+ All Categories
Home > Documents > Optimal protein threading by cost-splitting

Optimal protein threading by cost-splitting

Date post: 30-Apr-2023
Category:
Upload: univ-valenciennes
View: 1 times
Download: 0 times
Share this document with a friend
15
Optimal protein threading by cost-splitting P. Veber 1 , N. Yanev 1 ? , R. Andonov 1 , and V. Poirriez 2 1 IRISA, Campus de Beaulieu, 35042 Rennes Cedex, France {pveber,nyanev,randonov}@irisa.fr 2 University of Valenciennes, 59313 Valenciennes, France [email protected] Abstract. In this paper, we use integer programming approach for solv- ing a hard combinatorial optimization problem, namely protein thread- ing. For this sequence-to-structure alignment problem we apply cost- splitting technique to derive a new Lagrangian dual formulation. The optimal solution of the dual is sought by an algorithm of polynomial com- plexity. For most of the instances the dual solution provides an optimal or near-optimal (with negligible duality gap) alignment. The speed-up with respect to the widely promoted approach for solving the same prob- lem in [17] is from 100 to 250 on computationally interesting instances. Such a performance turns computing score distributions, the heaviest task when solving PTP, into a routine operation. 1 Introduction Protein folding is one of the most extensively studied problems in com- putational biology. The problem can be simply stated as follows: given a protein sequence, which is a string over the 20-letter amino acid alpha- bet, determine the positions of each amino acid atom when the protein assumes its 3D folded shape. Although simply stated, this problem is extremely difficult to solve and is widely recognized as one of the most important challenges in computational biology today [10, 16, 6]. In case of remote homologs, one of the most promising approaches to the above problem is protein threading, i.e., one tries to align a query pro- tein sequence with a set of 3D structures to check whether the sequence might be compatible with one of the structures. Fold recognition meth- ods based on threading are complex and time consuming computational techniques consisting of the following components: 1. a database of known 3D structural templates; 2. an objective function which evaluates any alignment of a sequence to a template structure; ? on leave from University of Sofia, 5, J. Bouchier str., 1126 Sofia, Bulgaria
Transcript

Optimal protein threading by cost-splitting

P. Veber1, N. Yanev1?, R. Andonov1, and V. Poirriez2

1 IRISA, Campus de Beaulieu, 35042 Rennes Cedex, France{pveber,nyanev,randonov}@irisa.fr

2 University of Valenciennes, 59313 Valenciennes, [email protected]

Abstract. In this paper, we use integer programming approach for solv-ing a hard combinatorial optimization problem, namely protein thread-ing. For this sequence-to-structure alignment problem we apply cost-splitting technique to derive a new Lagrangian dual formulation. Theoptimal solution of the dual is sought by an algorithm of polynomial com-plexity. For most of the instances the dual solution provides an optimalor near-optimal (with negligible duality gap) alignment. The speed-upwith respect to the widely promoted approach for solving the same prob-lem in [17] is from 100 to 250 on computationally interesting instances.Such a performance turns computing score distributions, the heaviesttask when solving PTP, into a routine operation.

1 Introduction

Protein folding is one of the most extensively studied problems in com-putational biology. The problem can be simply stated as follows: given aprotein sequence, which is a string over the 20-letter amino acid alpha-bet, determine the positions of each amino acid atom when the proteinassumes its 3D folded shape. Although simply stated, this problem isextremely difficult to solve and is widely recognized as one of the mostimportant challenges in computational biology today [10, 16, 6].

In case of remote homologs, one of the most promising approaches tothe above problem is protein threading, i.e., one tries to align a query pro-tein sequence with a set of 3D structures to check whether the sequencemight be compatible with one of the structures. Fold recognition meth-ods based on threading are complex and time consuming computationaltechniques consisting of the following components:

1. a database of known 3D structural templates;

2. an objective function which evaluates any alignment of a sequence toa template structure;

? on leave from University of Sofia, 5, J. Bouchier str., 1126 Sofia, Bulgaria

3. a method for finding the best (with respect to the score function)possible sequence-3D structure alignment;

4. a statistical analysis of the raw scores allowing the detection of thesignificant sequence-structure alignments.

The third point above is related to the problem of finding the optimalsequence-to-structure alignment and is referred to as protein threadingproblem (PTP). From a computer scientist’s viewpoint this is the mostchallenging part of the threading methods. Until recently, it was the mainobstacle to the development of efficient and reliable fold recognition meth-ods. In the general case, when variable-length alignment gaps are allowedand pairwise amino acid interactions are considered in the score function,PTP is NP-hard [8]. Moreover, it is MAX-SNP-hard [1], which means thatthere is no arbitrary close polynomial approximation algorithm, unless P= NP. In this context the progress done by the computational biologycommunity in solving PTP during the last few years is really remarkable[12, 20, 2, 17, 18, 3]. The empirical results clearly illustrate that PTP iseasier in practice than in theory and that it is possible to solve real-life(biological) instances in a reasonable amount of time. These results alsoshow that one of the most promising approaches in solving this problemis using advanced mathematical programming (Mixed Integer Program-ming, MIP) models for PTP [19, 20, 2, 17]. The most amazing observationis that for almost all (more than 95%) of the instances, the LP relaxationof the MIP models is integer-valued, thus providing optimal threading.This is true even for polytopes with more than 1046 vertices. Moreover,when the LP relaxation is not integer, its value is a relatively good approx-imation of the integer solution. However, to the best of our knowledge,this observation has not been practically used before the current paper.Other successful Integer Programming approaches for solving combinato-rial optimization problems originated in molecular biology are discussedin the recent survey [11].

The main drawback of mathematical programming approaches is thatthe corresponding models are often very large (over 106 variables). Eventhe most advanced MIP solvers need prohibitively large running timefor solving such instances. For example, the authors in [17] find out 30templates for which it takes about 15 hours to thread one target ontothem on a Silicon Graphics Origin 3800 system, which has 40400 MHzMIPS R12000 CPUs and 20 GB of RAM. Different divide-and-conquermethods and parallel algorithms can be used to overcome this drawback[18–20].

2

A further step in solving the huge MIP models is the developmentof special-purpose algorithms based on advanced combinatorial optimiza-tion techniques like Lagrangian relaxation. Such an algorithm has beenrecently designed by S. Balev in [3] and computationally compared withthe B&B algorithm from [8] and a heuristic used in [9]. The computa-tional results are very impressive and clearly show that the Lagrangianrelaxation (LR) significantly outperforms both other algorithms. How-ever, comparisons with MIP solver are not provided in [3].

In this paper we continue the same direction of research and proposea new dedicated algorithm for solving protein threading MIP models.It is as well based on Lagrangian relaxation. But, both our Lagrangiandual formulation and the optimization technique that we use for solving it(the so-called cost-splitting [13]), differentiate from those described in [3].Extensive computational results prove that: (i) our algorithm is in mostcases faster than the one in [3]; (ii) both Lagrangian relaxation algorithmssignificantly outperform solving MIP models by LP relaxation. To thebest of our knowledge the only other impressive application of LR to analignment problem is discussed in [5].

Another contribution of the current paper concerns the 4th pointabove. When aligning a given query sequence to a set of 3D structures itis not possible to directly use the raw scores to rank the 3D structures.The reason is that these scores strongly depend on the query and tem-plate lengths and also, in a complicated way, on the particular featuresof the 3D structures. In addition, the query sequence may correspond tonone of the existing folds. Therefore one must have means to evaluate thesignificance of an alignment score. This can be done as a preprocessingstage, by empirically calculating a distribution of scores for each template,using a set of sequences not related to it3. The underlying score normal-ization procedure involves threading a large set of queries against eachtemplate and requires solving millions of PTP. For example the packageFROST (Fold Recognition-Oriented Search Tool) [9], uses a database ofabout 1,200 known 3D structures, each one associated with empirically de-termined score distributions. Computing these distributions is extremelytime consuming: it requires solving about 1,200,000 sequence-to-structurealignments and takes about 40 days on a 2.4 GHz computer and about 3days on a cluster of 12 PCs [14]. Accelerating computations involved inthis component is crucial for the development of efficient fold recognitionmethods.

3 More justifications for this phase the interested reader can find in [9].

3

Based on extensive comparisons we observe that the approximatedsolutions obtained by any one of the three algorithms considered in thispaper can be successfully used when computing scores distributions. Sincethese approximated solutions are obtained by polynomial algorithms, weexperimentally prove that this heavy stage can be polynomially com-puted.

The organization of the paper is as follows. In section 2 we introducea formal presentation of PTP, and then study some special cases in thesection 3. Section 4 presents the cost-splitting technique. Last section isdedicated to experimental results.

2 Protein threading problem

For the sake of brevity, in this paper we stick to the network optimizationproblem formulation proposed in [19, 2].

Let us introduce variables yij , and denote by Y the set of feasiblethreadings, defined by the following constraints:

n∑

k=1

yik = 1 i = 1, . . . ,m (1)

k∑

l=1

yil −

k∑

l=1

yi+1,l ≥ 0 i = 1, . . . ,m − 1, k = 1, . . . , n − 1 (2)

yik ∈ {0, 1} i = 1, . . . ,m, k = 1, . . . , n (3)

These constraints describe the set of feasible paths in a particulardigraph (see figure 4 in Appendix A), with vertex set V = {(i, j) | i =1, . . . ,m, j = 1, . . . , n}. The vertices (i, j), j = 1, . . . , n will be referredto as ith layer. Each layer corresponds to a structural element, and eachvertex in a layer corresponds to a positioning of this element on a queryprotein. Let L ⊆ {(i, k) | 1 ≤ i < k ≤ m} be a given set of inter-layerslinks. This is the so-called contact graph: a link between layers i and kmeans that the corresponding structural elements are in contact in the3D structure.

Let Aik be the 2n × n(n+1)2 node-arc incidence matrix for the sub-

graph spanned by the layers i and k, (i, k) ∈ L. The submatrix Ai, thefirst n rows of Aik, (resp. Ak, the last n rows) corresponds to the layeri (resp. k). To avoid added notation we will use vector notation for thevariables yi = (yi1, ...yin) ∈ Bn where Bn is the set of n-dimensionalbinary vectors, with assigned costs ci = (ci1, ...cin) ∈ Rn and zik =

(zi1k1, . . . , zi1kn, zi2k1, . . . , zinkn) ∈ Bn(n+1)

2 for (i, k) ∈ L with assigned

4

costs dik = (di1k1, . . . , di1kn, di2k1, . . . , dinkn) ∈ Rn(n+1)

2 . In the sectionsbelow the vector dik will be considered as a n × n upper triangular ma-trix, having arbitrarily large coefficient below the diagonal. This slightdeviation from the standard definition of an upper triangular matrix isused only for formal definition of some matrix operations.

Now the protein threading problem PTP (L) is defined as:

zLip = v(PTP (L)) = min{

m∑

i=1

ciyi +∑

(i,k)∈L

dikzik} (4)

subject to: y = (y1, . . . , ym) ∈ Y, (5)

yi = Aizik, yk = Akzik (i, k) ∈ L (6)

zik ∈ Bn(n+1)

2 (i, k) ∈ L (7)

The shortcut notation v(.) will be used for the optimal objective functionvalue of a subproblem obtained from PTP (L) with some z variables fixed.Throughout the next section, vertex costs ci are assumed to be zero. Westudy three sorts of contact graph that make PTP polynomially solvable.

3 Special cases

3.1 Contact graph contains no crossing edges

Two links (i1, k1) and (i2, k2) such that i1 < i2 are said to be crossingwhen k1 is in the open interval (i2, k2). The case when the contact graph Lcontains no crossing edges has been mentioned to be polynomially solvablefor the first time in [1]. Here we present a different sketch for O(n3)complexity of PTP in this case.

If L contains no crossing edges, then PTP (L) can be recursively di-vided into independent subproblems. Each of them consists in computingall shortest paths between the vertices of two layers i and k, discardinglinks that are not included in (i, k). Thus the result of this computationis a distance matrix Dik such that Dik(j, l) is the optimal length betweenvertices (i, j) and (k, l). Note that for j > l as there is no path in thegraph, Dik(j, l) is an arbitrarily large coefficient. Finally, the solution ofPTP (L) is the smallest entry of D1m.

We say that an edge (i, k), i < k is included in the interval [a, b] when[i, k] ⊆ [a, b]. Let us denote by L(ik) the set of edges of L included in [i, k].Then, an algorithm to compute Dik can be sketched as follows:

5

1. if L(ik) = {(i, k)} then the distance matrix is given by

Dik =

{

dik if (i, k) ∈ L

0 otherwise(8)

where 0 is an upper triangular matrix in the previously defined sense(arbitrary large coefficients below the main diagonal) and having onlyzeros in its upper part.

2. otherwise as L(ik) has no crossing edges, there exists some s ∈ [i, k]such that any edge of L(ik) but (i, k) is included in [i, s] or in [s, k].Then

Dik =

{

Dis.Dsk + dik if (i, k) ∈ LDis.Dsk otherwise

(9)

where the matrix multiplication is computed by replacing (+,×) op-erations on reals by (min,+).

Remark 1. If the contact graph has m vertices, and contains no crossingedges, then the problem is decomposed into O(m) subproblems. For eachof them, the computation of the corresponding distance matrix is a O(n3)procedure (matrix multiplication with (min,+) operations). Overall com-plexity is thus O(mn3). Typically, n is one or two orders of magnitudegreater than m, and in practice, this special case is already expensive tosolve.

3.2 All edges have their left end tied to a common vertex

A set of edges L = {(i1, k1), . . . , (ir, kr)}, k1 < k2 < . . . kr is called astar if it has at least two elements and it = i1, t ≤ r. The arc costscorresponding to the link (i, ks) are given by the upper triangular matrixdiks

. The following algebra is used to prove the O(n2) complexity of thecorresponding PTP.

Definition 1. Let A,B be two matrices of size n × n. M = A ⊗ B is

defined by M(i, j) = mini≤r≤j

A(i, r) + B(i, j)

In order to compute A⊗B, we use the following recursion: let M ′ bethe matrix defined by M ′(i, j) = min

i≤r≤jA(i, r), then

M ′(i, j) = min{M ′(i, j − 1), A(i, j)}, for all j ≥ i

Finally A ⊗ B = M ′ + B. From this it is clear that ⊗ multiplication forn × n matrices is of complexity O(n2).

6

Theorem 1. Let L = {(i, k1), . . . , (i, kr)} be a star.

Then Dikr= (. . . (dik1 ⊗ dik2) ⊗ . . . ) ⊗ dikr

Proof. The proof follows the basic dynamic programming recursion forthis particular case: for the star L = {(i, k1), . . . , (i, kr)} = L′

{(i, kr)},we have v(L : zijkrl = 1) = dijkrl + min

j≤s≤lv(L′ : zijkr−1s = 1)

3.3 Sequence of independent subproblems

Given a contact graph L = {(i1, k1), . . . , (ir, kr)}, PTP (L) can be de-composed into two independent subproblems when there exists an integere ∈ (1,m) such that any edge of L is included either in [1, e], either in[e,m]. Let I = {i1, . . . , is} be an ordered set of indices, such that anyelement of I allows for a decomposition of PTP (L) into two independentsubproblems. Suppose additionally that for all t ≤ s − 1, one is able tocompute Ditit+1 . Then we have the following theorem:

Theorem 2. Let p = (p1, p2, . . . , pn) be obtained by the following matrix-

vector multiplication p = Di1i2Di2i3 . . . Dis−1isp, where p = (0, 0, . . . , 0)and the scalar product in the matrix-vector multiplication is defined by

changing ”+” with ”min” and ”.” with ”+”. Then for all i, pi = v(PTP (L :y1i = 1), and v(PTP (L)) = min{pi}.

Proof. Each multiplication by Dikik+1in the definition of p is an algebraic

restatement of the main step of the algorithm for solving the shortest pathproblem in a graph without circuits.

Remark 2. With the notations introduced above, the complexity of PTP (L)for a sequence of such subproblems is O(sn2) plus the cost of computingmatrices Ditit+1 .

From the last two special cases, it can be seen that if the contact graphcan be decomposed into independent subsets, and if these subsets aresingle edges or stars, then there is a O(srn2) algorithm, where s is thecardinality of the decomposition, and r the maximal cardinality of eachsubset, that solves the corresponding PTP.

4 Cost splitting

In order to apply the results from the previous section, we need to finda suitable partition of L into L1

L2...⋃

Lt where each Ls induces an

7

easy solvable PTP (Ls), and to use the s.c. cost-splitting variant of theLagrangian duality. Now we can restate (4)-(7) equivalently as:

vLip = min

t∑

s=1

(

m∑

i=1

csiy

si +

(i,k)∈Ls

dikzik)

(10)

subject to: y1i = ys

i , s = 2, t (11)

ys = (ys1, ..y

sm) ∈ Y, s = 1, . . . , t (12)

ysi = Aizik, ys

k = Akzik s = 1, . . . , t (i, k) ∈ Ls (13)

zik ∈ Bn(n+1)

2 s = 1, . . . , t (i, k) ∈ Ls (14)

Taking (11) as the complicating constraints, we obtain the Lagrangiandual of PTP (L):

vcsd = maxλ

miny

t∑

s=1

(m

i=1

csi (λ)ys

i +∑

(i,k)∈Ls

dikzik) = maxλ

t∑

s=1

vLs

ip (λ) (15)

subject to (12), (13) and (14).The Lagrangian multipliers λs are associated with the equations (11)

and c1i (λ) = c1

i +∑t

s=2 λs, csi (λ) = cs

i −λs, s = 2, . . . , t. The coefficients csi

are arbitrary (but fixed) decomposition (cost-split) of the coefficients ci,i.e. given by cs

i = psci with∑

ps = 1. From the Lagrangian duality theoryfollows vlp ≤ vcsd ≤ vip. This means that for each PTP instance s.t. vlp =vip holds vcsd = vip. By applying the subgradient optimization technique([13]) in order to obtain vcsd, one need to solve t problems vLs

ip (λ) (see the

definition of vLs

ip ) for each λ generated during the subgradient iterations.As usual, the most time consuming step is PTP (Ls) solving, but we havedemonstrated its O(n2) complexity in the case when Ls is a union ofindependent stars and single links. More details concerning the actualimplementation are given in Appendix B.

5 Experimental results

The numerical results presented in this section were obtained on an In-tel(R) Xeon(TM) CPU 2.4 GHz, 2 GB RAM, RedHat 9 Linux. The be-havior of the algorithm was tested by computing the same distributionsas given in [3] (for the purpose of comparison), plus few extra-large in-stances based on real-life data generated by FROST (Fold RecognitionOriented Search Tool) software [9]. The MIP models were solved usingCPLEX 7.1 solver [7].

8

−1.0 −0.5 0.0 0.5

−10

12

3

1ASYA0

CPU time in log10(seconds) for the CS−LR algorithm

CP

U ti

me

in lo

g10(

seco

nds)

for t

he C

PLE

X−L

P a

lgor

ithm

Plot of time in seconds with CS-LR al-gorithm on the x-axis and the LP al-gorithm from [2] on the y-axis. Bothalgorithms compute approximated so-lutions for 962 threading instances as-sociated to the template 1ASYA0 fromthe FROST database. The linear curvein the plot is the line y = x. What is ob-served is a significant performance gapbetween the algorithms. For example ina point (x, y) = (0.5, 3) CS-LR is 102.5

times faster than LP relaxation.

Fig. 1. Cost-Splitting Lagrangian Relaxation versus LP Relaxation

In our first computational experiment we focus on computing scoredistributions phase and we study the quality of the approximated solu-tions given by three PTP algorithms. Five distributions are associatedto any 3D template in the FROST database. They are computed bythreading the template with sets of non related protein sequences hav-ing length respectively equal to: -30%, -15%, 0%, +15%, +30% of thetemplate length. Any of these sets contains approximately 200 sequences.

Hence, computing a score distribution in the FROST database re-quires solving approximately 1000 sequence-to-template alignments. Onlytwo values will be finally used: these are the score values obtained at the1st and at the 3rd quartiles of the distribution (denoted respectively byq25 and q75). FROST uses the following scheme: the raw score (RS) (i.e.the score obtained when a given query is aligned with the template) isnormalized according to the formula NS = q75−RS

q75−q25. Only the value NS

(called normalized score) is used to evaluate the relevance of the computedraw score to the considered distribution.

We conducted the following experiment. For the purpose of this sec-tion we chose a set of 12 non-trivial templates. 60 distributions are as-sociated to them. We first computed these distributions using an exactalgorithm for solving the underlying PTP problem. The same distribu-tions have been afterwords computed using the approximated solutionsobtained by any of the three algorithms here considered. By approxi-mated solution we mean respectively the following: i) for a MIP modelthis is the solution given by the LP relaxation; ii) for SB-LR (StefanBalev’s Lagrangian Relaxation) algorithm this is the solution obtainedfor 500 iterations (the upper bound used in [3]). Any exit with less than500 iterations is a sign that the exact value has been found; iii) for the

9

−1.0 −0.5 0.0 0.5

−1.0

−0.5

0.0

0.5

1.0

Time in log10(seconds) for the CS−LR algorithm

Tim

e in

log1

0(se

cond

s) fo

r the

SB

−LR

alg

orith

m

−1.0 −0.5 0.0 0.5 1.0 1.5

−1.0

−0.5

0.0

0.5

1.0

1.5

2.0

time for the CS−LR algorithm

time

for t

he S

B−L

R a

lgor

ithm

Fig. 2. Plot of time in seconds with CS-LR (Cost-Splitting Lagrangian Relaxation)algorithm on the x-axis versus SB-LR (Stefan Balev’s Lagrangian Relaxation) algo-rithm [3] on the y-axis concerning score distributions of two templates. Both the x-axisand y-axis are in logarithmic scales. The linear curve in the plot is the line y = x.Left: The template 1ASYA (the one referenced in [3]) has been threaded with 962sequences. Right: 1ALO 0 is one of the templates yielding the biggest problem in-stances when aligned with the 704 sequences associated to it in the database. Weobserve that although CS-LR is often faster than SB-LR, in general the performanceof both algorithms is very close.

Cost-Splitting Lagrangian Relaxation algorithm (CS-LR) this is the solu-tion obtained either for 300 iterations or when the relative error betweenupper and lower bound is less than 0.001.

We use the MYZ integer programming model introduced in [2]. Ithas been proved faster than the MIP model used in the package RAP-TOR [17] which was well ranked among all non-meta servers in CAFASP3(Third Critical Assessment of Fully Automated Structure Prediction) andin CASP6 (Sixth Critical Assessment of Structure Prediction). Becauseof time limit we present here the results from 10 distributions only4.Concerning the 1st quartile the relative error between the exact and ap-proximated solution is 3 × 10−3 in two cases and less than 10−6 for allother cases. Concerning the 3rd quartile, the relative error is 10−3 in twocases and less than 10−6 for all other cases.

All 12125 alignments for the set of 60 distributions have been com-puted by the other two algorithms. Concerning the 1st quartile, the exactand approximated solution are equal for all cases for both (SB-LR andCS-LR) algorithms. Concerning the 3rd quartile and in case of SB-LRalgorithm the exact solution equals the approximated one in all but twocases in which the relative error is respectively 10−3 and 10−5. In thesame quartile and in case of CS-LR algorithm the exact solution equalsthe approximated one in 12119 instances and the relative error is 7×10−4

in only 6 cases.

4 More data will be solved and provided for the final version.

10

0.0 0.5 1.0 1.5 2.0 2.5 3.0

0.0

0.5

1.0

1.5

2.0

2.5

3.0

CS−LR/ SB−LR, running time to compute distributions.

CPU time in log10(seconds) for the CS−LR algorithm

CP

U ti

me

in lo

g10(

seco

nds)

for t

he S

B−L

R a

lgor

ithm

Plot of time in seconds with CS-LRalgorithm on the x-axis and the SB-LR algorithm on the y-axis. Each pointcorresponds to the total time needed tocompute one distribution determinedby approximately 200 alignments of thesame size. 61 distributions have beencomputed which needed solving totally12125 alignments. Both the x-axis andy-axis are in logarithmic scales. Thelinear curve in the plot is the line y = x.CS-LR is consistently faster than SB-LR algorithm.

Fig. 3. CS-LR versus SB-LR : recapitulation plot concerning 12125 alignments.

Obviously, this loss of precision (due to computing the distributionby not always taking the optimal solution) is negligible and does notdegrade the quality of the prediction. We therefore conclude that theapproximated solutions given by any of above mentioned algorithm canbe successfully used in the score distributions phase.

Our second numerical experiment concerns running time comparisonsfor computing approximated solutions by LP, SB-LR and CS-LR algo-rithms. The obtained results are summarized on figures 1, 2 and 3. Figure1 clearly shows that CS-LR algorithm significantly outperforms the LPrelaxation. Figures 2 and 3 illustrate that CS-LR is mostly faster thanSB-LR algorithm. Time sensitivity with respect to the size of the problemis given in Fig. 3.

6 Conclusion

The results in this paper confirm once more, that integer programmingapproach is well suited to solve protein threading problem. Here, we pro-posed a cost-splitting approach, and derived a new Lagrangian dual for-mulation for this problem. This approach compares favorably with theLagrangian relaxation proposed in [3]. It allows to solve huge instances5,with solution space of size up to 1077, within a few minutes.

The results lead us to think that even better performance could beobtained by relaxing additional constraints, relying on the quality of LPbounds. In this manner, the relaxed problem will be easier to solve. Thisis the subject of our current work.

5 Solution space size of 1040 corresponds to a MIP model with 4×104 constraints and2 × 106 variables [20].

11

References

1. T. Akutsu and S. Miyano. On the approximation of protein threading. Theoretical

Computer Science, 210:261–275, 1999.2. R. Andonov, S. Balev and N. Yanev, Protein Threading Problem: From Mathe-

matical Models to Parallel Implementations, INFORMS Journal on Computing,2004, 16(4), pp. 393-405

3. Stefan Balev, Solving the Protein Threading Problem by Lagrangian Relaxation,WABI 2004, 4th Workshop on Algorithms in Bioinformatics, Bergen, Norway,September 14 - 17, 2004

4. D. Fischer, http://www.cs.bgu.ac.il/ dfishcer/CAFASP3/, Dec. 20025. A. Caprara, R. Carr, S. Israil, G. Lancia and B. Walenz, 1001 Optimal PDB

Structure Alignments: Integer Programming Methods for Finding the MaximumContact Map Overlap Journal of Computational Biology, 11(1), 2004, pp. 27-52

6. H. J. Greenberg, W. E. Hart, and G. Lancia. Opportunities for combinatorialoptimization in computational biology. INFORMS Journal on Computing, 16(3),2004.

7. Ilog cplex. http://www.ilog.com/products/cplex8. R. Lathrop, The protein threading problem with sequence amino acid interaction

preferences is NP-complete, Protein Eng., 1994; 7: 1059-10689. A. Marin, J.Pothier, K. Zimmermann, J-F. Gibrat, FROST: A Filter Based Recog-

nition Method, Proteins, 2002 Dec 1; 49(4): 493-50910. T. Lengauer. Computational biology at the beginning of the post-genomic era. In

R. Wilhelm, editor, Informatics: 10 Years Back - 10 Years Ahead, volume 2000 ofLecture Notes in Computer Science, pages 341–355. Springer-Verlag, 2001.

11. G. Lancia. Integer Programming Models for Computational Biology Problems. J.

Comput. Sci. & Technol., Jan. 2004, Vol. 19, No.1, pp.60-7712. R.H. Lathrop and T.F. Smith. Global optimum protein threading with gapped

alignment and empirical pair potentials. J. Mol. Biol., 255:641–665, 1996.13. G. L. Nemhauser and L. A. Wolsey. Integer and Combinatorial Optimization.

Wiley, 1988.14. V. Poirriez, A. Marin, R. Andonov, J-F. Gibrat. FROST: Revisited and Dis-

tributed, HiCOMB 2005, Fourth IEEE International Workshop on High Perfor-mance Computational Biology, April 4, 2005, Denver, CO

15. R: A language and environment for statistical computing, R Foundation for Sta-tistical Computing, Vienna, Austria, 2004, http://www.R-project.org

16. J.C. Setubal, J. Meidanis, Introduction to computational molecular biology, 1997,Chapter 8: 252-259, Brooks/Cole Publishing Company, 511 Forest Lodge Road,Pacific Grove, CA 93950

17. J. Xu, M. Li, G. Lin, D. Kim, and Y. Xu. RAPTOR: optimal protein threadingby linear programming. Journal of Bioinformatics and Computational Biology,1(1):95–118, 2003.

18. Y. Xu and D. Xu. Protein threading using PROSPECT: design and evaluation.Proteins: Structure, Function, and Genetics, 40:343–354, 2000.

19. N. Yanev and R. Andonov. Solving the protein threading problem in parallel.In HiCOMB 2003 – Second IEEE International Workshop on High Performance

Computational Biology, 2003, Avril, Nice, France20. N. Yanev and R. Andonov, Parallel Divide and Conquer Approach for the Pro-

tein Threading Problem, Concurrency and Computation: Practice and Experience,2004; 16: 961-974

12

Appendix

A Network flow model

S T

7 1 3 1

3

4

1

4

2

1

7 8

5

1

4

1

28

1

3

2

10

8

2

1

2

2 3 4 5

( 1 1 ) (3 2) 2 (3 1) (5 2) 4

( 1 1 ) (3 3) 7 (3 1) (5 3) 2

( 1 2 ) (3 2) 3 (3 2) (5 2) 7

( 1 2 ) (3 3) 8 (3 2) (5 3) 5

( 1 3 ) (3 3) 5 (3 3) (5 3) 2

(1 3) (3 5)

NON−LOCAL COSTS

( 1 1 ) (3 1) 4 (3 1) (5 1) 1

opt = f ((1,1) (2,1) (3,2) (4,2) (5,2)) = 14.0

3

1

i

k

Fig. 4. According to the model introduced in [2], any feasible threading corresponds toa path from S to T in this particular graph. The optimal threading is the augmentedshortest path, i.e. the path charged with the cost induced by links of the contact graph(non-local costs). Here, the contact graph L is {(1, 3), (3, 5)}.

B Implementation issues

In order to apply the subgradient optimization technique to solve PTP (L)one need i) to find a suitable partitioning of L into subgraphs with aspecial structure, and ii) to tune appropriately the parameters of thealgorithm, used for finding vcsd.

B.1 Problem decomposition

The aim of cost-splitting techniques is to decompose a problem into sub-problems of reasonable complexity. In our case, each subproblem shouldbe a set of independent stars and single links. Several such decompositionsexist, but the choice of a particular decomposition may impact a lot onperformance: with a lot of subproblems, each one is simpler to solve, butit takes more subgradient iterations to reach a complete agreement be-tween subproblems. Experimentally, the following decomposition appearsto be suitable and is easy to obtain.

First all (i, i+1) links (i ∈ [1,m−1]) are put in L1 subproblem (if oneof them, doesn’t exist, it is added with a corresponding null cost matrix).

13

All vertex costs ci, i ∈ [1,m] are affected to L1 subproblem. Thus, allother subproblems have null vertex cost.

Then, given K a set of links we start constructing a subproblem byselecting the star with maximal left and right end (called right most star,rms), and delete it from K. Then we iterate this selection scheme, andeach time add a rightmost star which is compatible with the last selectedone (they are independent in the sense described above). When no star canbe added to the subproblem, we start building a new subproblem followingthe same procedure until K is empty. Fig. 5 illustrates the constructionof a subproblem on an example.

B.2 Subgradient algorithm

The subgradient ascend is an iterative search procedure that is used tomaximize a concave function (for a comprehensive introduction, see [13]).In our case this is the function

vcsd(λ) = miny

{

t∑

s=1

(

m∑

i=1

csi (λ)ys

i +∑

(i,k)∈Ls

dikzik)} (16)

= min{

m∑

i=1

ciyi +∑

(i,k)∈L

dikzik +

t∑

s=2

i∈I1s

λis(y1i − ys

i )} (17)

subject to maximize in (15). This function is obtained from (10) by re-laxation of the complicated constraints (11). The sets I 1s are derivedfrom the actual realization of the partition of L and by elimination from(11) all i not common for subproblems L1 and Ls. If Is, s = 2, . . . , tbe the set of layers covered by Ls then I1s = I1

Is. Instead (11)to hold for each i ∈ {1, . . . ,m} one can achieve the goals by takingI1s, s = 2, . . . , t as inclusive sets for the respective i. Thus (15) is functionof λ = (λ2, . . . , λt) with λs ∈ Rn|I1s|. From Lagrangian duality theory theadded term

∑ts=2

i∈I1s λis(y1i − ys

i ) is used for approaching the optimalλ∗ from the current one by taking a small step along the subgradient. In

1 2 3 4 5 6 7 8 9 1314=S11=S’

1210

K14rms = {(11, 13), (11, 14)}

K11rms = {(5, 8), (5, 9)} K

5rms = {(2, 5)}

subproblem: K5rms ∪ K

11rms ∪ K

14rms

Fig. 5. Construction of a subproblem from a set of links K

14

this case (y1i − ys

i ), i ∈ L1s( for each i this is a n-vector with only twonon-zero coefficients equal to 1 and -1 resp.), with ys being an optimalsolution to PTP (cs(λ), Ls) is the part of the subgradient, correspondingto λs. At each iteration, y1 provides a feasible solution that is used tocompute an upper bound ub for the optimal value; a lower bound lb isgiven by the highest found value of the Lagrangian. In our experimentsthe step length: θi in iteration i is controlled by θi = 1.4(ui

b− lib)ρiρ0/nbm

where ρ500 = 0.001, ρ0 is an initial guess for step length, and nbm is thenumber of violated relaxed constraints (the length of the subgradient).

C Additional experimental results

0 20 40 60 80

01

23

4

CS−LR running time for computing distributions

Size of solutions space (logarithmic scale)

CS

−LR

CP

U ti

me

in s

econ

ds (l

og10

)

Each point in this plot corresponds tothe total time required by CS-LR algo-rithm to compute one distribution de-termined by approximately 200 align-ments of the same size. About 60 dis-tributions have been computed whichneeded solving about 12000 alignmentstotally. The size of the biggest instanceis O(1077).

Fig. 6. Evolution in time as a function of the solutions space size.

15


Recommended