Skip to main content

MIMO: an efficient tool for molecular interaction maps overlap

Abstract

Background

Molecular pathways represent an ensemble of interactions occurring among molecules within the cell and between cells. The identification of similarities between molecular pathways across organisms and functions has a critical role in understanding complex biological processes. For the inference of such novel information, the comparison of molecular pathways requires to account for imperfect matches (flexibility) and to efficiently handle complex network topologies. To date, these characteristics are only partially available in tools designed to compare molecular interaction maps.

Results

Our approach MIMO (Molecular Interaction Maps Overlap) addresses the first problem by allowing the introduction of gaps and mismatches between query and template pathways and permits -when necessary- supervised queries incorporating a priori biological information. It then addresses the second issue by relying directly on the rich graph topology described in the Systems Biology Markup Language (SBML) standard, and uses multidigraphs to efficiently handle multiple queries on biological graph databases. The algorithm has been here successfully used to highlight the contact point between various human pathways in the Reactome database.

Conclusions

MIMO offers a flexible and efficient graph-matching tool for comparing complex biological pathways.

Background

In the post-genomic era the analysis of biological networks plays a crucial role in computational and systems biology. Consequently, biological network databases, tools for biological graph modeling and approaches for the management and standardization of the large amount of generated data are under continuous evolution. As an example, the PathGuide [1] repository lists four different XML standards for biological networks, modeled as graphs (SBML [2], BioPax [3], CellML [4], PSI-ML [5]), and over 300 biological pathway related resources, including databases of protein-protein interactions, metabolic and signaling pathways, gene regulatory and interaction networks. Generally speaking, in these databases, different molecular species are represented as nodes, while edges indicate a plethora of relationships existing among such molecules (including protein-protein interactions and phosphorylation).

Due to the increasing availability of biological graph databases, the problem of developing efficient and flexible subgraph matching methods arises in a number of applications. The main goal of biological graph matching is to detect the template-subgraphs that share similarity with noisy pathways built from the analysis of experimental data or built by collecting various sources of information. The goals are numerous and span over a large amount of topics: inference of metabolic pathways [6], prediction of protein-protein interactions (PPI) [7, 8] or complex interactions by joining together various sources of information [9]. In the frame of the quickly evolving translational and evidence-based medicine it is crucial to give biological support to any novel claim, emerging from statistically relevant clinical evidence. In this sense, from the identification of shared pathways among maladies [10], to the elucidation of common targets for different drugs [11], and potential side effects, it is crucial to provide biological bases on any novel finding. Challenges involve both computational bottlenecks (such as the computational intractability of the subgraph matching problem, which translates in huge time/memory requirements), and biological limitations, due to noisy/incomplete information.

In the last ten years, several approaches to perform approximate graph matching have been proposed [12-22]. However, few of them are specific for biological graph comparisons. The most notable examples are Netalign [8], Rahnuma [6], PathAligner [14], PathBLAST [15], NetworkBLAST [17], and SAGA [20]. To compare PPI, Netalign [8] models pathways as undirected graphs, allowing mismatches up to a certain BLAST E-value and gaps by clustering smaller subnetworks (overlap ≥80%, i.e. gaps limited to a proportion of the size of the smaller network). PathBLAST [15] and its extension NetworkBLAST [17] allow node mismatches and gap-node management for very short pathways. For the modeling of metabolic network Rahnuma [6] uses directed hypergraphs, with large flexibility in terms of gaps and mismatches (backtracking). However, the approach does not rely on any standard. PathAligner [14] can only process linear pathways, therefore excluding tree-like structures. SAGA [20] permits both node gaps and mismatches and implements a very computationally efficient subgraph indexing procedure, which, however, affects its sensitivity (i.e a pathway of exactly three nodes can be indexed only if there exists a path joining each possible pair of nodes) and does not allow the management of purely linear pathways (that have no backward edges and thus are not indexed). Besides, the input is SAGA-specific. Overall, the above described approaches rely on simplified graphs topologies (for example, none of these methods can handle directed edges) and have consequently limited flexibility or reduced matching capabilities.

Our contribution, MIMO (Molecular Interaction Maps Overlap) is characterized by three main properties that guarantee the suppleness needed to properly handle the biological graph matching problem. First, our algorithm relies directly on the graph topology described in SBML documents, which defines a reaction as a set of interacting entities (reactants, products of the reactions and modifiers) placed in specific compartments. This takes into account the biological environment and the complexity of a 3-ways interaction, crucial to preserve the largest possible information in noisy biological network models. Importantly, no intermediate format conversion is needed, avoiding possible losses of information and additional error-prone processing steps. Second, our matching procedure naturally allows node mismatches and gap-nodes introduction. Although computationally intractable, the matching procedure implemented in MIMO is fast enough to allow multiple queries on biological graph databases. Third, in order to deal with the possibility to match distinct elements with similar biological role (i.e. orthologous proteins), or conversely not to match distinct entities encoded as the same element (i.e. a gene and its expressed protein), MIMO allows the user to specify a set of allowed/forbidden mappings between entities in two SBML documents. This list is preprocessed to define a similarity function that extends the matching capabilities of the procedure, when the user has a priori knowledge about the biological processes to be compared.

Implementation

SBML format and graph model

The Systems Biology Markup Language (SBML) [2] is a free XML-based format for representing molecular interaction networks. In the following, we only describe those components of an SBML document that are used in our comparison algorithm (for additional details refer to [23]).

An SBML document specifies a set of entities, generally denoted with the term species, that take part in reactions. An SBML species has two mandatory attributes: the id attribute, which uniquely identifies the species in the document, and the compartment attribute, the physical location where the reacting species are placed. A species has also an optional name attribute of type string. Distinct species (i.e. species with distinct id attributes) are allowed to share the same name (for example, a gene and its expressed protein). A reaction component is a statement that links one or more species. A reaction is defined in terms of the participating species and it consists of a set of (possibly empty) reactants, products and modifiers, along with an additional Boolean reversibility attribute. Just like species, reactions are identified by a mandatory id attribute and an optional name attribute. A reaction can be seen as a directed edge connecting a set of reactants to a set of products. The set of modifiers can be seen as an attribute of the edge. The reversibility attribute, when true, implicitly asserts that the role of reactants and products in the reaction can be reversed. A single species in an SBML document can participate in one or more reactions as reactant, product or modifier. SBML specifications allow the definition of species that do not take part in any reaction and reactions that have empty sets of reactants, products and modifiers.

Thus, the topology of an SBML map can be described by a labeled multidigraph (i.e. a directed graph that allows multiple edges between the same pair of nodes), where a single SBML reaction is spliced into a set of directed edges, connecting every single reactant with every single product in the reaction. The modifiers are treated as edges’ attributes and the compartments are treated as vertices’ attributes. In our model incomplete reactions (empty set of reactants or products) and isolated species are ignored.

MIMO graph comparison procedure

The algorithmic procedure implemented in MIMO computes the overlap between two multidigraphs by detecting the largest possible consistent set of matches between shortest paths in the two graph structures. A matching is consistent if it induces a one-to-one mapping between subsets of reaction pathways, entities (species) and compartments. Two user-defined parameters are required in order to constrain the overlap: 1. Maximum length N: specifies the maximum-length for the computation of the shortest paths; 2. List of allowed/forbidden matches between nodes and reaction pathways: this list is used in step (ii) below to define the sets of equivalences between species and reaction pathways.

A short introductory description of the main points characterizing the algorithm is given below (see Additional file 1 for details).

  1. i)

    Simple paths computation. The algorithm computes and stores the set of simple paths of the two input graphs. A simple path is a valid path of maximum length N connecting two species. Moreover, a simple path is non-overlapping, i.e. it identifies a non-overlapping chain of SBML reactions ids. Finally, a simple path between two species is required to be minimal, i.e. all simple paths are shortest paths. In short, a simple path between two species is defined as the shortest chain of reactions connecting the two species. Given a pair of species, there can be distinct reaction chains of minimal length connecting the pair (by definition, a simple path is allowed to start and end at the same species).

  2. ii)

    Simple paths matching. Two simple paths are considered equivalent, if they can be matched at the extremes, i.e. if they have equivalent initial and terminal species. By default, two species are considered equivalent if they have the same name attribute. Even when two paths are equivalent at the extremes, they are not matched if: a) the matching between the corresponding reaction pathways or species is explicitly forbidden by the user (user-defined parameters); b) there are matchable subpaths, i.e. if there are two equivalent intermediate species in the two paths; c) the matching does not induce a one-to-one mapping between species and compartments. For example, a simple path starting and ending at the same species (or respectively compartment) cannot be matched with a simple path connecting two distinct species (respectively compartments). The simple paths matching procedure naturally induces gaps and mismatches between two linear paths.

  3. iii)

    Maximal sets of compatible simple path pairs. A subset of equivalent path pairs is consistent if it induces a one-to-one mapping between species, compartments and reaction pathways and it is maximal if it is not a proper subset of any other consistent set. This issue is recoded (in the standard way) as the computation of the maximal clique of the compatibility graph on the full set of equivalent path pairs, computed with the standard Bron-Kerbosh Version 2 (BKv2) algorithm [24].

    In detail, the compatibility graph is an undirected graph (without self loops) that describes the compatibility between pairs of matched paths. By construction each vertex of the compatibility graph corresponds to one pair of matched paths and an edge between two vertices indicates that two pairs of paths are compatible. Two pairs of matched paths are compatible if the induced mapping between reaction pathways is one-to-one, i.e. a chain of reaction ids in one graph can be matched at most with a unique chain of reactions ids in the other graph, and, in particular, every single reaction id is required to belong at most to a unique path of reaction ids or to its reversed chain. Moreover, two pairs of matched paths are compatible if the induced mapping between vertices and compartments is one-to-one. A subset of equivalent path pairs respecting these rules is consistent, in the sense that it induces a one-to-one mapping between species, compartments and reaction id pathways.

    The maximal clique detection is computationally intractable. In order to make this phase more efficient, the clique computation is iteratively performed in N steps, where, at each step i=1,…,N only the subset of path pairs of maximum length i is considered. This heuristic approach has the advantage of speeding up the computation, while giving more importance to the matches between the shortest biological pathways in the two maps. Intuitively, the procedure iteratively builds a solution by detecting first the safest similarities among the two graphs. After the computation of the maximal compatible subset, the procedure sets-up the mapping between the modifiers that appear in the selected pathways.

  4. iv)

    Overlap score. A consistent subset E of equivalent path pairs detects a subgraph matching between the two input graphs, G1 and G2. The comparison score S associated to the subgraph matching E is defined as

    S( G 1 ,E)= r R 1 w ( r ) | R 1 | ,
    (1)

    where R 1 is the set of reaction identifiers in G1 and w(r) is a weight associated to the reaction r, computed as

    w(r)= | R E ( r ) | + | P E ( r ) | + | M E ( r ) | | R ( r ) | + | P ( r ) | + | M ( r ) | ,
    (2)

    where R(r),P(r),M(r) denote the set of Reactants, Products, Modifiers of reaction r, respectively, and R E (r),P E (r),M E (r) denote the set of Reactants, Products, Modifiers of reaction r contained in E, respectively. As a result w(r)=0 if r has no match in G2 and w(r)=1 if all reactants, products and modifiers of r have a match in G2 with respect to E. The score for G2 is computed equivalently by S(G2,E) (normalized on | R 2 |). Note that, since the score S is normalized with respect to the size of the graph, it is in general not symmetric, i.e. in general S(G1,E)≠S(G2,E). This scoring function provides a value in [0,1] and roughly measures how much of the graph G1 is contained in G2 according to E (equivalently, for G2).

Implementation details

Our software has been implemented in C language by using the libSBML [25] interface library version 4.1.0. The libSBML library provides routines for reading, writing, manipulating and validating SBML documents.

Our implementation takes as input two valid SBML documents (no conversion required into intermediate formats) and provides also the possibility to obtain as output, additionally to the comparison score, the computed overlap in SBML format. In particular, if requested by the user, the executable saves three SBML files related to the highest-scoring solution found. Two of these documents correspond to the SBML documents in which the non-matched reactions have been removed. In these files the matched reactions are saved in their full definition, i.e. all reactants, products and modifiers of the reaction are saved, even if they have not been matched in the computed overlap. The third SBML file contains the computed overlap between the two molecular interaction maps. In this file, every matched pair of reaction pathways is saved as a unique reaction. Only those reactants, products and modifiers that have been matched are saved into the document. In addition, in order to simplify the inspection of the output SBML documents, a text file listing the mappings between species, reactions and compartments is also saved.

The running time of our algorithm is bound by the running time of the BKv2 procedure [24], used in step (iii) for the computation of all maximal cliques of the compatibility graph. The BKv2 algorithm is efficient in practice [26] but, even with clever pivoting strategies, its running time depends also on the number of possible maximal cliques in a graph, which can be exponential in the number of nodes [27]. In order to provide some control on the running time of the algorithm in the most complex cases, the implementation allows the user to bound the running time by specifying a maximum number of solutions and/or a maximum amount of time for the execution of the BKv2 procedure. This feature can be useful to allow fast queries on large databases.

Results and discussion

We present the performances of MIMO in detecting functional relationships among the 56 human pathways of the manually-curated Reactome [28] database version 39 [29] (full list in Additional file 2: Table S1). We performed a leave-one-out test on the whole ensemble of maps, where every single pathway is used as a query graph and it is compared against all the other pathways in the dataset; the detected top scoring pathways (if any) are considered as related to the query.

We compared the performances of MIMO with those of SAGA [20], which has been explicitly designed for efficient graph-database querying and which is, to date, the only publicly available tool closely related to our work. We converted the SBML documents into the SAGA graph format. We remark that in the SAGA graph format it is not possible to encode the information related to modifiers, compartments and direction of the reactions. In SAGA (like in MIMO) the isolated entities in the SBML maps are not encoded during format. We ran SAGA with the default parameters for the graph database creation (the maximum allowed length for the fragment index creation is equal to 3) with the exception of the D_MAX parameter, which is, by default, set to 3 and in our test has been set to 1. The reason is that, with the default value the algorithm returns almost no match. Additionally, we performed the query phase with SAGA by allowing 0.0 as percentage of non-gap nodes (by using the default parameter 0.8, the algorithm returns no match in all cases). For performance comparison, we ran MIMO with maximum path length equal to 3 (the same distance as SAGA) and with a maximum running time equal to 1 minute for the BKv2 procedure. No relevant improvement in terms of quality/size of the overlaps was observed when testing larger time-bounds for the BKv2 procedure (up to 1h). This is due to the fact that, for most of the complex cases (i.e. maps with very large overlaps), an upper bound of 1h for the BKv2 procedure is still not sufficient to explore the entire space of the possible solutions. Larger time-bounds are impractical, requiring weeks of computation.

To warrant the comparisons to be as informative as possible, we performed two different kinds of experiments on two disjoint subsets of the 56 pathways in Reactome. The first set consists of the 36 human pathways in Reactome that share a non-empty subset of reactions with at least one of the other maps in the dataset. Since reactions in Reactome SBML maps are uniquely identified by their id attribute, the a priori amount of overlap between two maps can be assessed by simply counting the fraction of common reactions (i.e. number of common reactions/total number of reactions). This set of 36 maps is used to assess the performances of MIMO and SAGA in detecting similarities between biological pathways (validation test, Table 1). The second set consists of the remaining 20 human pathways for which no trivial relationships can be inferred by using the reaction id attribute; that is to say that these pathways, if analyzed by the same overlap principle, share no common set of reactions with other maps in Reactome. Therefore such pathways are used to infer possible novel functional similarities between human pathways (inference test, Table 2). MIMO appears to be able to identify the largest of such non trivial solutions. A validation and an inference example are discussed in details in the final part of each section.

Table 1 Comparison of Reactome biological pathways
Table 2 Comparison of Reactome biological pathways

From a computational point of view, both MIMO and SAGA are extremely efficient (for the benchmark under test), with a time ratio between MIMO and SAGA of 4 when the necessary format conversion time (dataset upload into the postrgreSQL database) is included and 5 when excluded. This, however, comes at a cost in terms of the quality of the overlaps identified, including a number that is totally or partially missed by SAGA (Tables 1 and 2).

Validation test

The results of the biological validation test are summarized in Table 1. For visualization purposes, we show only the top-scoring hit for each query pathway. Multiple hits are shown only when the comparison score is exactly the same. The full list of comparisons is available as supplementary data (see Additional file 3: Table S2). Overlaps for which SAGA does not return any hits (9 out of 36), are due to: (i) the quality filtering used (a match is not returned if it has P-value ≤0.01) and (ii) the fragment procedure which forbids the match between linear pathways in two graphs. As a consequence, non-trivial overlaps (i.e. >16% common reactions) such as the ones related to the pairs (R111064, R9470), (R111057, R6844) and (R1538, R152) are lost (see Table 1). In general, from a qualitative point of view SAGA always identifies overlaps smaller than the ones identified by MIMO. One notable example is the query R383 which is a subgraph of map R152 (correctly identified by MIMO) and for which SAGA is able to detect a mapping for only 12 out of 109 nodes. From a quantitative point of view, MIMO is able to correctly detect the best hits for 29 out of 36 queries against 20 out of 36 identified by SAGA. Moreover, when -due to the time-bound constraints imposed to the algorithm- the optimal solution is not the top ranking, MIMO always identifies it in the top four positions (see Additional file 3: Table S2). Finally, performance comparison in terms of Areas Under the ROC curves (AUC) for each single query (Table 1) and on the entire set of 36 maps (Figure 1) confirms that the classification performance of MIMO is superior to that of SAGA.

Figure 1
figure 1

ROC curve for the comparative performances of MIMO and SAGA over the 36 pathways in the validation test. The test scores are the ones obtained from each algorithm and the gold standard is the overlap detected directly in Reactome: a Reactome score (see “Validation test” Section) greater than 0 between two maps means related and a score equal to zero not-related. SAGA ROC curve’s shape is due to the numerous missing overlaps. AUC MIMO = 0.89, AUC SAGA = 0.73.

When querying map R111083 (see Table 1) MIMO detects a non-trivial overlap with R13 (scoring hit 0.2151 in Table 1). For MIMO, the similarity of R111083 with R13 is higher than with R474 (as expected by inspecting Reactome’s hit, see Table 1). Interestingly, this overlap detects a non-trivial relationship between R111083 and R13 which cannot be directly inferred from Reactome, as in fact, such maps have no common reactions (see Additional file 3: Table S2).

The citric acid (TCA) cycle and respiratory electron transport (R111083) vs Metabolism of amino acids and derivatives (R13)

The matched subgraph of these two pathways is shown in Figure 2. The overlap involves entities located into the “mitochondrial matrix” and “cytosol” compartments. The most interesting biological relationship regards the set of matched reactions in the “mitochondrial matrix” and the role of the “alpha-ketoglutarate dehydrogenase complex”, which is an enzyme complex involved in lysine degradation and tryptophan metabolism.

Figure 2
figure 2

R111083 vs R13. The citric acid (TCA) cycle and respiratory electron transport (R111083) vs Metabolism of amino acids and derivatives (R13).

The junction between the two original maps in the “mitochondrial matrix” derived from a chain of events that link the two reactions. The citric acid cycle (in R111083) comprises a series of enzyme-catalysed chemical reactions of central importance in all living cells that use oxygen as part of cellular respiration. In eukaryotic cells, the citric acid cycle occurs in the matrix of the mitochondrion [30] and starts with acetyl-CoA. In particular, pyruvate is derived primarily from glucose 6-phosphate, alanine, and lactate and is converted into acetyl-CoA, the main input for the citric acid cycle. In a separate process, protein catabolism (part of proteins metabolism, R13), proteins are broken down by proteases into their constituent amino acids, in a complex process due to the large number of enzymes and metabolites involved. Following the metabolic fate of carbon atoms in the amino acids, it is possible to trace all the major metabolic intermediates because of the close interaction of amino acid metabolism with the citric acid cycle. In fact, carbon backbones of amino acids become a source of energy once they are converted to acetyl-CoA, either directly (Ketogenic amino acids) or indirectly via degradation to pyruvate (Glucogenic amino acids) and enter into the citric acid cycle [31]. Acetyl-CoA is then the junction between the citric acid cycle and the metabolism of amino acids. As it is visible from the overlap of these two pathways, most of the species and reactions are located in the mitochondrion and the main reaction: alpha-ketoglutarate dehydrogenase complex + NAD + CoA + Succinyl CoA + CO2 + NADH was successfully identified by MIMO. Clearly, the overlap between these two pathways shows how amino acids enter the citric acid cycle and follow the different steps of the citric acid cycle. Interestingly, this could not be inferred in SAGA, the reason being that two very important species, alpha-ketoglutarate dehydrogenase complex and CoA, were not highlighted in this overlap (data not shown).

Inference test

The results of the biological inference test are summarized in Table 2. For visualization purposes, as for Table 1, only the top-scoring hit for each query pathway are shown. The full list of comparisons is available as supplementary data (see Additional file 3: Table S2).

From Table 2, SAGA detects some similarities only for three out of 20 queries in the dataset, compared to 15 of MIMO. This suggests that MIMO is more sensitive than SAGA in detecting similarities among biological graphs. However, most of such overlaps, though effective from a computational point of view, do not highlight functional markers, but are, in most of the cases, confined to very common molecules (H+, H20, Oxygen, NAD+, NADH). The impact of such common molecules in the computational analyses of biological networks can represent indeed an issue as it distorts the evaluation of topological network parameters such as centrality or pathway length[32]. However, the biological interest of such overlaps may not be discarded a priori, and since non-interesting overlaps can be easily detected by visual inspection of the outputs we here chose to maintain them (like tha authors of SAGA did), and give the end-user the option to keep or remove them. Nevertheless, in this inference test at least in one case, namely for maps R11045 and R152, MIMO identifies a non-trivial overlap, which is not identified by SAGA (see Table 2). This example is discussed in detail below.

Signaling by Wnt (R11045) vs Cell Cycle, Mitotic (R152)

The matched subgraph of these two pathways is shown in Figure 3. The overlap involves entities located into the “cytosol” and it is related to the role of the “SCF- β-TrCP1 complex” and the “26S proteasome”.

Figure 3
figure 3

R11045 vs R152. Signaling by Wnt (R11045) vs Cell Cycle, Mitotic (R152).

The Wnt signaling pathway (R11045) is critically involved in the early development of complex, multi-cellular organisms controlling early axis formation, limb patterning and organogenesis [33]. Abnormal Wnt signaling is often related to severe human diseases, including cancer, osteoporosis and other degenerative disorders [34]. The replication of the genome and the subsequent segregation of chromosomes into daughter cells (R152) are controlled by a series of events collectively known as the cell cycle. In particular, a family of protein (serine/threonine kinases) known as the cyclin-dependent kinases (CDKs) controls the progression through the cell cycle [35]. Recent work has implicated Wnt components in regulating mitotic events, suggesting that cell cycle and Wnt signaling are directly linked [36]. Interestingly, MIMO can highlight this connection and additionally it can also provide details regarding the molecules involved. In fact, by reading the output file, it is possible to argue that this happens via the activity of SCF- β-TrCP1 complex (an ubiquitin ligase) whose substrates can be divided into two main groups: direct regulators of CDKs, regulators of gene transcription or both. β-catenin is the substrate of SCF- β-TrCP1 in the Wnt signaling pathway [37] where it plays a key role. In particular, phosphorylated β-catenin is recognized and ubiquitinated by the SCF- β TrCP ubiquitin ligase complex and is subsequently degraded by the proteasome [38]. Similarly, some of the CDKs, such as cdc20, are also the substrate of SCF- β TrCP in the cell cycle. From there, once they have been identified by SCF- β TrCP, all substrates enter the process of proteasomal degradation, the identified common process.

Conclusions

MIMO (Molecular Interaction Map Overlap) is a tool for biological graph matching. The main features of MIMO are: (i) Easy-to-use: MIMO takes as input biological networks encoded with the Systems Biology Markup Language (SBML) standard. The SBML standard is widely adopted for biological network modeling and is flexible enough to allow the encoding of quite complex molecular interactions. Most importantly, the choice to adopt a standard format as input avoids the pre-processing phase needed to convert molecular interaction maps in a non-standard format removing all the consequent burden. (ii) Flexibility: MIMO implements a flexible procedure for sub-graph matching, which naturally allows the introduction of gaps and mismatches and permits (if required) supervised queries incorporating a priori biological information. (iii) Computational efficiency: while the subgraph matching problem is computationally intractable, MIMO implementation is fast enough to allow multiple queries on graph databases.

The capabilities of MIMO have been highlighted by performing a one-to-one comparison on all human pathways in the Reactome database. The experimental tests prove that MIMO is flexible and efficient enough to make it a suitable tool for biological pathway comparisons.

Availability and requirements

Project Name: Molecular Interaction Map Overlap;Project home page: http://www.picb.ac.cn/ClinicalGeno micNTW/software.htm;Operating system(s): Linux, Mac Os X;Programming language: C;Other requirements: libSBML;Licence: GPL3;Any restrictions to use by non-academics: No.

References

  1. PathGuide. [http://www.pathguide.org]

  2. Hucka M, Finney A: The systems biology markup language (SBML) a medium for representation and exchange of biochemica network models. Bioinformatics. 2003, 19 (4): 524-531. 10.1093/bioinformatics/btg015.

    Article  CAS  PubMed  Google Scholar 

  3. Demir E, Cary MP: The BioPAX community standard for pathway data sharing. Nat Biotechnol. 2010, 28: 935-942. 10.1038/nbt.1666.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Lloyd CM, Halstead MDB: CellML: its future, present and past. Prog Biophys Mol Biol. 2004, 85 (2-3): 433-450. 10.1016/j.pbiomolbio.2004.01.004.

    Article  CAS  PubMed  Google Scholar 

  5. Hermjakob H, Montecchi-Palazzi L, Bader G, Wojcik J, Salwinski L, Ceol A, Moore S: The HUPO PSI’s Molecular Interaction format-a community standard for the representation of protein interaction data. Nat Biotechnol. 2004, 22: 177-183. 10.1038/nbt926.

    Article  CAS  PubMed  Google Scholar 

  6. Mithani A, Preston GM: Rahnuma: hypergraph-based tool for metabolic pathway prediction and network comparison. Bioinformatics. 2009, 25 (14): 1831-1832. 10.1093/bioinformatics/btp269.

    Article  CAS  PubMed  Google Scholar 

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

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Liang Z, Xu M: NetAlign: a web-based tool for comparison of protein interaction networks. Bioinformatics. 2006, 22 (17): 2175-2177. 10.1093/bioinformatics/btl287.

    Article  CAS  PubMed  Google Scholar 

  9. Wu G, Zhu L: A comprehensive molecular interaction map for rheumatoid arthritis. PLoS ONE. 2010, 5 (4): e10137-10.1371/journal.pone.0010137.

    Article  PubMed Central  PubMed  Google Scholar 

  10. Li Y, Agarwal P: A pathway-based view of human diseases and disease relationships. PLoS One. 2009, 4 (2): e4346-10.1371/journal.pone.0004346.

    Article  PubMed Central  PubMed  Google Scholar 

  11. Smith SB, Dampier W, Tozeren A, Brown JR, Magid-Slav M: Identification of common biological pathways and drug targets across multiple respiratory viruses based on human host gene expression analysis. PLoS One. 2012, 7 (3): e33174-10.1371/journal.pone.0033174.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Shasha D, Wang JTL: Algorithmics and applications of tree and graph searching. Proceedings of the twenty-first ACM SIGMOD-SIGACT-SIGART symposium on Principles of database systems. 2002, PODS ’02. New York: ACM, 39-52.

    Chapter  Google Scholar 

  13. Yan X, Yu PS, Han J: Graph indexing: a frequent structure-based approach. Proceedings of the 2004 ACM SIGMOD international conference on Management of data. 2004, SIGMOD ’04. New York: ACM, 335-346.

    Chapter  Google Scholar 

  14. Chen M, Hofestadt R: PathAligner: metabolic pathway retrieval and alignment. Appl Bioinformatics. 2004, 3 (4): 241-252. 10.2165/00822942-200403040-00006.

    Article  CAS  PubMed  Google Scholar 

  15. Kelley BP, Yuan B: PathBLAST: a tool for alignment of protein interaction networks. Nucleic Acids Res. 2004, 32 (suppl 2): W83-W88.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  16. Yan X, Yu PS, Han J: Substructure similarity search in graph databases. Proceedings of the 2005 ACM SIGMOD International conference on Management of data. 2005, SIGMOD ’05. New York: ACM, 766-777.

    Chapter  Google Scholar 

  17. Sharan R, Suthram S: Conserved patterns of protein interaction in multiple species. Proc Natl Acad Sci USA. 2005, 102 (6): 1974-1979. 10.1073/pnas.0409522102.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Yan X, Zhu F, Han J, Yu P: Searching Substructures with Superimposed Distance. Data Engineering, 2006. ICDE ’06. Proceedings of the 22nd International Conference on. 2006, 88-88.

    Google Scholar 

  19. He H, Singh A: Closure-Tree: an index structure for graph queries. Data Engineering, 2006. ICDE ’06. Proceedings of the 22nd International Conference on. 2006, 38-38.

    Google Scholar 

  20. Tian Y, McEachin RC: SAGA: a subgraph matching tool for biological graphs. Bioinformatics. 2007, 23 (2): 232-239. 10.1093/bioinformatics/btl571.

    Article  CAS  PubMed  Google Scholar 

  21. Tian Y, Patel J: TALE: a tool for approximate large graph matching. Data Engineering, 2008. ICDE 2008. IEEE 24th International Conference on. 2008, 963-972.

    Google Scholar 

  22. Zhang S, Li S: GADDI: distance index based subgraph matching in biological networks. Proceedings of the 12th International Conference on Extending Database Technology: Advances in Database Technology. 2009, EDBT ’09. New York: ACM, 192-203.

    Chapter  Google Scholar 

  23. Hucka M, Bergmann F: The systems biology markup language (SBML):Language specification for level 3 version 1 core (release 1 candidate). Nature Precedings. 2010, 31 (10): 839-847.

    Google Scholar 

  24. Bron C, Kerbosch J: Algorithm 457: finding all cliques of an undirected graph. Commun ACM. 1973, 16 (9): 575-577. 10.1145/362342.362367.

    Article  Google Scholar 

  25. Bornstein BJ, Keating SM, Jouraku A, Hucka M: LibSBML: an API library for SBML. Bioinformatics. 2008, 24 (6): 880-881. 10.1093/bioinformatics/btn051.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  26. Tomita E, Tanaka A, Takahashi H: The worst-case time complexity for generating all maximal cliques and computational experiments. Theor Comput Sci. 2006, 363: 28-42. 10.1016/j.tcs.2006.06.015.

    Article  Google Scholar 

  27. Moon J, Moser L: On cliques in graphs. Israel J Math. 1965, 3: 23-28. 10.1007/BF02760024.

    Article  Google Scholar 

  28. Reactome. [http://www.reactome.org]

  29. Matthews L, Gopinath G: Reactome knowledgebase of human biological pathways and processes. Nucleic Acids Res. 2009, 37 (suppl 1): D619-D622.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  30. Sch E: Handbuch der Allgemeinen Pathologie. Anzeiger für Schädlingskunde. 1970, 43: 15-15.

    Google Scholar 

  31. Berg J, Tymoczko J: Biochemistry. 2002, New York: W. H. Freeman & Co.

    Google Scholar 

  32. Ma H, Zeng AP: Reconstruction of metabolic networks from genome data and analysis of their global structure for various organisms. Bioinformatics. 2003, 19 (2): 270-277. 10.1093/bioinformatics/19.2.270.

    Article  CAS  PubMed  Google Scholar 

  33. Logan C, Nusse R: The Wnt signaling pathway in development and disease. Annu Rev Cell Dev Biol. 2004, 20: 781-10.1146/annurev.cellbio.20.010403.113126.

    Article  CAS  PubMed  Google Scholar 

  34. Sonderegger S, Pollheimer J: Wnt Signalling in implantation, decidualisation and placental differentiation-review. Placenta. 2010, 31 (10): 839-847. 10.1016/j.placenta.2010.07.011.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  35. Satyanarayana A, Kaldis P: Mammalian cell-cycle regulation: several Cdks, numerous cyclins and diverse compensatory mechanisms. Oncogene. 2009, 28 (33): 2925-2939. 10.1038/onc.2009.170.

    Article  CAS  PubMed  Google Scholar 

  36. Davidson G, Niehrs C: Emerging links between CDK cell cycle regulators and Wnt signaling. Trends Cell Biol. 2010, 20 (8): 453-460. 10.1016/j.tcb.2010.05.002.

    Article  CAS  PubMed  Google Scholar 

  37. Winston J, Strack P: The SCFβ-TRCP-ubiquitin ligase complex associates specifically with phosphorylated destruction motifs in IκB,α and β-catenin and stimulates IκB,α ubiquitination in vitro. Genes Dev. 1999, 13 (3): 270-10.1101/gad.13.3.270.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  38. Kimelman D, Xu W: β-Catenin destruction complex: Insights and questions from a structural perspective. Oncogene. 2006, 25 (57): 7482-7491. 10.1038/sj.onc.1210055.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

Pietro Di Lena took part of the official exchange between the University of Bologna and PICB. This work is funded by the National Science Foundation of China (NSFC), grant n. 31070748.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Pietro Di Lena or Christine Nardini.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

PDL and CN designed the project and wrote the manuscript. PDL designed and implemented the algorithmic procedure, and carried out all computational experiments. GW interpreted the biological results. All the authors read and approved the final manuscript.

Electronic supplementary material

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

Authors’ original file for figure 3

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

Di Lena, P., Wu, G., Martelli, P.L. et al. MIMO: an efficient tool for molecular interaction maps overlap. BMC Bioinformatics 14, 159 (2013). https://doi.org/10.1186/1471-2105-14-159

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-159

Keywords