Dataset: 11.1K articles from the COVID-19 Open Research Dataset (PMC Open Access subset)
All articles are made available under a Creative Commons or similar license. Specific licensing information for individual articles can be found in the PMC source and CORD-19 metadata
.
More datasets: Wikipedia | CORD-19

Logo Beuth University of Applied Sciences Berlin

Made by DATEXIS (Data Science and Text-based Information Systems) at Beuth University of Applied Sciences Berlin

Deep Learning Technology: Sebastian Arnold, Betty van Aken, Paul Grundmann, Felix A. Gers and Alexander Löser. Learning Contextualized Document Representations for Healthcare Answer Retrieval. The Web Conference 2020 (WWW'20)

Funded by The Federal Ministry for Economic Affairs and Energy; Grant: 01MD19013D, Smart-MD Project, Digital Technologies

Imprint / Contact

Highlight for Query ‹COVID-19 screening

A mixed integer linear programming model to reconstruct phylogenies from single nucleotide polymorphism haplotypes under the maximum parsimony criterion

Problem 1

– The Phylogeny Estimation Problem (PEP)

optimizef(T)s.t.g(H,T)=1T∈T,

where T a phylogeny of

H,T the set of all possible phylogenies of

H,f:T→R a function modeling the selected criterion of phylogeny estimation, and

g:H×T→R is a characteristic function equal to one if a phylogeny T is compatible (according to the selected criterion) for the set

H. A specific optimization problem is completely characterized by defining the functions f and g, and the phylogeny T∗ that optimizes f and satisfies g is referred to as optimal.

One of the classic criteria for phylogeny estimation is the parsimony criterion, which assumes that one taxon evolves from another by means of small changes and that the most plausible phylogeny will be that requiring the smallest number of changes. That evolution proceeds by small rather than smallest changes is due to the fact that the neighborhood of possible alleles that are selected at each instant of the life of a taxon is finite and, perhaps more important, that the selective forces acting on the taxon may not be constant throughout its evolution

[12,13]. Over the long term (periods of environmental change, including the intracellular environment), the accumulation of small changes will not generally correspond to the smallest possible set of changes consistent with the observed final sequences. Nevertheless, it is plausible to believe, at least for well-conserved molecular regions where mutations are reasonably rare and unlikely to have occurred repeatedly at any given variant locus, that the process of approximating small changes with smallest changes could provide a good approximation to the true evolutionary process of the observed set of taxa

[14]. Such an assumption is likely to be reasonable, for example, in intraspecies phylogenetics, where few generations have elapsed since the observed taxa shared a common ancestor and thus the expected number of mutations per locus is much less than one. When such assumtions hold, a phylogeny of

H is defined to be optimal under the parsimony criterion if it satisfies the following requirements: (i) it has the shortest length, i.e., the minimum sum of the edge weights, and (ii) it is such that, for each pair of distinct haplotypes

hi,hj∈H, the sum of the edge weights belonging to the path from hi to hj in T∗ is not smaller than the observed number of changes between hi and hj[11]. The first condition imposes the assumption that the smallest number of mutations consistent with the observed sequences is a good approximation to the true accumulated set of mutations; the second condition correlates the edge weights to the observed data.

The parsimony assumption can be considered accurate in the limit of low mutation rates or short time scales, making it a reasonable model for situations such as analysis of intraspecies variation where little time is presumed to have elapsed since the existence of a common ancestor of all observed taxa. Maximum parsimony also remains valuable as a model for novel methodology development in phylogenetics because of its relative simplicity and amenity to theoretical analysis. Novel computational strategies, such as those developed in this paper, might therefore productively be developed and analyzed in the context of maximum parsimony before being extended to more complicated models of phylogenetics.

Finding the phylogeny that satisfies the parsimony criterion involves solving a specific version of the PEP, called the Most Parsimonious Phylogeny Estimation Problem (MPPEP). Some of the variants of the MPPEP, see e.g.,

[15,16], can be solved in polynomial time, however, in the most general case, the problem is

NP-hard

[11,17] and this fact has justified the development of a number of exact and approximate solution approaches, such those described in

[11,17,18]. Some recent versions of the MPPEP, such as the Most Parsimonious Phylogeny Estimation Problem from SNP haplotypes (MPPEP-SNP) investigated in this article, play a fundamental role in providing predictions of practical use in several medical bioinformatics applications, such as disease association studies

[19] or reconstruction of tumor phylogenies

[20,21]. In these contexts, it would be highly desirable to have the most accurate inferences possible for specific applications, but this in turn would imply to have algorithms able to exactly solve instances of such versions. As regards the MPPEP-SNP, the literature describes some (rare) circumstances for which it is possible to solve the problem in polynomial time (see Section Methods). Unfortunately, in the general case the MPPEP-SNP is

NP-hard and solving provably to optimality therefore generally requires the use of exact approaches based on implicit enumeration algorithms, similar to the mixed integer programming strategies described in

[1,2,22].

In this article, we explore the prospects for improving on the implicit enumeration strategy of

[1,2] using a novel problem formulation and a series of additional constraints to more precisely bound the solution space and accelerate implicit enumeration of possible optimal phylogenies. We present a formulation for the problem based on an adaptation of

[23]’s mixed integer formulation for the Steiner tree problem extended with a number of preprocessing techniques and reduction rules to further decrease its size. We then show that it is possible to exploit the high symmetry inherent in most instances of the problem, through a series of strengthening valid inequalities, to eliminate redundant solutions and reduce the practical search space. We demonstrate through a series of empirical tests on real and artificial data that these novel insights into the symmetry of the problem often leads to significant reductions in the gap between the optimal solution and its non-integral linear programming bound relative to the prior art as well as often substantially faster processing of moderately hard problem instances. More generally, the work provides an indication of the conditions under which such an optimal enumeration approach is likely to be feasible, suggesting that these strategies are usable for relatively large numbers of taxa, although with stricter limits on numbers of variable sites. The work thus provides methodology suitable for provably optimal solution of some harder instances that resist all prior approaches. In future work, it may provide useful guidance for strategies and prospects of similar optimization methods for other variants of phylogeny inference.

Problem 2

The Most Parsimonious Phylogeny Estimation Problem from SNP haplotypes (MPPEP-SNP).Given a set

H of n haplotypes having m alleles each, find the minimum cardinality haplotype set

H′ to be added to

H so that the phylogeny

T¯⋆ has minimum length.

If the haplotype set

H′ is empty, i.e., if

G=(H,E) is connected, then MPPEP-SNP can be solved in polynomial time as the minimum spanning tree is a (optimal) solution to the MPPEP-SNP. Similarly, if the input haplotype set

H satisfies the perfect phylogeny condition i.e., the requirement that each allele changes only once throughout the optimal phylogeny (see

[19]), then the MPPEP-SNP can be still solved in polynomial time

[26-28]. Unfortunately, it is possible to prove that in the general case the MPPEP-SNP is

NP-hard (see

[1,22]). In fact, the binary nature of the SNP haplotypes allows us to interpret a generic haplotype

hi∈H as a vertex of a m-dimensional unit hypercube, its s-th allele as the s-th coordinate of the vertex hi, and the set

H′ as the set of Steiner vertices of the unit hypercube. Hence the MPPEP-SNP can be seen as particular case of the Steiner tree problem in a graph, a notorious

NP-hard combinatorial optimization problem

[29].

Finding the optimal solutions to the MPPEP-SNP is fundamental to validating the parsimony criterion, i.e., to verify whether, for a given instance of MPPEP-SNP, the results predicted by the criterion match the experimental ones. Unfortunately, the

NP-hardness of the MPPEP-SNP limits the size of the instances analyzable to the optimum, which in turn affects the ability to validate the parsimony criterion, hence the practical utility of the predictions themselves. In order to address this concern, in the following section we shall develop an integer programming model able to provide optimal solutions to real instances of the MPPEP-SNP.

Formulation 1

Basic Model

(1a)min∑i,j∈V:i≠j∑s∈Szijs

(1b)s.t.xis=hi(s)∀s∈S,i∈H

(1c)xis≤ui∀s∈S,i∈V

(1d)zijs≥+xis−xjs+yij−1∀s∈S,i,j∈V:i≠j

(1e)zijs≥−xis+xjs+yij−1∀s∈S,i,j∈V:i≠j

(1f)∑s∈Szijs=yij∀i,j∈V:i≠j

(1g)yij≤ui∀i,j∈V:i≠j

(1h)yij≤uj∀i,j∈V:i≠j

(1i)∑j∈V:i≠jyij≥ui∀i∈V

(1j)∑i,j∈C:i≠jyij≤∑i∈Cui−1∀C⊂V:C∩VH≠∅

(1k)∑i,j∈V:i≠jyij=∑i∈Vui−1

(1l)∑i∈Qui=n+LB

(1m)ui,xis,zijs,yij∈{0,1}.

The objective function (1a) aims at minimizing the length of the optimal phylogeny. Constraints (1b) impose that the coordinates of the first n vertices in V are exactly the ones of the input haplotype set

H. Constraints (1c) impose that the s-th coordinate of vertex ui, i ∈ V, can assume value 1 only if vertex ui is considered in the optimal solution to the problem. Constraints (1d)-(1e) force variables

zijs to be one if in the optimal solution to the problem there exist a pair of adjacent vertices ij ∈ V having a different value at the s-th coordinate. Constraints (1f) impose that in an optimal solution to the problem two distinct vertices ij ∈ V can be adjacent only if

dhihj=1. Constraints (1g)-(1h) impose that in the optimal solution to the problem variable yij may assume value 1 only if both vertices i and j are considered. Vice versa, constraints (1i) impose that if in the optimal solution to the problem a vertex ui, i ∈ V, is considered then at least one variable yij must assume value 1. Constraints (1j) and (1k) impose the Generalized Subtour Elimination Constraints (GSEC)

[23]. Finally, constraints (1l) impose that the first n + LBvertices in V have to be considered in the optimal solution to the problem.

Note that Formulation 1 can be easily extended to the case in which the haplotypes are represented by multi-character data, i.e., sequences over an alphabet Σ = {0,1,2,…,γ}. In fact, in such a case it is sufficient to replace each character c in the haplotype by a binary γ -vector ν such that the s-th coordinate of ν is equal to 1 if the character c is equal to s, s ∈ Σ, and 0 otherwise. For example, if the generic haplotype were, for example, the string 〈AACGT〉, then it could be represented as 〈1000 1000 0100 0010 0001〉.

Formulation 2

Reduced Model

(2a)min∑i,j∈V:i,j∈Z∑s∈Ŝwszijs

(2b)s.t.xis≤ui∀s∈Ŝ,i∈R

(2c)∑s′∈Ŝ:s′≠szijs′+hi(s)−xjs≤1∀s∈Ŝ,i∈VH,j∈VH′

(2d)∑s′∈Ŝ:s′≠szijs′−hi(s)+xjs≤1∀s∈Ŝ,i∈VH,j∈VH′

(2e)∑s′∈Ŝ:s′≠szijs′+xis−xjs≤1∀s∈Ŝ,i,j∈VH′:i,j∈Z

(2f)∑s′∈Ŝ:s′≠szijs′−xis+xjs≤1∀s∈Ŝ,i,j∈VH′:i,j∈Z

(2g)∑s∈Ŝzijs≤1∀i,j∈V∖R:i,j∈Z

(2h)∑s∈Ŝzijs≤ui∀i∈R,j∈V:i,j∈Z

(2i)∑s∈Ŝzijs≤uj∀j∈R,i∈V:i,j∈Z

(2j)∑j∈V:j∈Z∑s∈Ŝzijs≥1∀i∈Q

(2k)∑j∈V:j∈Z∑s∈Ŝzijs≥ui∀i∈R

(2l)∑i,j∈C:i,j∈Z∑s∈Ŝzijs≤∑i∈C:i∈Rui+|CH|−1∀C⊂V:C∩VH≠∅

(2m)∑i,j∈V:i,j∈Z∑s∈Ŝzijs=n+LB+∑i∈Rui−1

(2n)ui,xis,zijs,yij∈{0,1}.

Note that in Formulation 2 variables

xis and

zijs cannot be relaxed anymore.

Proposition 1

Constraints

(3)ui+1≤ui∀i∈V∖(Q∪{n+UB})

are valid for Formulation 2.

Proof

In a feasible solution to the problem variable ui, i ∈ V∖(Q ∪ {n + UB}), can assume only value 0 or 1. If ui = 0, constraint (3) reduces to ui + 1 ≤ 0 which is trivially valid for Formulation 2. If ui = 1, constraint (3) reduces to ui + 1 ≤ 1 which is again valid.

Constraints (3) impose an ordering on the variables ui, i ∈ R, so that vertex ui + 1 can be considered in the optimal solution to the problem only if vertex ui has been already considered.

Proposition 2

Constraints

(4)∑j∈V:j∈Z∑s∈Ŝzijs≥2ui∀i∈R

are valid for Formulation 2.

Proof

In a feasible solution to the problem a vertex ui,

i∈VH′, cannot be a terminal vertex. In fact, if such a condition held, a cheaper solution could be obtained by dropping ui from

T¯⋆, contradicting the optimality of

T¯⋆ itself. Hence, the degree of any vertex in

VH′ must be at least 2. Now, in a feasible solution to the problem variables ui ∈ {0,1}. If ui = 0, constraint (4) reduces to

∑j∈V:j∈Z∑s∈Ŝzijs≥0

which is trivially valid. Vice versa, if ui = 1, constraint (4) reduces to

∑j∈V:j∈Z∑s∈Ŝzijs≥2

which is again valid for the above arguments.

Proposition 3

Constraints

(5)+xis2−xjs2≤2(1−zijs1)−∑s∈Ŝ:s≠s1zijs∀s1,s2∈Ŝ:s1≠s2,i,j∈VH′:i,j∈Z

(6)−xis2+xjs2≤2(1−zijs1)−∑s∈Ŝ:s≠s1zijs∀s1,s2∈Ŝ:s1≠s2,i,j∈VH′:i,j∈Z

are valid for Formulation 2.

Proof

As observed in the previous proposition, in a feasible solution to the problem

∑s∈Ŝzijs,

i,j∈VH′, i,j∈Z, can assume only value 0 or 1. If

∑s∈Ŝzijs=0, then constraint (5) (respectively constraint (6)) reduces to

+xis2−xjs2≤2 (respectively

−xis2+xjs2≤2), which is trivially valid due to the integrality of variables

xis. If

∑s∈Ŝzijs=1, then either

∑s∈Ŝ:s≠s1zijs=1 or

zijs1=1. If

∑s∈Ŝ:s≠s1zijs=1 then constraint (5), (respectively constraint (6)) reduces to

+xis2−xjs2≤1 (respectively

−xis2+xjs2≤1), which is trivially valid. If

zijs1=1 then constraint (5) (respectively constraint (6)) reduces to

+xis2−xjs2≤0 (respectively

−xis2+xjs2≤0), which is again valid.

Similar arguments can be used to prove the following proposition:

Proposition 4

Constraints

(7)+hi(s2)−xjs2≤2(1−zijs1)−∑s∈Ŝ:s≠s1zijs∀s1,s2∈Ŝ:s1≠s2,i∈VH,j∈VH′

(8)−hi(s2)+xjs2≤2(1−zijs1)−∑s∈Ŝ:s≠s1zijs∀s1,s2∈Ŝ:s1≠s2,i∈VH,j∈VH′

are valid for Formulation 2.

Given an input haplotype set

H and a pair of non-adjacent haplotypes hi and hj, there exit multiple equivalent paths that may connect hi and hj in the unary hypercube. This characteristic constitutes the principal class of symmetries for the MPPEP-SNP and may lead to poor relaxations for the problem. For example, suppose that the input haplotype set

H is constituted by haplotypes h1 = 〈00〉 and h2 = 〈11〉. Then a possible solution to the instance may consist either of a star centered in haplotype h3 = 〈10〉 or a star centered in haplotype h3 = 〈01〉(see Figure

1). Note that both solutions are feasible and optimal for the specific instance. A possible strategy to break this class of symmetries consists of imposing the following constraints:

Proposition 5

Constraints

(9)∑p=1s2s−pxip≤∑p=1s2s−pxi+1p∀s∈Ŝ,i∈VH′∖R

(10)∑p=1s2s−pxip≤∑p=1s2s−pxi+1p+∑p=1s2s−p(1−ui+1)∀s∈Ŝ,i∈R∖{n+UB}

are valid for Formulation 2.

Proof

The statement trivially follows from the integrality of variables

xis and from constraints (2b).

Constraints (9)-(10) impose an ordering on the coordinates of the vertices in

VH′ by means of the smallest big-M possible, i.e., a power of 2. Note that the distinction between constraints (9) and (10) is necessary, as in principle vertices in R may not be needed in the optimal solution to the problem.

Proposition 6

Constraints

(11)∑j∈V:j∈Z∑s∈Ŝzijs≥∑j∈V:j∈Z∑s∈Ŝz(i+1)js∀i∈VH′∖{n+UB}

are valid for Formulation 2.

Proof

In a feasible solution to the problem, the sum

∑s∈Ŝzijs,

i,j∈VH′, i,j∈Z, can assume only value 0 or 1. If

∑j∈V:j∈Z∑s∈Ŝz(i+1)js=0, constraint (11) reduces to

∑j∈V:j∈Z∑s∈Ŝzijs≥0 which is trivially valid. Vice versa, If

∑j∈V:j∈Z∑s∈Ŝz(i+1)js=1, constraint (11) reduces to

∑j∈V:j∈Z∑s∈Ŝzijs≥1 which is again valid due to Propositions 1 and 2. □

Proposition 6 forces vertices in

VH′ to be sorted according to a decreasing degree order. In this way, it is possible to avoid the occurrence of symmetric solutions to the problem differing just for the degree of the Steiner vertices (see e.g., Figure

2).

Let

Q3={i,j∈VH:dij≥3} and k ∈ V, k ∉ Q3. Then the following proposition holds:

Proposition 7

Constraints

(12)∑s∈Sziks+∑s∈Szkjs≤1∀i,j∈Q3

are valid for Formulation 2.

Proof

In a feasible solution to the problem the path between two distinct haplotypes

hi,hj∈H cannot be shorter than the distance

dhihj. Hence, if the distance between hiand hjis greater or equal to three, vertices i and j cannot be adjacent to a same vertex k, i.e., only one of the two sums

∑s∈Sziks or

∑s∈Szjks can be equal to 1. □

Note that if k ∈ R then (12) can be strengthened by replacing the right-hand-side by uk. Moreover, Proposition 7 can be generalized as follows. Consider the sets

Qd={i,j∈VH:dij≥d}, d ∈ {3,4,…,m}, C ⊂ V such that 2 ≤ |C| ≤ d − 1 and C ∩ Qd = ∅, and a path p that involves only vertices in C. Denote pk the k-th vertex in p. Then the following proposition holds:

Proposition 8

The family of constraints

(13)∑s∈Szip1s+∑k=1|C|−1∑s∈Szpkpk+1s+∑s∈Szp|C|js≤|C|∀i,j∈Kd,

called forbidden path constraints, are valid for Formulation 2.

Proof

Similarly to Proposition 7, in a feasible solution to the problem the path p between two distinct haplotypes

hi,hj∈H cannot be shorter than the distance

dhihj. Hence, if the distance between hi and hj is greater or equal to d, at most |C| vertices can belong to p. □

Implementation

We implemented Formulations 1 and 2 by means of Mosel 64 bit 3.2.0 of Xpress-MP, Optimizer version 22, running on a Pentium 4, 3.2 GHz, equipped with 2 GByte RAM and operating system Gentoo release 7 (kernel linux 2.6.17). In both formulations, we computed the overall solution time to solve a generic instance of the problem as the sum of the preprocessing time due to the implementation of

[22]’s reduction rules plus the solution time taken by the Optimizer to find the optimal solution to the instance. In preliminary experiments, we observed that Formulation 2 has two main advantages with respect to Formulation 1, namely: it requires much less memory to load the model (at least 27% RAM less in the analyzed instances) and it is characterized by faster linear relaxations at each node of the search tree. As result, Formulation 2 allows potentially the analysis of larger instances than Formulation 1 and may be characterized by faster solution times. Hence, we preferred to use Formulation 2 in our experiments.

We considered two different implementations of Formulation

2, namely: the GESC-based Reduced Model

(GSEC-RM) and the Flow-based Reduced Model (Flow-

RM). The GESC-RM consists of Formulation 2 strengthened

by the valid inequalities previously described. The

Flow-RM consists of Formulation 2 strengthened by the

valid inequalities and such that the GSEC are replaced

by a multi-commodity flows. Specifically, by denoting

fijq

as a decision variable equal to one if there exists a flow

from vertex 1 to vertex

q∈VH

passing through edge

(i,j∈E¯

and 0 otherwise, the Flow-RM can be obtained by replacing constraints

2l) with:

(14)fjiq+fijq≤∑s∈Szijs∀q∈VH:q≠1,i,j∈V:i,j∈Z

(15)∑i∈V:i≠1f1iq=1∀q∈VH:q≠1

(16)∑j∈V:i≠jfijq−∑j∈V:i≠jfjiq=0∀q∈VH:q≠1,i∈V:i∉{1,q}

(17)∑i∈V:i≠qfiqq−∑i∈V:i≠qfqiq=1∀q∈VH:q≠1

(18)fijq≥0∀q∈VH:q≠1,i,j∈V:i,j∈Z.

In preliminary experiments we observed that the Flow-RM outperforms the GESC-RM in terms of solution time. This fact is mainly due to the computational overhead introduced by the GSEC separation oracle which seems to be not compensated by the size of the analyzed instances. Hence, we did not consider the GESC-RM any further in our experiments.

During the runtime, we enabled the Xpress-MP automatic cuts and the Xpress-MP pre-solving strategy. Moreover, we also tested a number of generic primal heuristics for the Steiner tree problem to generate a first primal bound to the MPPEP-SNP (see, e.g.,

[34]). Unfortunately, in preliminary experiments we observed that the use of such heuristics interferes negatively with the Xpress Optimizer, by delaying the solution time of the analyzed instances. Hence, we disabled the used of the generic primal heuristics and enabled the use of the Xpress-MP primal heuristic instead. The source code of the algorithm can be downloaded at

http://homepages.ulb.ac.be/~dacatanz/Site/Software_files/iMPPEP.zip.

Separation oracle for the forbidden path constraints

When using the Flow-RM, the valid inequalities (3)-(12) are loaded together with the reduced model. On the contrary, the valid inequalities (13) are dynamically generated by means of a separation oracle working as follows. Before loading the reduced model, we precompute the sets Qd, for all d ∈ {3,4,…,m}. Let

(u¯,x¯,z¯) be the current fractional solution at a given node of the search tree and, for all d ∈ {3,4,…,m}, consider a pair of vertices i,j∈Qd. Then, the forbidden path constraints (13) are violated if there exists a path p having internal vertices in C ⊂ V, 2 ≤ |C| ≤ d − 1, C ∩ Qd = ∅, and such that

(19)∑s∈Sz¯ip1s+∑k=1|C|−1∑s∈Sz¯pkpk+1s+∑s∈Sz¯p|C|js>|C|.

Note that searching for the most violated constraint (19) is in general

NP-hard as it involves solving a longest path problem on the weighted graph

G¯z¯V∖Qd, i.e., the graph

G¯ whose edges are weighted by variables

z¯ and whose vertex set is restricted to (V∖Qd) ∪ {i,j}. In order to have a fast separation oracle for the forbidden path constraints we do not solve exactly (19) but we use a heuristic approach instead. Specifically, we first sort edges of

E¯ in decreasing order according to their weights and we select two distinct vertices v1,v2 ∈ V∖Qd such that edge (v1,v2) has the largest weight. Subsequently, we set C = {v1,v2}, mark v1 and v2 as visited, and build a simple path from vertex i to vertex j passing by v1 and v2. If p is such that (19) is satisfied then we add the constraint

(20)∑s∈Szip1s+∑k=1|C|−1∑s∈Szpkpk+1s+∑s∈Szp|C|js≤|C|

to the formulation; otherwise, we select a different pair of vertices in V∖Qd and iterate this procedure until either 10 distinct paths have been generated or all possible pairs of vertices in V∖Qd have been selected. If all vertices have been selected but less than 10 distinct paths have been generated, then we select a larger subset of V∖Qd (e.g., a triplet of vertices) and we iterate again the previous steps. It is easy to realize that this procedure may potentially generate all the possible paths violating (13). However, we stop the procedure after generating 10 paths or after considering subset C containing more than 5 vertices as we observed in preliminary experiments that this strategy provides the best trade-off between speed and tightness of the cut.

Branching strategies

In preliminary experiments we observed that the standard branching strategy implemented in the Xpress-MP Optimizer is not appropriate for the problem as it is not able to exploit the dissimilarity of the weights ws in the objective function. This inconveniently leads to formulations characterized by slow solution times. To improve this aspect we implemented a different strategy consisting of branching on the following constraints:

(21)∑i,j∈V:i,j∈Zzijs≤α∀s∈S

or

(22)∑i,j∈V:i,j∈Zzijs>α,∀s∈S

where α ∈ {1,2,…,q} and

q=min{∑k∈VHhk(s),n/2}. Constraints (21)-(22) limit the number of changes along a phylogeny with respect to a given coordinate

s∈S and tend to be more effective when the weights ws are very dissimilar among them. This branching strategy can be implemented by introducing a decision variable

βαs=1if the overall number of changes at coordinates∈SofT¯⋆is equal toα0otherwise,

for all

s∈S and α ∈ {1,2,…,q}, and by adding the following constraints

∑i,j∈V:i,j∈Zzijs=∑α=1qβαs∀s∈S∑α=1qβαs=1∀s∈S.

We observed that even better runtime performance can be obtained by sorting the coordinates of the input haplotypes in decreasing way according to the weights ws and by branching first on variables

βαs, then on variables ui, and subsequently on variables

xis and finally on variables

zijs.

Performance analysis

In order to obtain a measure of the performance of the Flow-RM, we compared

[1]’s polynomial-size formulation versus the Flow-RM on

[1]’s real instances of the MPPEP-SNP, namely: Human chromosome Y constituted by 150 haplotypes having 49 SNPs each; bacterial DNA constituted by 17 haplotypes having 1510 SNPs each; Chimpanzee mitochondrial DNA constituted by 24 haplotypes having 1041 SNPs each; Chimpanzee chromosome Y constituted by 24 haplotypes having 1041 SNPs each; and a set of four Human mitochondrial DNA from HapMap

[35] constituted by 40 haplotypes having 52 SNPs each, 395 haplotypes having 830 SNPs each, 13 haplotypes having 390 SNPs each, and 44 haplotypes having 405 SNPs each, respectively. Such instances consist only of non-recombining data (Y chromosome, mitochondrial, and bacterial DNA) and can be downloaded at

http://homepages.ulb.ac.be/~dacatanz/Site/Software_files/iMPPEP.zip.

Table

1 shows the results obtained by such comparison. Specifically, the fourth and fifth columns refer to the gaps (expressed in percentage) of the respective formulations, i.e., to the difference between the optimal value to a specific instance and the value of linear relaxation at the root node of the search tree, divided by the optimal value. The table shows that, excluding the cases in which the solution to a specific instance was trivially a minimum spanning tree (see e.g., Human chromosome Y, Chimpanzee mtDNA, and Chimpanzee chromosome Y), the Flow-RM is always characterized by (sometimes dramatically) smaller gaps. This fact derives on the one hand from the tightness of the Flow-RM with respect to

[1]’s polynomial-size formulation and on the other hand from the efficiency of the strengthening valid inequalities previously described. The poor relaxations of their formulation led

[1] to propose an alternative and faster exact approach to solution of the MPPEP-SNP based on the brute-force enumeration of all possible Steiner vertices necessary to solve a specific instance of the problem. To speed up the computation, the brute-force enumeration algorithm makes use of a set of reduction rules based on Buneman graph enumeration to decrease the number of Steiner vertices to be considered. Interestingly, despite the differences in terms of implementation language between the two programs (namely, Mosel for the Flow-RM and C++ for

[1]’s brute-force enumeration algorithm), the Flow-RM proved to be competitive with

[1]’s enumeration algorithm, being able to solve almost all the considered instances within 1 second computing time. Only in two cases, namely Human mtDNA 40×52 and Human mtDNA 395×830, the Flow-RM needed more than 5 minutes to find the corresponding optimal solutions. The deterioration of the runtime performance in those instances is mainly due to the overhead necessary to load the formulation (that in both cases is considerably bigger than in the other instances) and to an intensive use of the separation oracle for the forbidden path constraints. Possibly, a more thorough implementation of the separation oracle and the use of more performing languages (e.g., C++) could help in speeding up computations in those instances at least.

Interestingly, sometimes in real applications the number of haplotypes can be much bigger than the number of SNPs. Hence, it is important to test the ability of an exact algorithm to tackle instances of the MPPEP-SNP containing e.g., hundreds haplotypes.

[1] observed that their brute force enumeration algorithm is able to tackle instances of the problem containing up to 270 haplotypes having up to 9 SNPs each within 12 hours computing time. Unfortunately, the authors also observed that their algorithm is unable to solve larger instances of the MPPEP-SNP, no matter the maximum runtime considered. In this context, the Flow-RM makes the difference, being able to tackle instances of the MPPEP-SNP having up to 300 haplotypes and 10 SNPs within 3 hours computing time. To show this result, we considered a number of random instances of the problem containing 100, 150, 200, 250, and 300 haplotypes, respectively. Fixing the number of haplotypes n∈{100,150,200,250,300}, we created an instance of the problem by generating at random n strings of length 10 over the alphabet Σ={0,1}. During the generation process, we randomly selected the number of SNPs equal to 1 in a given haplotype, and subsequently we randomly chose the sites of the haplotype to be set to 1. We iterated the instance generation process 10 times for a fixed value of n, obtaining eventually an overall number of 50 random instances of the MPPEP-SNP downloadable at

http://homepages.ulb.ac.be/~dacatanz/Site/Software_files/iMPPEP.zip.

The results obtained in our experiments are shown in Table

2. Specifically, the column “Time” refers to the solution time (expressed in seconds) necessary to solve exactly a specific instance of the MPPEP-SNP. Analogously, the column “Nodes” refers to the number of explored nodes in the search tree needed to solve exactly the instance. The table does not report on the performance of

[1]’s enumeration algorithm, as their algorithm never found the optimal solution to the analyzed instances within the limit runtime of 3 hours. As a general trend, the table shows that the considered instances can be exactly solved within 1 hour computing time. The only exceptions are constituted by the 7th instance of the group 150×10, the 9th instance of the group 200×10, the 2th instance of the group 250×10, and 3th instance of the group 300×10which needed 8719.65, 4600.69, 7757.98, and 5371.05 seconds, respectively, to be solved. These instances are much more sparse than the others, are characterized by smaller reduction ratios, and tend to have more degenerate relaxations than the other instances. The presence of these factors might explain the loss of performance of the Flow-RM.

The results showed that the integrality gaps are usually very low, ranging from 0% to 4.63% and assuming in average a value about 1%, confirming once again the tightness of the Flow-RM and the efficiency of the strengthening valid inequalities.

Finally, we also tested the performance of the Flow-RM on a set of 5 HapMap Human mitochondrial DNA instances of the MPPEP-SNP that were not solvable by using

[1]’s brute-force enumeration algorithm, namely: f1 constituted by 63 haplotypes having 16569 SNPs each, i2 constituted by 40 haplotypes having 977 SNPs each, k3 constituted by 100 haplotypes having 757 SNPs each, m4 constituted by 26 haplotypes having 48 SNPs each, and p5 constituted by 21 haplotypes having 16548 SNPs each. Such instances can be downloaded at the same address and consist only of non-recombining data (Y chromosome, mitochondrial, and bacterial DNA).

A part from m4, all the remaining instances gave rise to too large formulations (several hundreds Mbytes RAM) to be handled by the Xpress Optimizer. Hence, instead of analyzing entirely each instance we decomposed it into contiguous SNP blocks and analyzed the most difficult block separately. In more in detail, we define

Hr to be the haplotype matrix obtained by the application of

[1]’s reduction rules, we sorted the columns of

Hr according to an increasing ordering of the weights ws,

s∈Ŝ; subsequently, we considered the submatrices obtained by taking k contiguous SNPs (or k-block) in

Ŝ,k ∈ {10,13,15}. We did not consider greater values for k as we observed that k = 15 was already a threshold after which the haplotype submatrix gave rise to too large formulations. For each k-block

B in

Hr we considered the hamming distance

dhihj=∑s∈B|hi(s)−hj(s)| between each pair of distinct haplotypes in

Hr, and chose the k-block maximizing the sum

∑hi,hj∈Hr,hi

Table

3 shows the results obtained in our experiments. As for Table

2, the columns “Time” and “Nodes” refer to the solution time (expressed in seconds) and to the number of nodes in the search tree necessary to solve exactly a specific instance of the MPPEP-SNP, respectively. In such a case, the values in the columns “Gap” refers to the gap between the best primal bound found within the limit time and the root relaxation and “Nodes” refers to the number of nodes explored in the tree search within the limit time.

Table

3 shows that, apart from the instances f1 and m4, the Flow-RM was unable to exactly solve, within the limit time, the considered instances for values of k ∈ {13,15}. Specifically, The Flow-RM exactly solved in less than a minute the instance f1 when considering values of k ∈ {10,13} ; in 20 minutes the instance i2 when considering k = 10 ; in less than 3 minutes the instance k3 when considering k = 10; and the instance m4 in 5 seconds. In contrast, the Flow-RM was unable to solve the instance p5, regardless of the value of k considered. In fact, already when considering k = 10, the Xpress Optimizer took more than 12 hours to exactly solve the instance p5 and explored over 10 million nodes in the search tree. A more detailed analysis of the instance showed that, despite the presence of the strengthening valid inequalities, p5 is characterized by highly fractional relaxations. This fact implies the existence of equivalent optimal solutions to the instance that, on the one hand, delay the finding of a primal bound and, on the other hand, force the Optimizer to explore many more nodes in the tree search. This situation in more pronounced in p5 but also occurs in the instances i2 and k3. To improve the tightness of the formulation we tried to include in the Flow-RM also classical facets and strengthening valid inequalities for the Steiner tree problem in a graph (see

[23,36-38]). However, we did not observe any benefit from the inclusion. We suspect that the presence of highly fractional solutions to the problem could be caused both by poor lower bounds on the number of Steiner vertices considered in the Flow-RM and by the existence of a number of non trivial classes of symmetries still present in the problem. Investigating such issues warrants future research efforts.

In order to measure the performance of the model on multi-state character data we also considered

[2] set of instances of the MPPEP-SNP. Specifically, we considered the following instances: a set of 41 sequences of O.rufipogon DNA (red rice) having 1043 sites each; 80 human mtDNA sequences having 245 sites each; 50 HIV-1 reverse transcriptase amino acid sequences having 176 sites each; a set of 500 sequences of mtDNA from the NCBI BLASTN best aligned taxa having 3000 sites each; a set of 500 sequences of mtDNA from the NCBI BLASTN best aligned taxa having 5000 sites each; and a set of 500 sequences of mtDNA from the NCBI BLASTN best aligned taxa having 10000 sites each. When running the same experiments described in

[2] we registered a very poor performance for the Flow-RM, mainly due to the large dimension of the considered instances and the presence of symmetries despite the use of constraints (13)-(15). We observed that the combination of these two factors increased the runtime performance of the Flow-RM of 2-3 orders of magnitude with respect to

[2] approach. However, we also observed that when performing

[2]’s “window analysis” (i.e., when decomposing into blocks of 10 SNPs the input matrix) the Flow-RM performed better than

[2]’s, being characterized by an average solution time of 8.27 seconds. This fact suggests that, when considering instances constituted by less than a dozen sites, an exact approach entirely based on integer programming may perform better than the implicit enumeration of the vertices of the generalized Buneman graph. Vice-versa, for larger instances the implicit enumeration of the vertices of the generalized Buneman graph appears more suitable.

Conclusion

In this article we investigated the Most Parsimonious Phylogeny Estimation Problem from Single Nucleotide Polymorphism (SNP) haplotypes (MPPEP-SNP), a recent version of the phylogeny estimation problem that arises when input data consist of SNPs extracted from a given population of individuals. The MPPEP-SNP is

NP-hard and this fact has justified the development of exact and approximate solution approaches such as those described in

[1,19,22,26-28]. We explored the prospects for improving on the strategy of

[1,2] using a novel problem formulation and a series of additional constraints to more precisely bound the solution space and accelerate implicit enumeration of possible optimal phylogenies. We present a formulation for the problem based on an adaptation of

[23]’s mixed integer formulation for the Steiner tree problem extended with a number of preprocessing techniques and reduction rules to further decrease its size. We then show that it is possible to exploit the high symmetry inherent in most instances of the problem, through a series of strengthening valid inequalities, to eliminate redundant solutions and reduce the practical search space. We demonstrate through a series of empirical tests on real and artificial data that these novel insights into the symmetry of the problem often leads to significant reductions in the gap between the optimal solution and its non-integral linear programming bound relative to the prior art as well as often substantially faster processing of moderately hard problem instances. More generally, the work provides an indication of the conditions under which such an optimal enumeration approach is likely to be feasible, suggesting that these strategies are usable for relatively large numbers of taxa, although with stricter limits on numbers of variable sites. The work thus provides methodology suitable for provably optimal solution of some harder instances that resist all prior approaches. Our results may provide also useful guidance for strategies and prospects of similar optimization methods for other variants of phylogeny inference. In fact, if appropriately adapted, some of the results we presented here (e.g., symmetry breaking strategies) can be generalized with respect to other phylogenetic estimation criteria (e.g., the likelihood criterion) and provide important computational benefits.

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

The authors equally contributed to conceive the work and write the article. DC implemented the algorithms and performed computations. All authors read and approved the final manuscript.