Skip to main content

Seed selection strategy in global network alignment without destroying the entire structures of functional modules

Abstract

Background

Network alignment is one of the most common biological network comparison methods. Aligning protein-protein interaction (PPI) networks of different species is of great important to detect evolutionary conserved pathways or protein complexes across species through the identification of conserved interactions, and to improve our insight into biological systems. Global network alignment (GNA) problem is NP-complete, for which only heuristic methods have been proposed so far. Generally, the current GNA methods fall into global heuristic seed-and-extend approaches. These methods can not get the best overall consistent alignment between networks for the opinionated local seed. Furthermore These methods are lost in maximizing the number of aligned edges between two networks without considering the original structures of functional modules.

Methods

We present a novel seed selection strategy for global network alignment by constructing the pairs of hub nodes of networks to be aligned into multiple seeds. Beginning from every hub seed and using the membership similarity of nodes to quantify to what extent the nodes can participate in functional modules associated with current seed topologically we align the networks by modules. By this way we can maintain the functional modules are not damaged during the heuristic alignment process. And our method is efficient in resolving the fatal problem of most conventional algorithms that the initialization selected seeds have a direct influence on the alignment result. The similarity measures between network nodes (e.g., proteins) include sequence similarity, centrality similarity, and dynamic membership similarity and our algorithm can be called Multiple Hubs-based Alignment (MHA).

Results

When applying our seed selection strategy to several pairs of real PPI networks, it is observed that our method is working to strike a balance, extending the conserved interactions while maintaining the functional modules unchanged. In the case study, we assess the effectiveness of MHA on the alignment of the yeast and fly PPI networks. Our method outperforms state-of-the-art algorithms at detecting conserved functional modules and retrieves in particular 86% more conserved interactions than IsoRank.

Conclusions

We believe that our seed selection strategy will lead us to obtain more topologically and biologically similar alignment result. And it can be used as the reference and complement of other heuristic methods to seek more meaningful alignment results.

Background

Understanding complicated networks of interacting proteins is a major challenge in systems biology. Computational methods to analyze and compare networks are also being developed at a fast pace, resulting in an explosive growth in available protein-protein interaction (PPI) data. Comparative PPI network analysis across species has been used to understand similarities and differences between species at the systemic level [1, 2], in particular, identify conserved protein subnetworks across species that are believed to represent evolutionarily conserved functional modules [3]. Generally, a PPI network is represented as an undirected graph in which nodes indicate proteins and edges indicate interactions. Comparing PPI networks usually translates into the form of network alignment to identify the pairs of homologous proteins from two different organisms. In the biological context, Network alignment has been proven to be a valuable tool for understanding the structure and function of complex biological networks in evolutionary and systems biology [1]. It also can be used to validate PPI conserved across multiple species and detect evolutionary conserved pathways or protein complexes [1, 10]. The interactions are usually obtained by high-throughput experimental bio-techniques, the two most commonly used of which are yeast two-hybrid screening, resulting in binary interaction data [4–6], and protein complex purification methods using mass-spectrometry, resulting in co-complex data [7–9]. As suggested by increasing evidence, protein interaction modules that are conserved across species may exist.

Several methods have been proposed to perform local network alignment (LNA) of PPI networks [11–13]. LNA algorithms aim to find local small regions of isomorphism (same subnetworks) corresponding to pathways and protein complexes, which are conserved in PPI networks of different species. Such alignments can be ambiguous because a single protein in one network can be offered implausibly numerous different pairings in different local alignments.

A global network alignment (GNA), in contrast, provides a unique alignment from a protein in one network to only one protein in another network. The aim in GNA is to seek the best overall consistent alignment across all nodes simultaneously for the applications of functional ortholog identification. GNA has been studied previously in the context of biological networks [14, 15]. Guided by the intuition that two nodes should be matched only if their neighbours can also be matched, IsoRank [14] aims to maximize the overall match between the two networks using a greedy strategy. The latest MI-GRAAL [15] can align networks of any type heavily relying on "graphlet degrees," which is a quantification of the topological similarity between nodes [15]. MI-GRAAL and IsoRank are all based on the seed-and-extend heuristic approach for solving the assignment problem.

Generally, the current GNA methods [14, 15] fall into global heuristic seed-and-extend approach with two steps: (1) find a seed pair of nodes that can be aligned with the highest similarity score; (2) extend and align the neighbourhoods of the pair of seed nodes. The fatal drawback of this strategy is that the final alignment result largely depends on the selected seeds. These methods can not get the best overall consistent alignment between networks for the opinionated local seeds. Especially, when the PPI networks have a great way different size, the smaller network will be simply aligned to some local regions of the larger one.

In Figure 1 we give a schematic example to show this phenomenon and the intuition behind our method. There are two networks for alignment in Figure 1(a) with nodes distinctively represented as rectangles and circles. Each one has two dense regions (highly connected sub-graphs) highlighted with different colours. For each possible pairing (i, j) between nodes in Figure 1 (a) of the two networks, we compute the score S ij in Figure 1(b). The scores depend on the centrality-type value as described by equation 2. Here we show that the pair of nodes (1, a) has the highest similarity score S 1a = 1.60. Beginning with the seed (1, a), align the neighbourhood of node {1} in network1 and the neighbourhood of node {a} in network2. The incomplete matching {(1, a), (2, b), (3, c), (4, e), (5, f)} emerges. Having the highest similarity score (S 6g = 1.35) of still unaligned nodes, apparently the seed (6, g) should be chosen. Then seed-and-extend approaches will return the alignment result such as Alignment1 of Figure 1 (c). This result has aligned the whole network1 to only one lager region marked with green colour of the network2.

Figure 1
figure 1

A schematic example to show our motivation. (a) Two Networks to be aligned. (b) Similarity scores between nodes of the two networks. (c) Two different alignment results.

Analysis of the results from current seed-and-extend approaches leads us to the development of an extended seed selection strategy for GNA based multiple hub seeds. High-throughput methods such as TAP [17] identify that proteins rarely act in isolation, but rather associate with each other to perform many biological functions. Generally, protein functional modules correspond to highly connected sub-graphs in the protein interaction networks [18] and the functional modules are recorded in the interaction database as star subnetworks with a single central protein serving as a hub. Considering hubs often form functional modules in PPI networks with their neighbourhood, we can choose pairs of topological hub nodes as seeds in MHA introduced in the next section. Beginning with each hub seed, the two modules forming around the hub nodes in their corresponding networks will be aligned, MHA can obtain a more overall consistent alignment result eventually without destroying the functional modules. MHA outperforms those heuristic approaches in understanding similarities and differences between species at the systemic level.

We apply our method to align PPI networks and demonstrate that our alignment exposes far more functional complex regions than existing methods. And we can maintain the functional modules are not damaged during the heuristic alignment process by using the membership similarity of nodes to quantify to what extent the nodes can participate in functional modules associated with current seed topologically. This method is efficient in resolving the fatal problem of most conventional algorithms that the initialization selected seeds have a direct influence on the alignment result.

Methods

Global network alignment

A PPI network can be represented by an undirected simple network G = (V G , E G ), where V G = (v 1 , ..., v N ) is a finite set of N vertices representing the N proteins, and E G is the set of edges representing the pairs of interacting proteins. Given two PPI networks G and H for various species (without loss of generality, we assume N <M, where |V G | = N, |V H | = M). The GNA problem is to find a total injective function f : V G → V H which matches similar proteins and enforces as much as possible the conservation of interactions between matched pairs in the two networks. Also, no two nodes from the smaller network G can be aligned to the same node in the larger network H. To quantify how topologically similar two networks are, we can use the edge correctness (EC) measure [15]:

E C = ( i , j ) ∈ E G ∧ f ( i ) , f ( j ) ∈ E H | E G | * 100 %
(1)

EC is the percentage of edges from a smaller network that are correctly aligned to edges in a bigger network. Naturally, when aligning two networks, we want to achieve as high EC as possible. GNA is NP-complete meaning as the underlying subnetwork isomorphism problem and heuristic approaches must be devised to get thus approximate solutions, especially for the large-sized PPI networks.

On the other hand maximizing the EC should not be the unique goal for biological networks alignment and we must strike a balance between topological and biological significances of our result. So our MHA improve the EC while maintaining the structure of functional modules. Although being the same as a seed-and-extend approach, MHA can solve the significant seeds chosen problem of such heuristics to a certain extent.

The seed selection strategy and our algorithm

Figure 2 shows an example of applying our method to the GNA problem. Firstly, we determine the centralities of nodes in each network and show the two networks in Figure 2(a) with the sizes of nodes proportional to their centrality values. Then the multiple hub seed set {(1, a), (6, k)} can be constructed for their local maximum similarities. It can be seen obviously that nodes {1, 6, a, k} are local hubs of networks respectively. Secondly, in Figure 2(b), beginning with the seed (1, a), the fractional alignment result {(1, a), (2, b), (3, c), (4, e), (5, d), (6, g)} is obtained as shown in Figure 2(b); Simultaneity, beginning with the seed (6, k), another fractional alignment result {(6, k), (7, l), (8, m), (9, n) } is obtained as shown in Figure 2(c). During this alignment process the dynamic membership similarity is changeable with the current aligned seed. MHA enables us to get a more overall consistent alignment shown as Alignment2 of Figure 1(c). MHA aligned two dense regions in network1 (marked with colours red and purple) according to distinct dense regions in network2 (marked with colours green and blue).

Figure 2
figure 2

The process of hub seeds-based alignment. (a) Two Networks to be aligned with nodes denoted by circles and rectangles. The node significances are indicated by the sizes. The nodes with local maximum similarities are selected as hub seeds. (b) With the hub seed (1, a) the red and purple parts of networks are aligned respectively. (c) Beginning from another seed (6, k) the green and blue parts of networks are aligned.

What follows is the detailed description of the major steps of the MHA method. In order to construct hub seeds for the seed-and-extend process, we should compute centralities and membership values of nodes in each network. An integrative network module identification and key nodes determination method family, called ModuLand [19], can be used to gain the values of the steps 1-3 straightway as follows:

Step 1: Determination of centralities of nodes in networks. NodeLand algorithm [19] iteratively determines the centrality value C G i of node i ∈ V G in respective networks G = (V G , E G ). We compute the centrality similarity (SC) measures between all pairs of nodes (i, j) ∈ V G × V H from networks G and H. Then a N × M - sized matrix SC is defined as:

S C ( i , j ) = C ̃ G i + C ̃ H j 2 + θ × e - C ̃ G i - C ̃ H j
(2)
θ = ∑ i = 1 N C ̃ G i + ∑ j = 1 M C ̃ H j N + M
(3)

Respectively, C ̃ G i = lg ( C G i ) , C ̃ G i = lg ( C G i ) and θ is the average centrality value of all nodes in networks G and H. There are always plentiful pairs of nodes and the differences between their centrality values are not an order of magnitude. The logarithmic value C G i and C ̃ H j should be employed in practice. Note that SC(i, j) will be large if node i and j are both significant nodes ( C G i and C ̃ H j are all higher) in their own network and has little gap ( C ̃ G i - C ̃ H j  is small ) of their centrality values. θ 's presence is to address the issue that a pair of similar nodes (i, j) with little gap should have a certain magnitude SC even if they are of very small roles in topology.

Step 2: Determination of multiple hub seeds. Here we present one concise approach suitable for the determination of hub seeds of networks. Local maxima based hub seeds is defined as: A hub seed is the pair of nodes having the locally maximal SC value, while all of their neighbouring nodes have lower SC values. The result of this step is the set SEEDS containing all hub seeds.

Functional modules in PPI are associated with a single central hub protein. Beginning with a hub (h g , h h ) ∈ SEEDS to extend and align the neighbourhood of the seed, this seed-and-extend process is to construct functional modules having similar biological function and topology around the hubs respectively. For every hub seed does the same process, MHA has avoided the phenomenon that multiple functional modules in G are aligned to a few dense regions in H and can align the networks by modules.

Step 3: Determination of membership values. The membership value calculated by ProportionalHill method [19] quantifies to what extent a node can participate in a functional module associated with the current seed topologically. L h g ( i ) has been used to indicate the membership value of node i relative to seed node h g , and a seed node gets the maximum membership value, L h g ( h g ) =1, relative to itself. We construct membership similarity (SM) between all pairs of the neighbouring nodes (i, j) for a hub seed (h g , h h ).

S M ( i , j ) = 2 1 L h g ( i ) + 1 L h h ( j )
(4)

SM (i, j) is the harmonic mean of L h g ( i ) and L h h ( j ) . It is not necessary to calculate SM (i, j) between all pairs of nodes (i, j) ∈ V G × V H relative to all hub seeds in H G and H H . For some current seed (h g , h h ), MHA only needs to get the SM values between neighbouring nodes around h g and h h during alignment process (in step 5) dynamically.

Step 4: Construction of the "similarity scores" matrix S N×M . We implement MHA by using the topological similarity (SC) between nodes in two networks, along with the sequence similarity (SE) given by the BLAST [20] E-value score between protein sequences. BLAST E-values are a standard measure for deciding whether two proteins are orthologs. Note that the "perfect" alignment should minimize centrality, membership and sequence differences between nodes. Hence, the similarity score between nodes i and j, S(i, j), is computed as follows:

S ( i , j ) = α × S E ( i , j ) + ( 1 - α ) × ( S C ( i , j ) + S M ( i , j ) )
(5)

S is N × M -sized matrix and S(i, j) is an kind of dynamic similarity. Different seed considered among the alignment process leads to different SM (i, j) and S(i, j). The weight α can be adjusted to assign relative importance to biological and topological data, depending upon the confidence level attributed to them and the type of results sought. In our implementation we assign the weight (α = 0.6). This parameter has been discussed in the following section.

Then we present the detailed description of MHA based on the matrix S, and in the following part we define the specific concepts used.

Algorithm MHA (G, H)

Construct the matrices SC, SE and the set SEEDS.

Initialize alignment A to an empty set and alignment score vector B equals to 0.

for a hub seed (h g , h h ) ∈ SEEDS do

   Add (h g , h h ) to alignment A, B(h g , h h ) = S(h g , h h ).

   for all k ∈ { 1, ..., D} do

      Construct a bipartite graph BP N G k ( h g ) , N H k ( h h ) , E

      Compute SM (i, j) relative to the seed and assign the weight ω(i, j) = S (i, j).

      Solve the Maximum Weight Bipartite Matching Problem by the Hungarian algorithm [16].

      To each optimal matching (u, v) found above, if and only if S (u, v) >B(u), then add (u, v) to the current alignment A, B(u) = S(u, v).

   end for

end for

return alignment A.

The kth neighbourhood of node h g in network G, N G k ( h g ) , is defined as the set of nodes of G that are at distance ≥ k from h g . Hence, N G k ( h g ) is the kth still unaligned neighbourhood and can be thought of as the "ball" of nodes around h g up to and including nodes at distance k. This allows us to model insertions and deletions of nodes in the paths conserved between two networks. D is the longest distance restricted.

A bipartite graph, BP (V 1, V 2, E), is a graph with a node set V consisting of two partitions, V = V 1 ∪ V 2, so that every edge e ∈ E connects a node from V 1 with a node from V 2 ; that is, there are no edges between nodes of V 1 and there are no edges between nodes of V 2 -- all the edges "go across" the node partition.

The set A contains pairs of nodes which are the optimal matching results during the process of MHA. The matrix B records the alignment score when a matching is added to A. While using the multiple hub seeds, the object node in network H to which MHA has matched a node in G can be changeable. Membership values are related to the current aligned seeds. Beginning with different seeds, we will get different similarity score influenced by membership values, then a node in G should be aligned to the node that they can get the highest similarity score together. The significance of dynamical and changeable membership value is that a node can select the best associated hub seed to form a functional module, and also several smaller modules in one network will never be covered constrainedly by a larger one in another network along with the alignment process.

Computational complexity of MHA

NodeLand [19] algorithm for determination of centralities of nodes is structurally similar to a breadth-first search, therefore the worst-case runtime complexity is O(N*(N + |E|)), respectively, where N is the number of nodes and |E| is the number of edges in the network. The presented ProportionalHill [19] method has a runtime complexity of O(d*|E|*h), with d being the average node degree and h being the number of the identified hubs. Solving the alignment for bipartite graph BP (V 1, V 2, E) takes O((|V 1|+|V 2|)*(|E|+(|V 1|+|V 2|)*log((|V 1|+|V 2|)))). Therefore, the total time complexity of MHA algorithm for aligning networks G = (V G , E G ) and H = (V H , E H ) is smaller than O(h*|V G |*(|E G |+|V G |*log(|V G |))) and the space complexity is O(|V G |*|V H |+|E G |+|E H |) clearly.

Results and discussion

Data sets and summarized statistics for our seed selection strategy

We implement the proposed MHA in the C programming language and use it to identify the common alignment graph between PPI networks including the S. cerevisiae (S), D. melanogaster (D), H. sapiens (H) and M. musculus (M). The interaction data is available in October 2008 release of the DIP [21] molecular interaction databases (DIP: http://dip.doe-mbi.ucla.edu/). The statistics for the PPI networks are shown in table 1. GO enrichment measures the components in an identified alignment with respect to the biological process annotation of GO, for each species separately. We use the tool GO TermFinder [23] to compute components functional enrichment P-values.

Table 1 Description of aligned PPI networks

For each pair of networks table 2 shows our alignment results. When we align from the S. cerevisiae (S) to D. melanogaster (D) PPI networks, the set SEEDS consisting of 255 hub seeds is constructed. And there are 106 modules with obvious biological significance in yeast and 45 functional modules in fly formed around the seeds after the alignment process eventually. Performing our method for aligning M. musculus to H. sapiens PPI networks, the set SEEDS consisting of 91 hub seeds is obtained. There are 55 functional modules in mouse and 45 functional modules in human formed around the seeds after the alignment process eventually. All these functional modules have obvious biological process annotation of GO. The conserved modules shown in table 2 are those who execute the same functions in their respective networks and have the same annotation of GO terms in our alignment results. Conserved edge is the percentage of edges from a smaller network that are correctly aligned to edges in a bigger network. These results show that we can maintain the functional modules undamaged during the heuristic alignment process and align the networks by modules. Simultaneously our method is efficient in achieving a high percentage of conserved edge. In Figure 3, we give some functional modules of yeast that formed during our alignment process from yeast to fly PPI network. From a large-size seed some nodes painted same colour will be aligned. And the same colour nodes will form a functional module around the seed node.

Table 2 Statistic analysis of maintained functional modules in our result
Figure 3
figure 3

Some functional modules formed around seeds in yeast. From a large-size seed some nodes painted same colour will be aligned. And the same colour nodes will form a functional module around the seed node in our method.

The best currently published network alignment algorithm, MI-GRAAL, uses a cost function relying on a highly constraining measure of topological similarity and achieved higher percentage of conserved edge (usually at about 50%) than our results. But the only one object for MI-GRAAL is to optimize the EC no fear of destroying the functional modules in original networks. For proteins always associate with each other to perform biological functions, it is more important to maintain the functional modules unchanged rather than maximize the EC value. As shown in Figure 4 we can improve our EC values shown in table 2 simply by decreasing the parameter α. And also our strategy of seed selection can be used as the reference and complement of other heuristic methods to seek more meaningful alignment results.

Figure 4
figure 4

Effect of the parameter α.

Enriched functional modules of alignment network

As a typical case study we use MHA to identify the common alignment network between PPI networks the S. cerevisiae (yeast) and D. melanogaster (fly). We construct the set SEEDS consisting of 255 hub seeds. The common graph corresponding to the global alignment between the yeast and fly PPI networks is comprised of 2649 edges with edge correctness of 15.08% (α = 0.6). The alignment graph consists of many disconnected components, with the largest component having 48 edges amongst 49 proteins (in Figure 5(a)). Table 3 presents the results of our algorithm and IsoRank [14], in terms of conserved interactions, size of the largest component and P-value. We know that MHA produces a more optimal solution, which can be found at no additional computational cost. Retrieving in particular 86% more conserved interactions than IsoRank for a given level of sequence similarity between two networks denotes that our alignment result is more topologically similar. Also, its largest component with P-value of 5.83E-13 has a significant function of DNA binding achieved congruously in both yeast and fly (in table 4). In contrast the function of IsoRank algorithm's largest component is unnoticed with P-value of 0.00098. As shown in Figure 5, the components discovered simultaneously span various topologies, from linear pathways (Figure 5(d), Figure 5(e)) to components corresponding to protein complexes (Figure 5(a), Figure 5(b) and Figure 5(c)). Each one has coherent function (identified by same GO term) in the two species. The detailed GO terms and P-value of these components are presented in table 4. Finally, we give some components having functionality only in yeast or fly detected by MHA in table 5. The most significant module with P-value of 4.30E-21, comprised of 49 aligned proteins, is obtained by our alignment in yeast PPI.

Figure 5
figure 5

Some functional subnetworks of our result. The node labels indicate the corresponding "yeast/fly" proteins. (a) The largest connected component of the yeast-fly GNA.

Table 3 Comparison with IsoRank
Table 4 Enriched functions of alignment network
Table 5 Prediction of functional modules

We emphasize that our components are rich in biological functions notwithstanding they are just subnetworks of the sparse alignment graph. Enrichment functions in our alignment graph profit from the selection of initialization multiple hubs. Around these hubs neighbourhood proteins form consistent and conserved functional modules in two PPI networks simultaneously. Our alignment result is more biologically similar.

Identification of functional orthologs

Proteins that are aligned together in the global alignment should have similar interaction patterns in their respective species and are thus likely to be functional orthologs [3]. Recently, there has been a lot of interest in the discovery of functional orthologs (FO). In particular, Bandyopadhyay et al. [3] took a fairly complex approach to FO detection between yeast and fly through LNA, and the probability of each short-listed pair of proteins being true FOs is computed. We apply MHA to the detection of functional orthologs (i.e., sets of proteins that perform the same function in two or more species), and compare of our results with Bandyopadhyay et al.'s results [3]. Our method has 162 pairs of proteins consistent with their results and, moreover, often resolves the ambiguity in their predictions. Some examples of our predicted FO matching Bandyopadhyay et al.'s predicted FO are shown in table 6. For each predicted functional ortholog the Number of Conserved interactions (NC), the Number of interactions in Yeast (NY), the Number of interactions in Fly (NF) and the probability of the FO being true are exposed.

Table 6 Comparison of our results with Bandyopadhyay et al.'s results [3].

Effect of the parameter α

To measure the biological quality of the alignment result, we count the fraction of aligned pairs that have at least 1 GO term [22] in common, estimated by blue curve in Figure 4. Simultaneously we compute the edge correctness (EC) to evaluate the topological quality of the alignment result, marked by red curve. When choosing the most appropriate value of the free parameter α, we rejected the choice corresponding to the largest common alignment graph size (the largest EC); thus, the α leading to the largest-size alignment graph may not be a biologically appropriate choice. Instead, for the choice of α, we compared the biological quality with the topological quality and chose the α = 0.6 that is used to adjust the assignment of the relative importance to the topological and biological data.

The error tolerance of MHA

Our simulations indicate that the algorithm is tolerant to errors in the input networks (Figure 6); this is valuable since PPI networks have high false positive and false negative rates. To evaluate the algorithm's error-tolerance we randomized a fraction of its edges using the Maslov-Sneppen trick that preserves node degrees [24]: we randomly choose two edges (a, b) and (c, d), remove them, and introduce new edges (a, d) and (c, b). For each choice of the percentage of randomized edges, we compute the fraction of nodes that are mapped to exactly same objects in the original graph and randomized graph after GNA. Clearly, the algorithm's performance degrades smoothly and very slowly. These simulations suggest our results are quite robust to errors in PPI data.

Figure 6
figure 6

Effect of error on algorithm's performance.

Conclusions

In this paper, the focus is on the GNA problem, and an intuitive yet powerful algorithm is proposed for computing the global alignment of two PPI networks; Unlike previous heuristic algorithms whose initialization seeds have a very deep influence on the alignment result, MHA, simultaneously, using multiple hub seeds and dynamic membership value, enable us to get a more overall consistent alignment and has avoided the phenomenon that multiple functional modules in one network are aligned to a few dense regions in another. Matching biological networks of different species is expected to be a valuable tool, since the results can be used to knowledge transfer between species, detection of new conserved pathways and prediction of PPI data. We expect the methods proposed in this paper to have a direct impact on these applications and become a remedy of other heuristic algorithms.

References

  1. Sharan R, Suthram S, Kelley RM, et al.: Conserved patterns of protein interaction in multiple species. Proc Natl Acad Sci USA 2005,102(6):1974–1979. 10.1073/pnas.0409522102

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  2. Suthram S, Sittler T, Ideker T: The plasmodium protein network diverges from those of other eukaryotes. Nature 2005,438(7064):108–112. 10.1038/nature04135

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  3. Bandyopadhyay S, Sharan R, Ideker T: Systematic identification of functional orthologs based on protein network comparison. Genome Res 2006,16(3):428–435. 10.1101/gr.4526006

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  4. Uetz P, et al.: A comprehensive analysis of protein-protein interactions in Saccharomyces cerevisiae. Nature 2000, 403: 623–627. 10.1038/35001009

    Article  CAS  PubMed  Google Scholar 

  5. Stelzl U, et al.: A human protein-protein interaction network: a resource for annotating the proteome. Cell 2005, 122: 957–968. 10.1016/j.cell.2005.08.029

    Article  CAS  PubMed  Google Scholar 

  6. Simonis N, et al.: Empirically controlled mapping of the Caenorhabditis elegans protein-protein interactome network. Nat Methods 2009, 6: 47–54. 10.1038/nmeth.1279

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  7. Gavin AC, et al.: Proteome survey reveals modularity of the yeast cell machinery. Nature 2006, 440: 631–636. 10.1038/nature04532

    Article  CAS  PubMed  Google Scholar 

  8. Krogan NJ, et al.: Global landscape of protein complexes in the yeast Saccharomyces cerevisiae. Nature 2006, 440: 637–643. 10.1038/nature04670

    Article  CAS  PubMed  Google Scholar 

  9. Collins S, Kemmeren P, Zhao X, et al.: Toward a comprehensive atlas of the physical interactome of Saccharomyces cerevisiae. Mol Cell Proteomics 2007, 6: 439–450.

    Article  CAS  PubMed  Google Scholar 

  10. Kelley BP, Sharan R, et al.: Conserved pathways within bacteria and yeast as revealed by global protein network alignment. Proc Natl Acad Sci USA 2003,100(20):11394–11399. 10.1073/pnas.1534710100

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  11. Kelley BP, Yuan B, Lewitter F, Sharan R, et al.: PathBLAST: a tool for alignment of protein interaction networks. Nucleic Acids Res 2004, 32: W83-W88. 10.1093/nar/gkh411

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  12. Koyutürk M, Kim Y, et al.: Pairwise alignment of protein interaction networks. J Comput Biol 2006,13(2):182–199. 10.1089/cmb.2006.13.182

    Article  PubMed  Google Scholar 

  13. Flannick J, Novak A, Srinivasan BS, et al.: Graemlin: general and robust lignment of multiple large interaction networks. Genome Res 2006,16(9):1169–1181. 10.1101/gr.5235706

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  14. Singh R, Xu JB, Berger B: Pairwise Global Alignment of Protein Interaction Networks by Matching Neighborhood Topology. RECOMB, LNBI 2007, 4453: 16–31.

    Google Scholar 

  15. Kuchaiev O, Przulj N: Integrative Network Alignment Reveals Large Regions of Global Network Similarity in Yeast and Human. Bioinformatics 2011,27(10):1390–1396. 10.1093/bioinformatics/btr127

    Article  CAS  PubMed  Google Scholar 

  16. Kuhn HW: The hungarian method for the assignment problem. Naval Research Logistics Quarterly 1955, 2: 83–97. 10.1002/nav.3800020109

    Article  Google Scholar 

  17. Gavin AC, et al.: Functional organization of the yeast proteome by systematic analysis of protein complexes. Nature 2002,415(6868):141–147. 10.1038/415141a

    Article  CAS  PubMed  Google Scholar 

  18. Tornow S, Mewes H: Functional modules by relating protein interaction networks and gene expression. Nucleic Acids Res 2003, 31: 6283–6289. 10.1093/nar/gkg838

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  19. Kovacs IA, Palotai R, Szalay MS, Csermely P: Community landscapes: an integrative approach to determine overlapping network module hierarchy, identify key nodes and predict network dynamics. PLoS One 2010,5(9):e12528. 10.1371/journal.pone.0012528

    Article  PubMed Central  PubMed  Google Scholar 

  20. Altschul SF, Gish W, Miller W, Lipman DJ: Basic local alignment search tool. Journal of Molecular Biology 1990, 215: 403–410.

    Article  CAS  PubMed  Google Scholar 

  21. Xenarios I, Salwinski L, et al.: DIP: The Database of Interacting Proteins. A research tool for studying cellular networks of protein interactions. Nucl Acids Res 2002, 30: 303–305. 10.1093/nar/30.1.303

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  22. Ashburner M, et al.: Gene Ontology tool for the unification of biology. Nat Genet 2000, 25: 25–29. 10.1038/75556

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  23. Boyle EI, Weng S, Gollub J, et al.: GO::TermFinder--open source software for accessing Gene Ontology information and finding significantly enriched Gene Ontology terms associated with a list of genes. Bioinformatics 2004,20(18):3710–5. 10.1093/bioinformatics/bth456

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  24. Maslov S, Sneppen K: Specificity and stability in topology of protein networks. Science 2002,296(5569):910–913. 10.1126/science.1065103

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

This article has been published as part of Proteome Science Volume 10 Supplement 1, 2012: Selected articles from the IEEE International Conference on Bioinformatics and Biomedicine 2011: Proteome Science. The full contents of the supplement are available online at http://www.proteomesci.com/supplements/10/S1.

This work was supported by the National Key Natural Science Foundation of China (Grant No. 60933009 & 91130006) and the Fundamental Research Funds for the Central Universities (K50511030001 & K5051106004).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Lin Gao.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

BW and LG designed the study. BW implemented the method, performed the experiments and analyzed the data. All authors contributed to discussions on the method. BW and LG wrote the manuscript. All authors revised the manuscript and approved the final version.

Bingbo Wang contributed equally to this work.

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Wang, B., Gao, L. Seed selection strategy in global network alignment without destroying the entire structures of functional modules. Proteome Sci 10 (Suppl 1), S16 (2012). https://doi.org/10.1186/1477-5956-10-S1-S16

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1477-5956-10-S1-S16

Keywords