Skip to main content
Advertisement
Browse Subject Areas
?

Click through the PLOS taxonomy to find articles in your field.

For more information about PLOS Subject Areas, click here.

  • Loading metrics

Aligning Metabolic Pathways Exploiting Binary Relation of Reactions

Abstract

Metabolic pathway alignment has been widely used to find one-to-one and/or one-to-many reaction mappings to identify the alternative pathways that have similar functions through different sets of reactions, which has important applications in reconstructing phylogeny and understanding metabolic functions. The existing alignment methods exhaustively search reaction sets, which may become infeasible for large pathways. To address this problem, we present an effective alignment method for accurately extracting reaction mappings between two metabolic pathways. We show that connected relation between reactions can be formalized as binary relation of reactions in metabolic pathways, and the multiplications of zero-one matrices for binary relations of reactions can be accomplished in finite steps. By utilizing the multiplications of zero-one matrices for binary relation of reactions, we efficiently obtain reaction sets in a small number of steps without exhaustive search, and accurately uncover biologically relevant reaction mappings. Furthermore, we introduce a measure of topological similarity of nodes (reactions) by comparing the structural similarity of the k-neighborhood subgraphs of the nodes in aligning metabolic pathways. We employ this similarity metric to improve the accuracy of the alignments. The experimental results on the KEGG database show that when compared with other state-of-the-art methods, in most cases, our method obtains better performance in the node correctness and edge correctness, and the number of the edges of the largest common connected subgraph for one-to-one reaction mappings, and the number of correct one-to-many reaction mappings. Our method is scalable in finding more reaction mappings with better biological relevance in large metabolic pathways.

Introduction

In the last few decades, the quantity and quality of metabolic data in biological databases such as KEGG (Kyoto Encyclopedia of Genes and Genomes) [1] and Metacyc [2] are greatly increased. The comparative analysis of this vast quantity of metabolic data provides insights into biology and life science applications [3]. An effective way of such analysis is to find the similarity between metabolic pathways by aligning them. The similarity between two pathways is often modeled as a function of the similarity between the aligned nodes or matching edges [4]. By comparing the similarity between metabolic pathways, we can reconstruct phylogeny and infer unknown function or evolution of pathways [5], reveal similar connecting pattern of metabolic pathways [6], and study the structural and functional relevance among species [7, 8]. The complexity of the pathway alignment problem stems from its close relationship with graph and subgraph isomorphism problems, which are GI (Graph isomorphism)-Complete and NP-Complete respectively [4]. Thus, it may become impractical to find an accurate solution for this problem as the size of the pathways grows. Due to both computational hardness of pathway alignment and the increasing amount of available metabolic data, obtaining topologically and biologically accurate alignments is a challenging task [9].

In the metabolic pathway alignment problem, metabolic pathways are usually represented as directed graphs, where a node denotes a molecule which can be specified as reaction, enzyme, or compound and an edge represents the interactions between molecules. A one-to-one mapping between nodes in two metabolic pathways maps a node from one pathway to a node in the other. A one-to-many mapping between the nodes in two metabolic pathways maps a node from one pathway to a connected subgraph of many nodes in the other [10]. The size of a one-to-many mapping is determined by the number of nodes in this mapping. Performing an alignment is often considered as finding one-to-one mappings or one-to-many mappings between molecules in metabolic pathways [10].

Accordingly, we can categorize existing literature on metabolic pathway alignment into two types. The first type finds one-to-one mappings between molecules of metabolic pathways to identify similar parts in different pathways [3, 1120]. This type of methods can be generally classified into two categories: (1) graph-based isomorphism methods. (2) dynamic programming methods.

The graph isomorphism problem asks to decide whether two given graphs are isomorphic, and the subgraph isomorphism problem asks to decide whether one graph is isomorphic to a subgraph of another [11]. A straightforward method for identifying the similarity between metabolic pathways is to transform metabolic pathway alignment problem into graph-based isomorphism problem. Considerable efforts were devoted to aligning metabolic pathways in this way [3, 1117]. For example, Pinter et al. [12] used enzyme graph to describe metabolic pathway and proposed a tree-based pathway search method called MetaPathwayHunter to align the enzyme graphs by using a graph theoretic approach. Although MetaPathwayHunter obtains a high efficiency in the alignments, the pathways are restricted to trees. To alleviate this restriction, Wernicke and Rasche [13] reduced the pathway alignment problem to subgraph homeomorphism problem and presented an alignment tool METAPAT. METAPAT does not restrict the topology of the metabolic networks in the alignments. Given two metabolic networks GP and GH where GP is represented as the pattern network and GH is represented as the host network, METAPAT determines whether GH contains a subgraph that is isomorphic to GP [13]. Owing to the fact that subgraph homeomorphism problem is NP-complete, METAPAT could be computationally hard with the increasing size of the networks. Meanwhile, Yang and Sze [14] proposed two metabolic pathway matching methods PathMatch and GraphMatch. PathMatch reduces the path matching problem to finding the longest weighted path in a directed acyclic graph while GraphMatch reduces the graph matching problem to finding the highest scoring subgraphs in a graph. Both PathMatch and GraphMatch can effectively and accurately extract biologically meaningful pathways, but finding the matching is time consuming owing to the exhaustive search of subgraphs. Although graph-based isomorphism is the most straightforward idea for aligning pathways, the computational complexity of the graph-based isomorphism problem prohibits its practical application because implementation requires tremendous computing resources as the size of the pathways grows.

In addition, some other methods align metabolic pathways by employing dynamic programming [1820]. In such alignment methods, the similarity between two pathways is defined by the sum of both node and edge matching scores in the similarity objective function. Then, the alignment of pathways is solved by maximizing the similarity objective function between two pathways over all feasible combinations. MNAligner [18] is one example of such methods. MNAligner uses the integer quadratic programming to formulate the alignment of two pathways and find conserved patterns between pathways. To align both two and multiple pathways, Tohsato et al. [19] exploited the global alignment algorithm using dynamic programming to find common pattern from pairwise alignment and then extend pairwise alignment to multiple alignment. Tohsato et al.’s methods were successfully applied to pathway analyses of sugar, DNA and amino acid metabolisms. However, dynamic programming methods do not work well for the large pathway alignment problem since solving the large-scale dynamic programming is time consuming.

Although the above-mentioned methods have achieved considerable progress, there still remains a big challenge. Ay et al. [10] reported that the methods which only search for one-to-one mappings between molecules could not identify biologically relevant mappings when different organisms perform the same or similar function through a varying number of steps. An example is shown in Fig 1, where both paths transform LL-2,6-diaminopimelate into 2,3,4,5-tetrahydrodipicolinate. The upper path denotes the shortcut used by plants to synthesize L-lysine. Due to the lack of the gene encoding LL-DAP aminotransferase (2.6.1.83) catalyzing reaction R07613, H. sapiens has to employ a three-step process, as shown with the lower path in Fig 1, to accomplish this transformation. The upper and lower paths should be mapped together in a meaningful alignment when the lysine biosynthesis pathways of human and a plant are aligned. However, due to the different number of reactions in these two paths, traditional methods that are restricted to finding one-to-one mappings fail to uncover the mapping in Fig 1. Motivated by this challenge, researchers develop the other type of alignment methods that allows not only one-to-one mappings but also one-to-many mappings between reactions of two metabolic pathways to tackle this problem. Ay et al. [10] proposed for the first time a one-to-many alignment model and an alignment method called SubMAP which searches one-to-many mappings between reactions of two metabolic pathways. SubMAP successfully identifies biologically relevant mappings of alternative subnetworks, and is scalable for metabolic pathways of arbitrary topology. To improve the quality of one-to-many alignments of metabolic pathways, Abaka et al. [21] presented a constrained alignment method CAMPways where its goal is to maximize the topological similarity while satisfying some constraints on homological similarity. However, due to the cost in exhaustive search of reaction sets, these two methods do not work well for finding reaction mappings in large-scale metabolic pathways.

thumbnail
Fig 1. A part of lysine biosynthesis pathway.

The square rectangles represent reactions. The compounds are depicted by small circles. Reactions are represented by their KEGG identifiers. Plants use the upper path with a reaction, whereas H. sapiens (human) accomplishes this transformation through the lower path with three reactions.

https://doi.org/10.1371/journal.pone.0168044.g001

In this work, we study the problem of aligning two metabolic pathways, which is briefly described as follows. To align two given metabolic pathways, we want to find a set of one-to-one, one-to-many or many-to-many mappings between reactions, and maximize the sum of the similarity scores of these mappings. The similarity score of such mapping is evaluated as a function of the similarity between the aligned reactions in the mapping (see Section ‘Third Stage’ for details). Recall that one-to-many or many-to-many mappings between reactions are used to identify the mappings of alternative pathways that have similar or the same functions through different sets of reactions [10]. High similarity score indicates that the corresponding alternative pathways perform similar or the same functions with high probability.

Our work is based on the observation that connected relation between reactions can be formalized as binary relation of reactions in the metabolic pathway. Motivated by this observation, we propose an alignment method called MPBR for aligning a pair of metabolic pathways exploiting binary relation of reactions. We formalize connected relation between reactions as binary relation of reactions in metabolic pathway. We exploit for the first time the multiplications of zero-one matrices of binary relation of reactions in finding reaction sets. We show that the multiplications of zero-one matrices of binary relation of reactions can be completed in finite steps. As a consequence, we efficiently obtain such reaction sets in a small number of steps without the need of exhaustive search. Furthermore, distinguishing from measuring the topological similarity of reactions based on the direct neighbors of the reactions [10] or the conserved edges induced by the pairs of reaction mappings in the alignment [21], we measure the topological similarity of nodes (reactions) by comparing the structural similarity of the k-neighborhood subgraphs of the nodes, which helps to improve the accuracy of the alignments due to the use of more topological information of the neighbors of the reactions. Our experimental results on the KEGG database show that when compared with other state-of-the-art methods, in most cases, MPBR obtains better topological and biological quality of the alignments than CAMPways and SubMAP, and accurately returns more biologically relevant reaction mappings.

The rest of the paper is organized as follows. Section ‘Method’ presents our method MPBR. Section ‘Results’ shows experimental results. Section ‘Conclusions’ concludes the paper.

Method

Preliminaries

To start with, we introduce some definitions and notations. A directed graph Gp = (Vp,Ep) is used to denote metabolic pathway P. Vp = {r1,r2,…,ri,…,rk} is the node set of Gp and each node ri represents a reaction in P, i = 1,2,…,k. Ep is the set of directed edges of Gp. There is a directed edge (ri, rj)∈Ep from ri to rj if and only if at least one output compound of ri is an input compound of rj, i = 1,2,…,k and j = 1,2,…,k. If both ri and rj are reversible, there is also a directed edge (rj, ri)∈Ep from rj to ri. Similarly, a directed graph Gp′ = (Vp′,Ep′) is used to denote metabolic pathway P′. Fig 2(A) shows a directed graph for the metabolic pathway of lysine biosynthesis.

thumbnail
Fig 2. Binary relation of reactions in the metabolic pathway of lysine biosynthesis.

The square rectangles represent reactions. The compounds are depicted by small circles. Reactions are represented by their KEGG identifiers. The directed edge from reactions ri to rj denotes that at least one output compound of ri is an input compound of rj. Rp is the binary relation of reactions in the metabolic pathway of lysine biosynthesis. (a) The metabolic pathway of lysine biosynthesis. (b) Directed graph for Rp. (c) Zero-one matrix Mp for Rp. (d) Zero-one matrix Mp2.

https://doi.org/10.1371/journal.pone.0168044.g002

For Gp = (Vp,Ep), let reaction set RS = {r1,r2,…,rn} of size n be a subset of Vp such that the induced subgraph of the reactions in RS is linearly connected in the underlying graph, n = 1,2,3,…. We represent the set of such reaction sets in Gp as RSn = {RS1, RS2,…, RSi,…, RSN}, where N is the number of the reaction sets, RSi is the ith reaction set in RSn and RSi has at most n reactions, i = 1,2,…,N. Similarly, for Gp′ = (Vp′,Ep′), let reaction set RS′ = {r1′,r2′,…,rm′} of size m be a subset of Vp′ such that the induced subgraph of the reactions in RS′ is linearly connected in the underlying graph, m = 1,2,3,…. We represent the set of such reaction sets in Gp′ as RSm′ = {RS1′, RS2′,…, RSj′,…,RSM′}, where M is the number of the reaction sets, RSj′ is the jth reaction set in RSm′ and RSj′ has at most m reactions, j = 1,2,…,M. Parameters n and m are determined by the user. Next, we state our problem formally.

Problem Statement: Given two pathways Gp and Gp′, we aim to find a set of mappings (RSi, RSj′) between RSn and RSm′ in the alignment of Gp and Gp′ such that the sum of the similarity scores of the mappings is maximized, i = 1,2,…,N and j = 1,2,…,M.

In the following, we introduce how to formalize connected relation between reactions as binary relation of reactions in metabolic pathway. A relation between two related elements of two sets is called binary relation [22]. Accordingly, we formalize the binary relation between reactions A and B as the relation that A is connected with B in a metabolic pathway. For example, in Fig 2(A), the reactions of the metabolic pathway of lysine biosynthesis are R04198, R04365, R04475, R02734, R02735, and R00451 (reactions are represented by their KEGG identifiers). The relations between two connected reactions in this pathway are represented as (R04198, R04365), (R04365, R04475), (R04475, R02734), (R02734, R02735), and (R02735, R00451). They can be formalized as binary relation {(R04198, R04365), (R04365, R04475), (R04475, R02734), (R02734, R02735), (R02735, R00451)}. As can be seen from Fig 2(B), binary relation of reactions in this pathway can be represented by a directed graph. Also, we can see from Fig 2(C) that this binary relation can be represented by a zero-one matrix Mp.

In this work, we represent binary relation of reactions in metabolic pathway by zero-one matrix Mp. Mp[i,j] = 1 when reaction ri is connected to reaction rj, and Mp[i,j] = 0 when ri is not connected to rj, i = 1,2,…,N and j = 1,2,…,M. Mpn can be computed recursively by Mp1 = Mp and , where is a Boolean matrix multiplication, positive integer n≥2. Fig 2(D) shows an example of zero-one matrix Mp2.

In the following section, we present our method MPBR.

MPBR method

For a pair of metabolic pathways Gp = (Vp, Ep) and Gp′ = (Vp′, Ep′), the goal of MPBR is to find the reaction mappings between Gp and Gp′. Without loss of generality, we assume that |Vp|≤|Vp′|, reaction sets RSVp and RS′⊆Vp′. MPBR consists of three main stages (as shown in Fig 3): (1) Find all reaction set RS of size n for Gp, and find all reaction sets RS′ of size m for Gp′ (as detailed in Subsection ‘First Stage’); (2) Construct a similarity matrix BM by computing the similarity between the reactions in Gp and Gp′ (as detailed in Subsection ‘Second Stage’); (3) Find mapping (RS, RS′) such that the similarity score of mapping (RS, RS′) is maximized (as detailed in Subsection ‘Third Stage’). A set RSmap of mappings (RS, RS′) is the result for aligning Gp and Gp′. Fig 3 shows an example illustrating the process of aligning a pair of sample pathways.

thumbnail
Fig 3. Overview of the MPBR method.

MPBR searches 1-to-3 reaction mappings between Gp′ and Gp. Mp and Mp are zero-one matrices for binary relation of reactions in Gp and Gp′ respectively. The size of reaction set RSx in Gp is m = 1, x = 1,2,3,4. The size of reaction set RSy in Gp is n = 3, y = 1,2,3,4,5. T(r1,r1), T(r2,r2), T(r3,r3′) and T(r4,r4′) are the topological similarities between the reactions in Gp and Gp′ respectively, the values of BM are the similarities between the reactions in Gp and Gp′.

https://doi.org/10.1371/journal.pone.0168044.g003

First Stage: Finding the candidate reaction sets.

In this subsection, we discuss how to exploit the multiplications of zero-one matrices for binary relation of reactions to create the set RSn = {RS1, RS2,…, RSN} in Gp, and the set RSm′ = {RS1′, RS2′,…, RSM′} in Gp′ respectively. For metabolic pathway Gp, there is a path from r1 to rn if there is a sequence of reactions r1,r2,…,rn with edges (r1, r2), (r2, r3),…, and (rn-1, rn) in Gp. Accordingly, we derive theorem 1.

Theorem 1: For reactions ri and rj, there is a path of length n from ri to rj in Gp if and only if Mpn[i,j] = 1, where n is a positive integer, i = 1,2,…,n and j = 1,2,…,n.

Proof: We will use mathematical induction. There is a path of length one from ri to rj in Gp if and only if Mp[i,j] = 1, so the theorem is true when n = 1.

Assume that the theorem is true for a positive integer n. There is a path of length n+1 from ri to rj if and only if there is a reaction rk in Gp such that there is a path of length one from ri to rk in Gp, so Mp[i, k] = 1, and a path of length n from rk to rj in Gp, that is, Mpn[k, j] = 1. Consequently, by the induction hypothesis, there is a path of length n+1 from ri to rj in Gp if and only if there is a reaction rk with Mp[i, k] = 1 and Mpn[k, j] = 1. But there is such a reaction if and only if Mpn+1[i, j] = 1. Therefore, there is a path of length n+1 from ri to rj in Gp if and only if Mpn+1[i, j] = 1, i = 1,2,…,n and j = 1,2,…,n. γ

Following from theorem 1, we introduce how to find reaction set RS of size n for Gp.

First, we compute Mpn-1. Then we create a reaction pair set NS and iteratively extend NS with the reaction pair (ri, rj) where Mpn-1[i, j] = 1. According to theorem 1, for reactions ri and rj with Mpn-1[i, j] = 1, there is a path of length n-1 from ri to rj in Gp if and only if Mpn-1[i, j] = 1. That is, there are n reactions in this path. Thus, we can construct reaction set RS of size n containing these n reactions. Finally, we search every path of length n between two reactions in each reaction pair of NS in Gp, and create each reaction set RS of size n containing the reactions in each path to construct the set RSn = {RS1, RS2,…, RSN} in Gp. Similarly, we can find each reaction set RS′ of size m and construct the set RSm′ = {RS1′, RS2′,…, RSM′} in Gp′.

Fig 3(B) shows an example of reaction sets of size 3. In this example, we first obtain the reaction pairs (ri, rj) with Mp2[i, j] = 1, i = 1,2,3 and j = 1,2,3,4,5. These reaction pairs are (r1,r3), (r2,r1), (r3,r2), (r2,r4) and (r3,r5). Next we create a reaction pair set NS = {(r1,r3), (r2,r1), (r3,r2), (r2,r4), (r3,r5)} by these reaction pairs. Then, we search the paths of length 2 between two reactions in each reaction pair of NS. These paths are Path 1(r1r2r3), Path 2 (r2r3r1), Path 3 (r3r1r2), Path 4 (r2r3r4) and Path 5 (r3r4r5) respectively. Finally we create reaction sets RS1 = {r1,r2,r3}, RS2 = {r2,r3,r1}, RS3 = {r3, r1, r2}, RS4 = {r2, r3, r4} and RS5 = {r3, r4, r5} with the reactions in Path 1, Path 2, Path 3, Path 4, and Path 5 respectively.

Based on theorem 1 and the above searching procedure of reaction sets in Gp, we drive the following property.

Property 1: Reaction set RS of size n+1 in Gp can be found through performing Mpn.

Property 1 illustrates the relationship between the search of reaction sets and the multiplications of zero-one matrices for binary relation of reactions in Gp.

For Mpn, we have the following theorem.

Theorem 2: If there exist positive integers t and s with t>s such that Mpt = Mps, then for any positive integer n, it holds that MpnS = {Mp, Mp2, …, Mpt-1}.

Proof:

For any n, when nt-1, we have Mp nS. We want to prove Mp nS when n>t-1. When n>t-1, it holds n>s. For n, s and t, there exist positive integers q and r such that n-s = (t-s)q+r (0<rt-s-1,n>s). Therefore, n = s+(t-s)q+r and Mpn = Mps+(t-s)q+r. Since 0<rt-s-1, so s+rt-1 and Mps+rS. Since Mpn = Mps+(t-s)q+r, if we can prove Mps+(t-s)q+r = Mps+r, then it follows Mpn = Mps+rS. In the following, we will use mathematical induction to prove Mps+(t-s)q+r = Mps+r.

When q = 1, it yields Mps+(t-s)q+r = Mps+(t-s)+r = Mpt+r = Mps+r. Assume that for any qk, Mps+(t-s)q+r = Mps+r holds. When q = k+1, we have Mps+(t-s)(k+1)+r = Mps+(t-s)k+r+(t-s) = Mps+(t-s)k+rMp(t-s) = Mps+rMpt-s = Mps+r+t-s = Mpt+r = Mps+r. Hence, Mps+(t-s)q+r = Mps+r also holds for q = k+1. By induction, we have proven that Mps+(t-s)q+r = Mps+r for all q>0. Consequently, since Mpn = Mps+(t-s)q+r, Mps+(t-s)q+r = Mps+r and Mps+rS, hence Mpn = Mps+rS

The discussion regarding the search of reaction sets in Gp and theorem 2 leads to the following corollary.

Corollary 1: If there exist positive integers s and t with s<t such that Mps = Mpt, then the reaction set RS of size nt in Gp can be found through performing at most Mpt-1.

Proof:

Let S = {Mp, Mp2,…,Mpt-1}. When there exist positive integers s and t with s<t such that Mps = Mpt, according to theorem 2, for any positive integer n, it holds that MpnS = {Mp, Mp2,…,Mpt-1}. In other words, when n-1≥t-1, there is a positive integer vt-1 such that Mpv = Mpn-1S. According to property 1, we need to perform Mpn-1 to find reaction set RS of size n in Gp. Because Mpv = Mpn-1 when n-1≥t-1, so we only need to perform Mpv to find the reaction set RS of size n in Gp instead of performing Mpn-1, where vt-1. ϒ

Property 1 implies that we can find reaction set RS of size n through performing Mpn-1. Furthermore, corollary 1 implies that, in order to find reaction set RS of size n, when nt, we only need to try at most Mpt-1. Therefore, we can find reaction set RS of size greater than t in metabolic pathway through performing at most Mpt-1.

In the first stage, MPBR first computes Mpn-1. Secondly, MPBR creates a reaction pair set NS and iteratively extends NS with the reaction pair (ri, rj) where Mpn-1[i,j] = 1. Finally, through finding the paths of length n-1 between two reactions in each reaction pair of NS in Gp, MPBR obtains the set RSn = {RS1, RS2,…, RSN} in Gp and the set RSm′ = {RS1′, RS2′,…, RSM′} in Gp′. Thus, in this way, we avoid the exhaustive search of reaction sets, and produce candidate reaction sets in finite steps.

Second Stage: Calculating the similarity of reactions.

The second stage aims to compute the similarity values between any two reactions in Gp and Gp, which combines topological and homological similarities of reactions, and construct a |Vp|×|Vp| similarity matrix BM, where BM [u,v] is the similarity value between nodes (reactions) u and v, uVp, vVp.

We first introduce how to compute topological similarity of nodes (reactions) in metabolic pathways. Our computation of topological similarity of nodes is based on the following observation. If node u is mapped to node v, then their neighbors in the corresponding graphs should also be similar. From this observation, we measure topological similarity of nodes by comparing the structural similarity of the k-neighborhood subgraphs of nodes. Next, we discuss how to compare the k-neighborhood subgraphs of nodes to compute topological similarity of nodes. Nk(u) is defined as the k-neighborhood node set of u in Gp and Nk(u) is a subset of Vp, uNk(u), where k is an integer and k≥0. The shortest distance between u and xNk(u) is defined as the number of edges of the shortest path between u and x, which is not exceeding k. Similarly, Nk(v) is defined as the k-neighborhood node set of v in Gp′.

For uVp and vVp, the k-neighborhood subgraph of u in Gp is denoted by . Ek(u) is defined as the edge set of . is the induced subgraph over Nk(u)∪{u} in Gp. The k-neighborhood subgraph of v in Gp′ is denoted by . is the induced subgraph over Nk(v)∪{v} in Gp′. Let d(u) be the degree of u in Gp and d(v) be the degree of v in Gp′. Suppose that the degree sequence of the nodes in Nk(u) is d(x1), d(x2),…,d(xi),…,and sorted in a non-increasing order, and the degree sequence of the nodes in Nk(v) is d(y1), d(y2),…,d(yj),…,and sorted in non-increasing order. We compare the k-neighborhood subgraph of u with the k-neighborhood subgraph of v to compute the topological similarity T(u,v) between u and v: (1) where Km is the maximal value of k and is determined by the user, and are the sum of degrees of nodes in Nk(u) and Nk(v) respectively. The impact of edges on the topological similarity T(u,v) is evaluated by and . When k = 0, Nk(u) = u and Nk(v) = v.

In the following, we discuss how to compute homological similarity between reactions. Since reactions consist of the input and output compounds and enzymes, we measure the homological similarity between reactions by the similarities of these components. Thus the homological similarity Bsim(u,v) between u and v is computed by the following equation: (2) where ue is the enzyme catalyzing reaction u, ve is the enzyme catalyzing reaction v, Esim(ue,ve) is the similarity score between enzyme ue and enzyme ve. We employ the enzyme similarity score defined in [16] to calculate Esim(ue,ve). More specifically, the EC identifier of an enzyme consists of four digits that categorize the type of the catalyzed chemical reaction. Esim(ue,ve) is 1 if all the four digits of the EC identifier of two enzymes are identical, Esim(ue,ve) is 0.75 if the first three digits are identical, Esim(ue,ve) is 0.5 if the first two digits are identical, Esim(ue,ve) is 0.25 if the first digit is identical, and Esim(ue,ve) is 0 if the first digit is different [16]. For example, for enzymes 2.3.1.117 and 2.6.1.17, Esim(2.6.1.18, 2.6.1.12) = 0.75. The input compounds of u and v are ui and vi respectively, and the output compounds of u and v are uo and vo respectively. Csim(ui,vi) is the average similarity score of compounds ui and vi, and Csim(uo,vo) is the average similarity score of compounds uo and vo. For example, if C1 and C2 are the input compounds of u, and C3 and C4 are the input compounds of v, then Csim(ui,vi) = {sim(C1,C3)+sim(C1, C4)+sim(C2, C3)+sim(C2, C4)}/4, where sim(A, B) is the similarity score of compounds A and B. Similarly, we can compute Csim(uo,vo). The similarity scores of compounds are calculated by the SIMCOMP package [23]. For example, the similarity score of compounds acetoacetyl-CoA and (S)-3-Hydroxy-3-methylglutaryl-CoA is 0.723077. Parameters α, β and γ control the balance between the weights of Esim(ue,ve), Csim(ui,vi) and Csim(uo,vo) with the constraint α+β+γ = 1. For the choice of weight parameters α, β and γ, we use α = 0.4, β = 0.3 and γ = 0.3.

Both homological and topological similarities of reactions provide significant information for the alignment of metabolic pathways. We are now ready to define our similarity S(u,v) between u and v, which is computed by the following equation: (3) where σ is a balancing parameter between the weight of T(u,v) and the weight of Bsim(u,v), 0≤σ≤1.

In the second stage, we use Eq (3) to calculate the similarity values between any two reactions in two pathways, and construct a similarity matrix BM for the reactions using these similarity values. For example, when k = 2, σ = 0.5, for simplicity, we assume that the homological similarities between any two reactions in sample pathways Gp and Gp′ are 0.5, a similarity matrix BM for the reactions in Gp and Gp′ is shown in Fig 3(C).

Third Stage: Extracting reaction mappings.

Once we obtain the set RSn = {RS1, RS2,…, RSi,…, RSN} in Gp, the set RSm′ = {RS1′, RS2′,…, RSj′,…,RSM′} in Gp′, and the similarity matrix BM for the reactions, we try to extract mappings (RSi, RSj′) that constitute our alignment. In the third stage, for each reaction set in RSn and RSm′, we first perform greedy search to find a mapping (RSi, RSj′) such that the similarity score of mapping (RSi, RSj′) is maximized, and then add mapping (RSi,RSj′) to the set RSmap of mappings. To compute the similarity score of mapping (RSi, RSj′), we obtain the similarity value S1 between the start reactions in RSi and RSj′, and the similarity value S2 between the end reactions in RSi and RSj′ from similarity matrix BM obtained in the second stage. The average value of S1 and S2 is the similarity score of mapping (RSi, RSj′). For example, as can be seen from Fig 3(C), in the similarity matrix BM, the similarity value between the start reactions in RS2 and RS1′ is 0.625, and the similarity value between the end reactions in RS2 and RS1′ is 0.75. Then the similarity score of mapping (RS2, RS1′) is 0.6875.

The greedy search for mappings (RSi, RSj′) is repeated until all reaction sets in RSn are aligned with the reaction sets in RSm′. At this time, the set RSmap of mappings (RSi, RSj′) is the result of aligning Gp and Gp′. Fig 3(D) shows an example of the mapping results found in the alignment of a pair of sample pathways.

In summary, we first utilize the multiplications of zero-one matrices for binary relation of reactions to find reaction set RS of size n for Gp and reaction set RS′ of size m for Gp′. Second, in order to improve the topological and biological accuracy of the alignments for metabolic pathways, we propose a measure of topological similarity of nodes (reactions), which compares the structural similarity of the k-neighborhood subgraphs of the nodes. Then, we measure the similarity between reactions by combining topological and homological similarities of reactions and build a similarity matrix BM between all reactions in two pathways. Finally, we employ a greedy search to find a set of reaction mappings (RS, RS′) where the sum of the similarity scores of each mapping is maximized.

Results

MPBR is implemented in Java, the data and program are available at http://210.36.16.170:8080/MPBR/MPBR.zip. Currently, CAMPways and SubMAP are the two available alignment softwares that allow one-to-many reaction mappings in the alignment of metabolic pathways. We downloaded CAMPways and SubMAP from http://code.google.com/p/campways/ and http://bioinformatics.cise.ufl.edu/SubMAP.html respectively. In this section, we experimentally compared the performance of MPBR with that of CAMPways and SubMAP, and discussed three sample alignments.

The KEGG database [1] provides 11 metabolism categories: 1.1 carbohydrate metabolism, 1.2 energy metabolism, 1.3 lipid metabolism, 1.4 nucleotide metabolism, 1.5 amino acid metabolism, 1.6 metabolism of other amino acids, 1.7 glycan biosynthesis and metabolism, 1.8 metabolism of cofactors and vitamins, 1.9 metabolism of terpenoids and polyketides, 1.10 biosynthesis of other secondary metabolites, and 1.11 xenobiotics biodegradation and metabolism.

From the metabolic pathways of the KEGG database retrieved and reformatted by Ay et al. [10], Abaka et al.[21] provided a dataset of 11 metabolic pathways to evaluate alignment quality. Each pathway in this dataset corresponds to one of the above metabolisms. Following the state-of-the-art method CAMPways [21], we also evaluate alignment quality using this dataset. The experimental evaluations are divided into the pathway alignments between species within the same domain and the pathway alignments between species from different domains. Similar to CAMPways, Homo sapiens (hsa) and Mus musculus (mmu) are selected as two representative species from the eukaryota domain, while Escherichia coli (eco) and Agrobacterium tumefaciens (atc) are selected as two representative species from the bacteria domain.

By using the method proposed by Abaka et al. [21], we merge all pathways of the above metabolisms into a large pathway for each of these four species. Thus, we totally obtain four large merged pathways, namely hsa-1.12 with 1520 nodes, mmu-1.12 with 1466 nodes, eco-1.12 with 1104 nodes and atc-1.12 with 1127 nodes. We also use these four large merged pathways to evaluate the performance of the alignment methods. Moreover, we use eight real metabolic pathways eco00230, eco00240, hsa00230, hsa00240, atc00230, atc00240, mmu00230 and mmu00240 from these four species as test pathways. These eight metabolic pathways are obtained from the literature [10] and they are represented by eco-1.13, eco-1.14, hsa-1.13, hsa-1.14, atc-1.13, atc-1.14, mmu-1.13 and mmu-1.14 respectively in this paper. S1 Table presents the number of nodes and the number of edges of the pathways used in the experiments.

The experimental comparisons are conducted based on six criteria. Next, we introduce these criteria in detail [10, 21, 2426].

  1. 1. Edge Correctness (EC) is the percentage of the edges of the first pathway that are aligned to the edges of the second pathway. The more similar topology of the two pathways, the higher value of the EC [24]. EC is calculated by the following equation [2426]: where u and v are the nodes in the first pathway, (u,v) is an edge in the first pathway, E is the edge set of the first pathway, E1 is the matched edge set of the first and second pathways, g(u) and g(v) are the mapping nodes of u and v in the second pathway respectively, and E2 is the edge set of the second pathway.
  2. 2. Node Correctness (NC) is the percentage of nodes of the first pathway that are aligned to the correct nodes of the second pathway. NC is calculated by the following equation [24]: where u is a node in the first pathway, V1 is the node set of the first pathway, f is the correct node mapping, and g is the alignment mapping. For the correct node mapping f, we use measurement FGC (functional group conversion category), which was previously used to define the correct mapping between pathways in [21], to judge whether the node mapping is correct. Specifically, FGC category is a part of the RCLASS database [27] of KEGG. The reactions in the KEGG database are classified into hierarchically organized functional group categories [21]. There are eight FGC categorizations of the KEGG hierarchy, and each FGC categorization is divided into five levels. Abaka et al. pointed out that an inter-species alignment of a pair of pathways is considered biologically validated if the alignment maps reaction subsets classified under the same FGC category [21]. The biological relevance of reaction mappings is closely related to the FGC hierarchy of reactions in the mappings. More specifically, a reaction mapping is biologically more significant if it includes more reactions with higher FGC hierarchy under the same FGC category. In the experimental results of the main text, for a fixed level 5 of the hierarchy, a node mapping is called correct if there exists at least one category at the 5th level of the FGC hierarchy that includes all the reactions in the mapping [21].
  3. 3. The Number of Edges of Largest Common Connected Subgraph (ELCCS) is the number of the edges of the largest connected subgraph of the first pathway that is isomorphic to a subgraph of the second pathway [24]. ELCCS is used to evaluate the topological accuracy and biological relevance of the alignments. The larger and denser connected subgraphs are biologically more valuable [24].
  4. 4. C-1tomany is the number of correct one-to-many reaction mappings between the first pathway and the second one. To describe this measurement, we introduce some notations first. Let X, X′ denote two species and GX, GX′ represent their metabolic pathways corresponding to some metabolism 1.m, listed earlier in the text. Let (RS, RS′) be a mapping from an alignment of GX and GX′ where RS = {r1}, RS′ = {r1′, r2′,…,rx′}, and P1,…,Pi,…,Px be the pathways that include reaction r1 and are associated with metabolism 1.m in the species X [21].

Following the literatures [10] and [21], we measure the correctness of the one-to-many reaction mappings based on two aspects. On the one hand, as Ay et al. [10] reported that if both alternative pathways can complete the transformations between two given compounds through different reaction sets, then these two pathways are considered to be functionally similar. A correct one-to-many reaction mapping between different pathways should be able to identify the mapping of such alternative pathways [10]. On the other hand, Abaka et al. [21] pointed out that an alignment mapping reactions that belong back to the same original KEGG pathway is considered to be of high quality. Combining these two aspects, a one-to-many reaction mapping (RS, RS′) is called correct if it satisfies the following two conditions: (1) The start reactions in RS and RS′ share at least one input compound and the end reactions in RS and RS′ share at least one output compound. (2) Every reaction in RS′ is included in at least one of the pathways P1′,…,Pi′,…, Px′ where each Pi′ is a pathway in metabolism 1.m of species X′ and corresponds to Pi of X [21].

  1. 5. CR-1tomany is the ratio of the number of correct one-to-many reaction mappings to the total number of mappings produced by the alignment [21]. CR-1tomany can be used to investigate the percentage of the correct one-to-many reaction mappings in the alignment. Higher values for CR-1tomany indicate that the alignments for one-to-many reaction mapping are of high quality [21].
  2. 6. C-manytomany is the number of correct many-to-many reaction mappings between the first pathway and the second one. By reference to C-1tomany, let (RS, RS′) be a many-to-many mapping from an alignment of GX and GX′ where RS = {r1, r2,…,rx}, RS′ = {r1′, r2′,…,ry′}, and P1,…,Pi,…,Px be the pathways that include a reaction in RS and are associated with metabolism 1.m in the species X. Similar to C-1tomany, a many-to-many reaction mapping (RS, RS′) is called correct if it satisfies the following two conditions: (1) The start reactions in RS and RS′ share at least one input compound and the end reactions in RS and RS′ share at least one output compound. (2) Every reaction in RS′ is included in at least one of the pathways P1′,…,Pi′,…,Px′ where each Pi′ is a pathway in metabolism 1.m of species X′ and corresponds to Pi of X.

MPBR, CAMPways and SubMAP provide the options of one-to-one alignment and one-to-many alignment. We can perform one-to-one alignment of two pathways to find one-to-one reaction mappings between these two pathways. Similarly, we can perform one-to-many alignment of two pathways to find one-to-many reaction mappings between these two pathways. In the experiments, the one-to-many reaction mappings include 1-to-2 and 1-to-3 reaction mappings.

In this paper, we use EC, NC and ELCCS to measure the quality of one-to-one alignment, and use C-1tomany and CR-1tomany to measure the quality of one-to-many alignment. In addition, we use C-manytomany to evaluate the capability of MPBR for searching many-to-many reaction mappings.

In the experiments, MPBR was run using k = 3 and σ = 0.6, and CAMPways and SubMAP were run using their default parameter settings. MPBR, CAMPways and SubMAP were run on the Sugon 5000A computer system of cluster architecture at Guangxi University, using a single computing node with a quad-core Intel(R) Xeon(R) CPU E5620 @ 2.40GHz and 40GB RAM. The operating system is Linux.

The following five subsections will provide our experimental evaluations on the qualities of the alignment results computed by MPBR, CAMPways and SubMAP respectively. Subsections ‘Same-domain One-to-one Alignments’ and ‘Same-domain One-to-many Alignments’ focus on one-to-one alignment and one-to-many alignment between the species within the same domain respectively. Subsections ‘Across-domains One-to-one Alignments’ and ‘Across-domains One-to-many Alignments’ focus on one-to-one alignment and one-to-many alignment between the species from different domains respectively. Subsection ‘Running time and memory requirements’ discusses the performance of each method in terms of the running time and memory requirements. Subsection ‘Many-to-many Alignments’ discusses the experimental results of many-to-many alignments of the pathways. Subsection ‘Case study’ introduces three sample alignments to show how MPBR, CAMPways and SubMAP can be used to analyze metabolic pathways.

The values of NC of the alignment results of MPBR, CAMPways and SubMAP for the fifth level of the FGC hierarchy are shown in Tables 115, whereas the values of NC for the first four levels of the FGC hierarchy are shown in S2S5 Tables.

thumbnail
Table 1. EC and NC of one-to-one alignment results for eco-atc.

https://doi.org/10.1371/journal.pone.0168044.t001

thumbnail
Table 2. EC and NC of one-to-one alignment results for hsa-mmu.

https://doi.org/10.1371/journal.pone.0168044.t002

thumbnail
Table 3. ELCCS of one-to-one alignment results for eco-atc and hsa-mmu.

https://doi.org/10.1371/journal.pone.0168044.t003

thumbnail
Table 4. C-1tomany and CR-1tomany of one-to-many alignment results for eco-atc.

https://doi.org/10.1371/journal.pone.0168044.t004

thumbnail
Table 5. C-1tomany and CR-1tomany of one-to-many alignment results for hsa-mmu.

https://doi.org/10.1371/journal.pone.0168044.t005

thumbnail
Table 6. EC and NC of one-to-one alignment results for hsa-eco.

https://doi.org/10.1371/journal.pone.0168044.t006

thumbnail
Table 7. EC and NC of one-to-one alignment results for hsa-atc.

https://doi.org/10.1371/journal.pone.0168044.t007

thumbnail
Table 8. EC and NC of one-to-one alignment results for mmu-atc.

https://doi.org/10.1371/journal.pone.0168044.t008

thumbnail
Table 9. EC and NC of one-to-one alignment results for mmu-eco.

https://doi.org/10.1371/journal.pone.0168044.t009

thumbnail
Table 10. ELCCS of one-to-one alignment results for hsa-eco and hsa-atc.

https://doi.org/10.1371/journal.pone.0168044.t010

thumbnail
Table 11. ELCCS of one-to-one alignment results for mmu-atc and mmu-eco.

https://doi.org/10.1371/journal.pone.0168044.t011

thumbnail
Table 12. C-1tomany and CR-1tomany of one-to-many alignment results for hsa-eco.

https://doi.org/10.1371/journal.pone.0168044.t012

thumbnail
Table 13. C-1tomany and CR-1tomany of one-to-many alignment results for hsa-atc.

https://doi.org/10.1371/journal.pone.0168044.t013

thumbnail
Table 14. C-1tomany and CR-1tomany of one-to-many alignment results for mmu-atc.

https://doi.org/10.1371/journal.pone.0168044.t014

thumbnail
Table 15. C-1tomany and CR-1tomany of one-to-many alignment results for mmu-eco.

https://doi.org/10.1371/journal.pone.0168044.t015

Same-domain One-to-one Alignments

In this subsection, we discuss the quality of the same-domain one-to-one alignments produced by MPBR and other comparative methods. Tables 13 summarize the one-to-one alignment results for the same domain species with respect to distinct performance indices.

As shown in Tables 13, over all 28 instances, MPBR has the highest values of EC, NC and ELCCS for 19, 18 and 18 instances respectively, whereas all three methods obtain equal values of EC, NC and ELCCS for 5, 6 and 7 instances respectively. Additionally, MPBR and CAMPways obtain equal values of EC, NC and ELCCS for 4, 4 and 3 instances respectively. These experimental results emphasize that, for the same-domain one-to-one alignment, in most cases, our MPBR method outperforms other comparative methods not only in topological accuracy but also in biological relevance of the results. Thanks to the use of structural similarity among the neighbors of reactions, MPBR is able to improve the topological and biological accuracy of the alignments.

Same-domain One-to-many Alignments

In this subsection, we compare the quality of the same-domain one-to-many alignments produced by MPBR and other comparative methods. The values of C-1tomany and CR-1tomany of the one-to-many alignment results for the same domain species are shown in Tables 4 and 5.

From Tables 4 and 5, we can see that, MPBR performs the best with the highest values of C-1tomany and CR-1tomany in 22 and 15 out of all 28 instances respectively. For 4 instances, all three methods obtained the same values of C-1tomany and CR-1tomany, while the value of C-1tomany of MPBR is lower than CAMPways for 2 instances and is lower than SubMAP for 1 instance. The value of CR-1tomany of MPBR is lower than SubMAP for 4 instances, and some values of CR-1tomany of MPBR are lower than CAMPways for 7 instances. This means that, in most cases, MPBR is able to return more correct one-to-many reaction mappings than CAMPways and SubMAP in the same-domain one-to-many alignment. On the other hand, when the size of the pathway becomes large, SubMAP is unable to generate a result for 9 instances under the current computing environment while MPBR and CAMPways are not restricted to the size of the pathway in the same-domain one-to-many alignment.

Across-domains One-to-one Alignments

This subsection discusses the quality of the across-domains one-to-one alignments produced by MPBR and other comparative methods. Tables 611 present the one-to-one alignment results for different domain species with respect to distinct performance indices.

As can be seen from Tables 611, over all 56 instances, MPBR performs better than the other two methods with the highest values of EC, NC and ELCCS for 47, 42 and 51 instances respectively. Some values of EC and NC of MPBR are a bit lower than those of CAMPways for 4 and 3 instances respectively. This demonstrates that, in most cases, MPBR is also capable of achieving better topological accuracy and biological relevance of the alignment results than other two comparative methods in across-domains one-to-one alignment.

In addition, from Tables 13 and Tables 611 we can find that the values of EC, NC and ELCCS of the same-domain alignments are obviously higher than those values of across-domains alignments. This is also consistent with the analysis that the biological relevance of the species within the same domain is much stronger [10]. Thus, we can employ the alignments of metabolic pathways to analyze the evolution of species.

Across-domains One-to-many Alignments

In this subsection, we compare the quality of the across-domains one-to-many alignments produced by MPBR and other comparative methods. The values of C-1tomany and CR-1tomany of the one-to-many alignment results for different domain species are shown in Tables 1215.

From Tables 1215, we can see that, MPBR achieves the best values of C-1tomany and CR-1tomany compared to other comparative methods in 44 and 32 out of 56 instances respectively. For only 10 out of 56 instances MPBR fails to be the best. On the other hand, combining Tables 1215 and S1 Table, we can find that, for the across-domains one-to-many alignment, when the size of the pathway is large enough with thousands of reactions, possibly due to the exhaustive search of reaction sets, CAMPways and SubMAP are unable to generate a result for 34 and 4 instances respectively under the current computing environment. In contrast, for these instances, the values of C-1tomany and CR-1tomany of MPBR are still high enough without being affected by the size of pathway. While the comparative methods suffer from the size of large-scale pathway, MPBR overcomes this problem and returns more correct one-to-many reaction mappings.

The above analysis of C-1tomany and CR-1tomany shows that, in most instances, MPBR also performs better than the other two methods in across-domains one-to-many alignment. In conclusion, the results from subsection ‘Same-domain One-to-many Alignments’ and subsection ‘Across-domains One-to-many Alignments’ demonstrate that MPBR is an effective method in retrieving one-to-many reaction mappings in the alignment of metabolic pathways.

Running time and memory requirements

In the experiments of one-to-one and one-to-many alignments, we have tested a total of 168 instances. In some cases, SubMAP and CAMPWays consumed an unusually long time until running out of memory, Table 16 summaries the percentage of the instances that can be solved by MPBR, CAMPWays and SubMAP respectively, and the average running time for the solved instances. In Table 16, PSI represents the percentage of the solved instances of each method, in one-to-one alignment, ART1 denotes the average running time for the 64 instances solved by all three methods and ART2 represents the average running time for the 84 instances solved by MPBR and CAMPWays, and in one-to-many alignment, ART3 denotes the average running time for the 41 instances solved by all three methods, and ART4 represents the average running time for the 80 instances solved by MPBR and CAMPWays.

thumbnail
Table 16. The percentage of the solved instances and the average running time for the solved instances (in seconds).

https://doi.org/10.1371/journal.pone.0168044.t016

As can be seen from Table 16, for the one-to-one alignment, although the average running time for the 64 solved instances of SubMAP is shorter than CAMPWays and MPBR, SubMAP failed to solve 20 out of 84 instances since it took an unusually long time until running out of memory in these unsolved instances, whereas both CAMPWays and MPBR solved all the instances. Meanwhile we can see that, for the one-to-one alignment, MPBR consumed less time than CAMPWays for the 84 instances solved by MPBR and CAMPWays.

For the one-to-many alignment, we can observe from Table 16 that, MPBR spent less time for the 41 instances solved by all three methods in comparison to CAMPWays and SubMAP; in addition, compared with CAMPWays, MPBR took less time for the 80 solved instances of MPBR and CAMPWays, and MPBR solved all the 84 instances while both CAMPWays and SubMAP did not.

Many-to-many Alignments

In addition to one-to-many alignments, we can also reveal alternative pathways that have similar functions by finding many-to-many reaction mappings between different pathways. This subsection discusses whether MPBR can accurately find such mappings in the alignment of metabolic pathways. The many-to-many reaction mappings include 2-to-2, 2-to-3 and 3-to-3 reaction mappings. Both CAMPways and SubMAP do not implement the functionality of many-to-many alignment. Table 17 shows the C-manytomany of many-to-many alignment results of MPBR.

thumbnail
Table 17. C-manytomany of many-to-many alignment results of MPBR.

https://doi.org/10.1371/journal.pone.0168044.t017

Both Escherichia coli (eco) and Agrobacterium tumefaciens (atc) are single-cell microorganisms, Homo sapiens (hsa) and Mus musculus (mmu) are complex organisms with cell membranes. Table 17 demonstrates that there are a number of many-to-many reaction mappings between the species among the same domain and among different domains. These results suggest that many-to-many reaction mappings frequently appear in nature. MPBR has the capability in finding many-to-many reaction mappings between different pathways to obtain biologically meaningful alignments.

Case study

In this subsection, we present three cases (as shown in Fig 4) to discuss how to comparatively analyze metabolic pathways using MPBR, CAMPways and SubMAP. We represent the reactions by their KEGG identifiers. First, we used MPBR, CAMPways and SubMAP to perform one-to-one alignment for the metabolic pathways of lysine biosynthesis in atc and eco. The result is shown in Fig 4(A). Lysine biosynthesis pathway consists of 6 enzymes arranged in a linear topology, transforming the substrate (2S,4S)-4-Hydroxy- 2,3,4,5-tetrahydrodipicolinate into L-lysine. We observed that the pathways of lysine biosynthesis are identical between atc and eco. This implies a common ancestral pathway, which is consistent with the theory that pathways for synthesis of proteinogenic amino acids were established before ancient organisms diverged into archaea, bacteria, and eucarya [28].

thumbnail
Fig 4. Sample alignments.

The upper reactions are a part of the pathways of atc, whereas the lower reactions are a part of the pathways of eco. Reactions are represented by their KEGG identifiers. Enzymes are shown in EC numbers. The compounds are depicted by small circles. (a) One-to-one reaction mappings extracted from the alignment of the metabolic pathways of lysine biosynthesis in atc and eco. (b) A one-to-many reaction mapping extracted from the alignment of the metabolic pathways of Glyoxylate and dicarboxylate metabolism in atc and eco. (c) A many-to-many reaction mapping extracted from the alignment of the metabolic pathways of Glycolysis in atc and eco.

https://doi.org/10.1371/journal.pone.0168044.g004

On the other hand, one-to-many or many-to-many reaction mappings in the alignment of pathways may uncover additional interesting evolutionary phenomena, or alternative pathways performing the same or similar function. An example is a one-to-many reaction mapping in Fig 4(B). MPBR obtains this mapping by performing one-to-many alignment for the metabolic pathways of Glyoxylate and dicarboxylate metabolism in atc and eco. Both CAMPways and SubMAP fail to find this mapping in this alignment. In Fig 4(B), the eco reaction R01394 [Hydroxypyruvate < = > 2-Hydroxy-3-oxopropanoate] was mapped to the atc reactions R01392 [D-Glycerate + NADP+ < = > Hydroxypyruvate + NADPH + H+] and R01747 [D-Glycerate + NADP+ < = > 2-Hydroxy-3-oxopropanoate + NADPH + H+]. Since both R01394 and R01392 share one input compound Hydroxypyruvate and both R01394 and R01747 share one output compound 2-Hydroxy-3-oxopropanoate, the reaction R01394 in eco, catalyzed by 5.3.1.22, is functionally similar to the succession of the two reactions R01392 and R01747 in atc, catalyzed by 1.1.1.79 and 1.1.1.60. Biologically, this indicates that the functionality of 5.3.1.22 in eco is analogous to the combined functionality of the two enzymes 1.1.1.79 and 1.1.1.60 in atc. This may imply an intriguing case of either gene fusion in eco or gene duplication in atc. This needs to be further investigated to reveal the biological scene that leads to this event; nevertheless, it provides an elicitation in this direction.

Another example is a many-to-many reaction mapping in Fig 4(C). MPBR obtains this mapping by performing many-to-many alignment for the metabolic pathways of Glycolysis in atc and eco. Both CAMPways and SubMAP do not implement the functionality of many-to-many alignment. In Fig 4(C), MPBR mapped the atc reactions R01602 [alpha-D-Glucose < = > beta-D-Glucose] and R01600 [ATP + beta-D-Glucose < = > ADP + beta-D-Glucose 6-phosphate] to the eco reactions R01786 [ATP + alpha-D-Glucose < = > ADP + alpha-D-Glucose 6-phosphate] and R02739 [alpha-D-Glucose 6-phosphate < = > beta-D-Glucose 6-phosphate]. As can be seen from Fig 4(C), alpha-D-Glucose can be transformed into beta-D-Glucose 6-phosphate through reactions R01602 and R01600 in atc, while this transformation can be done through reactions R01786 and R02739 in eco. That is, by allowing many-to-many reaction mappings in the alignments, MPBR has successfully found different alternative pathways that have similar function through different sets of reactions.

Conclusions

In this paper, we have proposed an alignment method MPBR for finding reaction mappings between two metabolic pathways. We have formalized the connected relation between reactions as binary relation of reactions, and have shown how to employ the multiplications of zero-one matrices for binary relation of reactions to search reaction sets in a small number of steps to uncover one-to-many and many-to-many reaction mappings between two metabolic pathways. This provides the first step in the process of exploiting the relation between reactions in the alignment of metabolic pathways. The success of MPBR is primarily due to the use of the multiplications of zero-one matrices for binary relation of reactions in finding reaction sets, which avoids the exhaustive search for reaction sets and increases the accuracy of the alignments of the alternative pathways. Furthermore, we introduce a measure of topological similarity of reactions, which compares the structural similarity of the k-neighborhood subgraphs of the reactions, and employ this similarity metric to improve the accuracy of the alignments.

In most cases, MPBR obtains alignment results with higher values of EC, NC, ELCCS, C-1tomany and CR-1tomany than CAMPways and SubMAP, and accurately returns more biologically relevant mappings. Moreover, our method also provides a user-defined parameter for finding many-to-many reaction mappings in the alignments, while both CAMPways and SubMAP do not support many-to-many alignment. Thus, MPBR enriches the means of one-to-many and/or many-to-many alignments of metabolic pathways.

In order to further improve biological relevance of resulting mappings, one feasible solution is to use context-specific information content, such as semantic similarity of the gene ontology (GO) terms or sequence information, to compute homological similarity of reactions. Another interesting issue is to exploit binary relation of reactions to identify functional motifs in metabolic pathways.

Supporting Information

S1 Table. The number of nodes and the number of edges of the pathways.

https://doi.org/10.1371/journal.pone.0168044.s001

(DOC)

S2 Table. NC of one-to-one alignment results for the fourth level of the FGC hierarchy.

https://doi.org/10.1371/journal.pone.0168044.s002

(DOC)

S3 Table. NC of one-to-one alignment results for the third level of the FGC hierarchy.

https://doi.org/10.1371/journal.pone.0168044.s003

(DOC)

S4 Table. NC of one-to-one alignment results for the second level of the FGC hierarchy.

https://doi.org/10.1371/journal.pone.0168044.s004

(DOC)

S5 Table. NC of one-to-one alignment results for the first level of the FGC hierarchy.

https://doi.org/10.1371/journal.pone.0168044.s005

(DOC)

Acknowledgments

We thank the anonymous reviewers for their constructive comments, which greatly help us improve our manuscript.

Author Contributions

  1. Conceptualization: YRH.
  2. Methodology: YRH CZ.
  3. Software: YRH.
  4. Validation: YRH CZ.
  5. Writing – original draft: YRH CZ.
  6. Writing – review & editing: HXL JH.

References

  1. 1. Kanehisa M, Goto S, Sato Y, Kawashima M, Furumichi M, Tanabe M. Data, information, knowledge and principle: back to metabolism in KEGG. Nucleic Acids Research. 2014;42(D1):D199–D205.
  2. 2. Caspi R, Foerster H, Fulcher CA, Kaipa P, Krummenacker M, Latendresse M, et al. The MetaCyc Database of metabolic pathways and enzymes and the BioCyc collection of Pathway/Genome Databases. Nucleic Acids Research. 2008;36(suppl 1):D623–D31.
  3. 3. Li Y, de Ridder D, de Groot MJ, Reinders MJ. Metabolic pathway alignment between species using a comprehensive and flexible similarity measure. BMC Systems Biology. 2008;2(1):111.
  4. 4. Hasan MM, Kahveci T. Indexing a protein-protein interaction network expedites network alignment. BMC Bioinformatics. 2015;16(1):326.
  5. 5. Sharan R, Suthram S, Kelley RM, Kuhn T, McCuine S, Uetz P, et al. Conserved patterns of protein interaction in multiple species. Proceedings of the National Academy of Sciences of the United States of America. 2005;102(6):1974–9. pmid:15687504
  6. 6. Ay F, Dang M, Kahveci T. Metabolic network alignment in large scale by network compression. BMC Bioinformatics. 2012;13(Suppl 3):S2.
  7. 7. Fionda V, Palopoli L. Biological network querying techniques: analysis and comparison. Journal of Computational Biology. 2011;18(4):595–625. pmid:21417941
  8. 8. Song B, Buyuktahtakin IE, Ranka S, Kahveci T. Manipulating the steady state of metabolic pathways. IEEE/ACM Transactions on Computational Biology and Bioinformatics (TCBB). 2011;8(3):732–47.
  9. 9. Malod-Dognin N, Pržulj N. L-GRAAL: Lagrangian graphlet-based network aligner. Bioinformatics. 2015;31(13):2182–9. pmid:25725498
  10. 10. Ay F, Kellis M, Kahveci T. SubMAP: aligning metabolic pathways with subnetwork mappings. Journal of Computational Biology. 2011;18(3):219–35. pmid:21385030
  11. 11. Chen W, Rocha AM, Hendrix W, Schmidt M, Samatova NF, editors. The multiple alignment algorithm for metabolic pathways without abstraction. 2010 IEEE International Conference on Data Mining Workshops (ICDMW); 2010: IEEE.
  12. 12. Pinter RY, Rokhlenko O, Yeger-Lotem E, Ziv-Ukelson M. Alignment of metabolic pathways. Bioinformatics. 2005;21(16):3401–8. pmid:15985496
  13. 13. Wernicke S, Rasche F. Simple and fast alignment of metabolic pathways by exploiting local diversity. Bioinformatics. 2007;23(15):1978–85. pmid:17540683
  14. 14. Yang Q, Sze S-H. Path matching and graph matching in biological networks. Journal of Computational Biology. 2007;14(1):56–67. pmid:17381346
  15. 15. Tian Y, Mceachin RC, Santos C, Patel JM. SAGA: a subgraph matching tool for biological graphs. Bioinformatics. 2007;23(2):232–9. pmid:17110368
  16. 16. Heymans M, Singh AK. Deriving phylogenetic trees from the similarity analysis of metabolic pathways. Bioinformatics. 2003;19(suppl 1):i138–i46.
  17. 17. Alberich R, Llabrés M, Sánchez D, Simeoni M, Tuduri M. MP-Align: alignment of metabolic pathways. BMC Systems Biology. 2014;8(1):1.
  18. 18. Cheng Q, Harrison R, Zelikovsky A. MetNetAligner: a web service tool for metabolic network alignments. Bioinformatics. 2009;25(15):1989–90. pmid:19414533
  19. 19. Tohsato Y, Matsuda H, Hashimoto A, editors. A multiple alignment algorithm for metabolic pathway analysis using enzyme hierarchy. Proceedings of the 8th International Conference on Intelligent Systems for Molecular Biology;2000.p.376–83.
  20. 20. Li Z, Zhang S, Wang Y, Zhang X-S, Chen L. Alignment of molecular networks by integer quadratic programming. Bioinformatics. 2007;23(13):1631–9. pmid:17468121
  21. 21. Abaka G, Bıyıkoğlu T, Erten C. CAMPways: constrained alignment framework for the comparative analysis of a pair of metabolic pathways. Bioinformatics. 2013;29(13):i145–i53. pmid:23812978
  22. 22. Rosen KH, Krithivasan K. Discrete mathematics and its applications: McGraw-Hill New York; 1999.
  23. 23. Hattori M, Okuno Y, Goto S, Kanehisa M. Development of a chemical structure comparison method for integrated analysis of chemical and genomic information in the metabolic pathways. Journal of the American Chemical Society. 2003;125(39):11853–65. pmid:14505407
  24. 24. Neyshabur B, Khadem A, Hashemifar S, Arab SS. NETAL: a new graph-based method for global alignment of protein–protein interaction networks. Bioinformatics. 2013;29(13):1654–62. pmid:23696650
  25. 25. Singh R, Xu J, Berger B. Global alignment of multiple protein interaction networks with application to functional orthology detection. Proceedings of the National Academy of Sciences. 2008;105(35):12763–8.
  26. 26. Milenkovic T, Ng WL, Hayes W, Przulj N. Optimal network alignment with graphlet degree vectors. Cancer Informatics. 2010;9:121. pmid:20628593
  27. 27. Kanehisa M, Goto S, Sato Y, Furumichi M, Tanabe M. KEGG for integration and interpretation of large-scale molecular data sets. Nucleic Acids Research. 2012;40(D1):D109–D14.
  28. 28. Hochuli M, Patzelt H, Oesterhelt D, Wüthrich K, Szyperski T. Amino acid biosynthesis in the halophilic archaeonhaloarcula hispanica. Journal of Bacteriology. 1999;181(10):3226–37. pmid:10322026