Next Article in Journal
Spatially Adaptive Regularization in Image Segmentation
Next Article in Special Issue
A Brain-Inspired Hyperdimensional Computing Approach for Classifying Massive DNA Methylation Data of Cancer
Previous Article in Journal / Special Issue
A Survey on Shortest Unique Substring Queries
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Linear-Time Algorithm for the Isometric Reconciliation of Unrooted Trees

by
Broňa Brejová
* and
Rastislav Královič
*
Department of Computer Science, Faculty of Mathematics, Physics, and Informatics, Comenius University, Mlynská dolina, 842 48 Bratislava, Slovakia
*
Authors to whom correspondence should be addressed.
Submission received: 15 July 2020 / Revised: 28 August 2020 / Accepted: 4 September 2020 / Published: 8 September 2020
(This article belongs to the Special Issue Algorithms in Bioinformatics)

Abstract

:
In the reconciliation problem, we are given two phylogenetic trees. A species tree represents the evolutionary history of a group of species, and a gene tree represents the history of a family of related genes within these species. A reconciliation maps nodes of the gene tree to the corresponding points of the species tree, and thus helps to interpret the gene family history. In this paper, we study the case when both trees are unrooted and their edge lengths are known exactly. The goal is to root them and to find a reconciliation that agrees with the edge lengths. We show a linear-time algorithm for finding the set of all possible root locations, which is a significant improvement compared to the previous O ( N 3 log N ) algorithm.

1. Introduction

Reconciliation of gene trees and species trees is a computational problem arising in evolutionary biology that has been studied since 1979 [1]. Here, we concentrate on a variant proposed by Ma et al. [2,3], called isometric reconciliation. We provide a linear-time algorithm for reconciling two unrooted trees, which is a significant improvement over the previous O ( N 3 log N ) algorithm [4].
A species tree represents an evolutionary history of a group of species. Present-day species are typically placed in the leaves, and internal nodes correspond to speciation events. Speciation is a process in which individuals of a single species separate into two groups that further evolve independently.
A gene tree represents an evolutionary history of a group of related genes from several species. In the simplest scenario, each individual has a single copy of a particular gene, and these genes are propagated along the species tree, yielding the gene tree identical to the species tree. However, during evolution, a gene can be lost (deleted), and it can also become duplicated, whereupon a particular species and its descendants have multiple copies of the gene. After a series of such duplication and deletion events, the gene tree and the species tree will differ. In a gene tree, the leaves represent copies of the gene in the present-day species and the internal nodes represent speciations and duplications. Lost gene copies are not represented in gene trees.
The goal of reconciliation is to map nodes of a gene tree to the corresponding points in a species tree that represent the same points in the evolutionary history. This mapping helps to distinguish whether a node of a gene tree corresponds to a speciation or a duplication and to estimate the number of deletions (see an example in Figure 1).
Note that gene trees and species trees representing evolutionary histories are rooted, with the root representing the last common ancestor of all the leaves. However, trees are in practice constructed from DNA or protein sequences, and many commonly used methods are unable to determine the root location, so instead provide only an unrooted version of the tree [5].
In the isometric reconciliation, both trees have known edge lengths and the reconciliation has to obey these lengths (see an example in Figure 2). The problem was introduced by Ma et al. [2,3], who provided a polynomial-time algorithm for reconciling an unrooted gene tree with a rooted species tree. Brejová et al. [4] have provided a corrected and improved version of this algorithm, which runs in O ( N log N ) time, where N is the total number of nodes in the two trees combined. The authors also provided algorithms for several variants of the problem, including an O ( N 5 log N ) -time algorithm to compute all reconciliations of two unrooted trees. In this paper, we improve this running time to O ( N ) for gene trees with node degrees bounded by O ( 1 ) (typically, unrooted phylogenetic trees have internal nodes of degree three). To achieve this time, we only output pairs of valid root locations in the two trees instead of full reconciliations. Given any pair of such root locations, the full reconciliation can be computed in O ( N log N ) time by a simple algorithm given by Brejová et al. [4]. If the earlier algorithm [4] is modified to output only root locations, it still runs in O ( N 3 log N ) time; thus the algorithm presented here is a significant improvement.
We also characterize the set of possible root locations, proving that it always forms a connected subgraph of the species tree and that the distances between different root locations in the species tree and their counterparts in the gene tree are preserved.
Finally, note that the problem of gene tree and species tree reconciliation was also studied in other settings [6]. The most traditional is the parsimony setting that uses unweighted trees and seeks a reconciliation minimizing the number of inferred duplications and deletions. This problem can be solved in linear time for two rooted trees [7,8]. For unrooted gene trees, it is possible to find all optimal root locations in linear time [9]. Rooting an unrooted species tree using a set of unrooted gene trees was also considered [10]. Edge lengths were used in the context of probabilistic models of gene duplication and deletion [11,12,13] and in models allowing horizontal transfer of genes between species [14,15].
In the rest of this section, we introduce necessary notation and formally define the isometric reconciliation problem. In Section 2, we describe our algorithm and supporting proofs, including the characterization of the solution set. We provide further discussion of our results and several open problems in Section 3.

1.1. Notation

A gene tree will be in the rest of the text denoted G, species tree S. Nodes of G are usually denoted as u and v, nodes of S as x and y, the root of G as q, the root of S as r and leaves in both trees as a and b.
A point in a tree is one of its nodes or a point inside an edge where this edge can be subdivided by a new node. By d T ( u , v ) , we denote the distance between points u and v in tree T. For a tree T with nodes u and v and real value α , such that 0 α d T ( u , v ) , let T ( u , v , α ) denote the point located at distance α from node u on the path connecting points u and v. By lca T ( u , v ) , we denote the lowest common ancestor of u and v in a rooted tree T.
Let { u , v } be an edge in an unrooted tree T. By sub ( T , u , v ) we will denote a rooted subtree of T obtained by removing edge { u , v } from T, taking the resulting connected component containing u and rooting it in u. A tree with m edges thus has 2 m rooted subtrees. In rooted trees, we will consider subtrees in the conventional sense, consisting of a node and all its descendants.
For a tree T, let L ( T ) be the set of its leaves and V ( T ) the set of its nodes. For a tree T and a set of leaves A, let T A denote the subtree of T induced by A and all paths connecting pairs of leaves from A. In particular, we will often consider the subtree G L ( T ) for some rooted subtree T of S; this is the part of G that naturally corresponds to subtree T of S.

1.2. Definition of Reconciliation

Consider a rooted or unrooted tree G (the input gene tree), rooted or unrooted tree S (the input species tree) and input mapping μ : L ( G ) L ( S ) , which gives for each gene its species of origin. Both trees have edges weighted by non-negative weights. An isometric reconciliation of the triple ( G , S , μ ) is a triple ( G O , S O , Φ ) , where G O and S O are weighted rooted trees and Φ is a mapping from V ( G O ) to V ( S O ) such that the following holds:
  • The output gene tree G O is either G, if G is rooted, or a rooted version of G obtained by subdividing some edge and rooting the tree in this newly created node.
  • The output species tree S O is obtained from S by rooting it if S is unrooted and optionally subdividing some edges by additional nodes and also optionally adding a new path leading from above to the original root of S.
  • Mapping Φ agrees with input mapping μ on all leaves.
  • Mapping Φ preserves the ancestor/descendant relationships and the distances between ancestors and descendants. For each u and v such that u is a parent of v in G O , we have that Φ ( u ) is an ancestor of Φ ( v ) and d S O ( Φ ( u ) , Φ ( v ) ) = d G O ( u , v ) .
  • Nodes are not added to S O and G O unnecessarily. For each node x which was added to S O except for the root, there is some node u from G O such that Φ ( u ) = x . The edges incident to x have strictly positive weights.
Note that when subdividing a weighted edge { u , v } , we divide the original edge length between the new edges so that the distance of u and v remains the same. The new nodes added to the output species tree S O represent duplication events; the path above the root of S corresponds to ancient duplications happening before the first speciation represented in the species tree. Figure 3 shows an example of an isometric reconciliation where the root of G O maps above the original root of S O . A more detailed discussion of the isometric reconciliation model can be found in the article by Brejová et al. [4].
For algorithmic simplicity, we allow rooting trees only in points located on edges, not in the original nodes. To root a tree in an existing node u, we choose one of the edges incident to u and subdivide it by a new node in the distance 0 from u. This is the only exception where we are allowed to create new edges of zero length.
In this paper, we do not compute the full reconciliation which includes mapping Φ and new nodes added to the input trees. Instead, we output all pairs of valid roots in the two trees, that is, pairs of points in G and S such that when the trees are rooted in these points, they can be reconciled. If desired, the full reconciliation can be easily computed for any particular pair of valid roots in O ( N log N ) time.
As we will see in Section 2.7, valid roots in S form a set of intervals of points on individual edges; for edge { x , y } in S we can express such an interval as the set of points S ( x , y , α ) for α [ α 1 , α 2 ] . For some edges, the set of valid roots can be empty, and for some it may contain only a single point. For each non-empty interval, we also have the corresponding interval of valid roots on some edge { u , v } in G; this interval thus has the form G ( u , v , β ) for β [ β 1 , β 2 ] .

2. Algorithm

In this section, we describe our linear-time algorithm. A proof-of-concept implementation of this algorithm is available at https://github.com/fmfi-compbio/unrooted-reconciliation.
The previous work shows that for rooted species tree S and unrooted gene tree G, there is at most one root location in G so that the trees can be reconciled [2,4]. The key idea of our algorithm is to take individual rooted subtrees of an unrooted tree S and to compute for each the unique location of the root in the corresponding part of G (Section 2.4).
In the second phase of the algorithm (Section 2.5), we consider each edge of S as a possible root location and combine information from the two rooted subtrees at its endpoints to obtain an interval of positions along this edge where the root can be placed.
To keep the running time linear, our computation in the first two phases of the algorithm does not check all requirements of an isometric reconciliation; the final check in the third phase either validates or rejects all preliminary solutions (Section 2.6).
Finally, in the fourth phase, we compute for each root location in S its exact corresponding root location in G (Section 2.7).

2.1. Assumptions and Preprocessing

In the core of our algorithm, we make the following assumptions.
  • The input trees G and S have the same set of leaves, and the input mapping μ is implicitly represented by leaf equality.
  • All internal nodes of tree S have degree three; S may have zero-length edges.
  • The degrees of all internal nodes of tree G are at least three and are bounded from above by some constant c; all edges of G have strictly positive lengths.
Of these assumptions, the first one may seem unrealistic, because reconciliation is typically performed on gene families where individual species have multiple copies, and thus the input mapping μ is a many-to-one mapping. However, we will show in Section 2.8 that this condition can be satisfied for any input trees by simple preprocessing.
The remaining conditions are satisfied for typical fully resolved phylogenetic trees with strictly positive edge lengths, but we also show how to handle a more general class of trees in preprocessing. The only serious obstacles are high-degree nodes either in the original G or resulting from contracting zero-length edges during preprocessing. Our algorithm works for high-degree nodes in G, but the running time becomes O ( N 3 ) .
In the rest of the paper, we assume that any trees G and S satisfy the requirements outlined in this section. The algorithm works for unrooted input trees, but some claims will consider rooted species trees which occur in the algorithm as subproblems.

2.2. Tree Primitives

In our algorithm, we use the following algorithmic building blocks, whose efficient implementation is explained in Section 2.8. We work with points in the trees represented as T ( u , v , α ) for some nodes u and v in tree T and distance α such that 0 α d T ( u , v ) . The following statements assume that O ( N ) -time preprocessing is done on each input tree T { G , S } .
  • Given two points u and v in tree T, we can compute their distance d T ( u , v ) in O ( 1 ) time.
  • Given three points u, v and w in a tree with strictly positive edge lengths, we can determine if v is located on the path connecting u and w in O ( 1 ) time; we denote this predicate between G ( u , v , w ) .
  • Given two points p 1 = T ( u 1 , v 1 , α 1 ) , and p 2 = T ( u 2 , v 2 , α 2 ) in tree T where u 1 , u 2 , v 1 , v 2 are nodes of T, we can represent point p = T ( p 1 , p 2 , β ) in the form p = T ( w 1 , w 2 , γ ) where w 1 , w 2 { u 1 , v 1 , u 2 , v 2 } , and this representation can be computed in O ( 1 ) time.
  • Given tree T with m edges, we can list all its 2 m rooted subtrees so that if node w is a child of u in a subtree sub ( T , u , v ) ; then subtree sub ( T , w , u ) occurs in the list before subtree sub ( T , u , v ) . We call this ordering bottom-up order of the rooted subtrees, and it can be computed in O ( N ) time. If we process rooted subtrees in the bottom-up order, all subtrees of each rooted subtree T are processed before T itself.

2.3. Potential Rooting of a Gene Tree

In the first phase of our algorithm, we process all rooted subtrees of the species tree S and compute potential rootings of the corresponding parts of G, as defined in the next definition.
Definition 1.
Let S be a rooted species tree with root r and G an unrooted gene tree with the same set of leaves. A potential rooting of G with respect to S is a pair ( q , h ) where q is a point in G and h is a real value such that for any leaf a L ( S ) = L ( G ) we have
d G ( q , a ) = h + d S ( r , a ) .
The intuition behind this definition is that in the reconciliation of S with G, point q is the new root of G, and it maps to distance h above node r. In an isometric reconciliation, we always have h 0 , but here we allow negative values of h to keep the algorithm simple; negative values of h are ruled out in a later phase of the algorithm. In the rest of this section, we prove a series of claims characterizing potential rootings. Although Definition 1 and the following claims are formulated for rooted tree S, we will eventually apply them to rooted subtrees T of an unrooted tree S, and to keep the set of leaves the same, we will restrict G to G L ( T ) .
Claim 1.
Let S be a rooted species tree with root r and G an unrooted gene tree. Then there is at most one potential rooting of G with respect to S. More precisely, if ( q 1 , h 1 ) and ( q 2 , h 2 ) are potential rootings, then h 1 = h 2 and d G ( q 1 , q 2 ) = 0 .
Proof. 
Let ( q 1 , h 1 ) , ( q 2 , h 2 ) be two potential rootings. If d G ( q 1 , q 2 ) = 0 , then both h 1 and h 2 must be equal to d G ( q 1 , a ) d S ( r , a ) , where r is the root of S, and a is an arbitrary leaf from L ( S ) .
Therefore, let us assume that d G ( q 1 , q 2 ) > 0 . Consider the forest obtained by removing the path connecting q 1 and q 2 from G. For i { 1 , 2 } , let us denote by a i an arbitrary leaf of G contained in the component of this forest containing q i . Due to the choice of leaf a 1 , the path from a 1 to q 2 in G goes through q 1 , and thus we obtain the following equations:
h 2 + d S ( r , a 1 ) = d G ( q 2 , a 1 ) = d G ( q 1 , a 1 ) + d G ( q 1 , q 2 ) = h 1 + d S ( r , a 1 ) + d G ( q 1 , q 2 ) ,
h 2 h 1 = d G ( q 1 , q 2 ) .
Symmetrically, for a 2 we have
h 1 + d S ( x , a 2 ) = d G ( q 1 , a 2 ) = d G ( q 2 , a 2 ) + d G ( q 1 , q 2 ) = h 2 + d S ( x , a 2 ) + d G ( q 1 , q 2 ) ,
h 2 h 1 = d G ( q 1 , q 2 ) ,
which is a contradiction, implying that indeed d G ( q 1 , q 2 ) = 0 . □
Claim 2.
Let S be a rooted species tree with root r and G an unrooted gene tree. Let S be a subtree of S with root r . Let ( q , h ) be a potential rooting of G with respect to S. Then G L ( S ) has a potential rooting ( q , h ) with respect to S , where q is the point of G L ( S ) closest to q (distance measured by d G ). In particular, if q is inside G L ( S ) , then q = q . Value h is defined by the following equation:
h = h d G ( q , q ) + d S ( r , r ) .
Proof. 
Let q be the point of G L ( S ) closest to q, and let h be the value defined by Equation (1). Then for any leaf a of S the path from a to q must lead through q , and thus we have d G ( q , a ) = d G ( q , a ) + d G ( q , q ) . Similarly, d S ( r , a ) = d S ( r , a ) + d S ( r , r ) . By combining these two equations, the equation d G ( q , a ) = h + d S ( r , a ) implied by the potential rooting ( q , h ) and Equation (1), we obtain
d G ( q , a ) = d G ( q , a ) d G ( q , q ) = h + d S ( r , a ) d G ( q , q ) = h + d G ( q , q ) d S ( r , r ) + d S ( r , a ) d G ( q , q ) = h d S ( r , r ) + d S ( r , a ) = h d S ( r , r ) + d S ( r , a ) + d S ( r , r ) = h + d S ( r , a )
Thus we have proved that ( q , h ) is the potential rooting, as required. □
The following two claims help us to compute potential rootings.
Claim 3.
Let both S and G contain only a single node x. The potential rooting of G with respect to S is ( x , 0 ) .
Claim 4.
Let S be a rooted species tree with root r, which is an internal node with two children r 1 and r 2 , and let G be an unrooted gene tree. Let S 1 and S 2 be subtrees of S rooted at r 1 and r 2 . Let us assume that G L ( S 1 ) and G L ( S 2 ) have potential rootings ( q 1 , h 1 ) , ( q 2 , h 2 ) (both rootings exist). Then the pair ( q , h ) is a potential rooting of G if and only if the following three conditions are satisfied.
1. 
h = ( d G ( q 1 , q 2 ) d S ( r 1 , r 2 ) + h 1 + h 2 ) / 2 .
2. 
q = G ( q 1 , q 2 , β ) , where β = h + d S ( r 1 , r ) h 1 and 0 β d G ( q 1 , q 2 ) .
3. 
Let π be the path in G between q 1 and q 2 . For each i { 1 , 2 } either q i = q or π is completely outside G L ( S i ) except for its endpoint q i .
Proof. 
Let G 1 = G L ( S 1 ) and G 2 = G L ( S 2 ) . Tree G consists of G 1 and G 2 and possibly the path π connecting these two trees in G.
First, let us prove that if ( q , h ) is a potential rooting, it satisfies the three conditions. Let us start with Condition 3 for some i { 1 , 2 } . If q = q i , the condition is automatically satisfied. Otherwise, we can use Claim 2 to observe that q i must be the point from G L ( S i ) closest to q, implying that the path from q to q i is outside G L ( S i ) except for q i . This discussion also implies that q is on the path from q 1 to q 2 , as needed in Condition 2.
Next, we use Equation (1) from Claim 2, which gives us the value of h expressed as
h = h i + d G ( q , q i ) d S ( r , r i )
for each of the subtrees S i . We obtain the desired value of β from Condition 2 directly from Equation (2) for S 1 , noting that β = d G ( q 1 , q ) . Finally, using Equation (2) for S 2 and noting that d G ( q , q 2 ) = d G ( q 1 , q 2 ) β , we obtain Condition 1.
To prove that the three conditions imply potential rooting, we first prove that Conditions 1 and 2 imply d G ( q , q i ) = h + d S ( r , r i ) h i for each i { 1 , 2 } . This equation clearly holds for i = 1 from Condition 2 as β = d G ( q 1 , q ) . Therefore, let us consider d G ( q , q 2 ) . From definition of q in Condition 2, we see that d G ( q , q 2 ) = d G ( q 1 , q 2 ) β . Then we use definitions of β and h from Conditions 1 and 2, the fact that d S ( r 1 , r 2 ) = d S ( r , r 1 ) + d S ( r , r 2 ) and simple manipulations to get
( 3 ) d G ( q , q 2 ) = d G ( q 1 , q 2 ) h d S ( r 1 , r ) + h 1 ( 4 )   = d G ( q 1 , q 2 ) d G ( q 1 , q 2 ) d S ( r 1 , r 2 ) + h 1 + h 2 2 d S ( r 1 , r ) + h 1 ( 5 )   = d G ( q 1 , q 2 ) + d S ( r 1 , r 2 ) + h 1 h 2 2 d S ( r 1 , r ) d S ( r , r 2 ) + d S ( r , r 2 ) ( 6 )   = d G ( q 1 , q 2 ) d S ( r 1 , r 2 ) + h 1 + h 2 2 + d S ( r , r 2 ) h 2 ( 7 )   = h + d S ( r , r 2 ) h 2 .
Now consider any leaf a L ( S ) . We need to prove that d G ( q , a ) = h + d S ( r , a ) . Let i be the index such that a belongs to L ( S i ) . Thanks to Condition 3, we have that d G ( q , a ) = d G ( q , q i ) + d G ( q i , a ) . Since ( q i , h i ) is a potential rooting of G i , we have that d G ( q i , a ) = h i + d S ( r i , a ) . Finally, since a L ( s i ) , we have d S ( r , a ) = d S ( r , r i ) + d S ( r i , a ) . These three observations yield the desired equality
d G ( q , a ) = h i + d S ( r i , a ) + = h i + d S ( r i , a ) = h + d S ( r , a ) .

2.4. Computation of Potential Rootings

In the first phase of the algorithm, we will compute potential rootings of all rooted subtrees of S. Claim 3 gives the potential rooting of a subtree with one leaf, and Claim 4 allows us to compute the potential rooting of a bigger subtree from rootings of its two subtrees.
Let T be a rooted subtree of S. The point q in a potential rooting ( q , h ) of G L ( T ) will be represented in the algorithm as G ( a , b , α ) for some leaves a and b and distance α . We will also keep a set of representative leaves for each subtree with a potential rooting ( q , h ) . The size of this set will be the same as the degree of q in G L ( T ) . For each edge { q , u } incident to q in G L ( T ) , the set will contain a leaf a such that between G ( q , u , a ) is true; that is, the path from q to a uses edge { q , u } . Note that if q is not a node of G, but rather a point inside some edge e, we will assume that G was modified by subdividing e in this point, and thus the degree of q is two, and it has two incident edges.
The algorithm processes each rooted subtree T of S in the bottom-up order. As a special case, if G L ( T ) consists only of leaf a, the rooting will be represented as ( q , 0 ) , where q = G ( a , a , 0 ) , and the representative set is { a } .
Consider now rooted subtree T with two rooted subtrees S 1 , S 2 as in Claim 4; we will also use other notation from the claim. The rooting for subtree T is computed from already known rootings of S 1 and S 2 as follows.
  • Compute h using Condition 1 of Claim 4. This requires computing d G ( q 1 , q 2 ) , where q 1 and q 2 are represented as q 1 = G ( a 1 , b 1 , α 1 ) and q 2 = G ( a 2 , b 2 , α 2 ) for some leaves a 1 , b 1 , a 2 , b 2 . This distance computation is one of our tree primitives (see Section 2.2 and Section 2.8).
  • Compute β from Condition 2; check that 0 β d G ( q 1 , q 2 ) . Then represent point q = G ( q 1 , q 2 , β ) in the form G ( a , b , α ) where a , b { a 1 , b 1 , a 2 , b 2 } . This computation is also one of our primitives.
  • To check Condition 3, we use the sets of representative leaves A 1 = { a 1 , , a g } and A 2 = { b 1 , , b h } for q 1 and q 2 , respectively. We also build the set A for q (see Figure 4).
    If q 1 = q 2 , Condition 3 is satisfied, and q = q 1 = q 2 . To build the set A, we start with the union of A 1 and A 2 . This clearly covers all outgoing edges from q belonging to G L ( T ) , but some of them may be covered twice, if they are shared between G L ( S 1 ) and G L ( S 2 ) . Thus, if for some a i A 1 and b j A 2 we have that between G ( a i , q , b j ) is false, either a i or b j is excluded from A.
    Now let us assume that q q i for some i { 1 , 2 } ; let j be the other index from { 1 , 2 } . We need to check that the edge ( q i , u ) leaving from q i towards q and q j does not belong to G L ( S i ) . This is achieved by checking that for each leaf a A i the predicate between G ( a , q i , q j ) is true (see Figure 5). If neither q 1 nor q 2 equal q, this check is repeated for both values of i.
    To build the set A for q, we consider two cases: if q is one of the endpoints of the path between q 1 and q 2 , say q = q 1 , then we start with set A 1 and add to it one leaf from A 2 as a representative of the edge leaving from q 1 towards q 2 .
    Finally, if q is inside the path connecting q 1 and q 2 , its degree in G L ( T ) will be two and the set A will consist of one arbitrarily chosen leaf from each A 1 and A 2 .
    A straightforward implementation of this step takes O ( | A 1 | · | A 2 | ) if q 1 = q 2 and O ( | A 1 | + | A 2 | ) if q 1 q 2 . If the degree of each node of G is O ( 1 ) , the running time of this step is also O ( 1 ) .
If the degrees of all nodes of G are O ( 1 ) , the overall running time for computing potential rootings of all 2 m subtrees is O ( m ) .

2.5. Potential Roots of an Unrooted Species Tree

Once we have potential rootings computed for all rooted subtrees of an unrooted tree S, we can consider potential roots of S, defined as follows.
Definition 2.
Let G and S be unrooted. A point r in S is called a potential root of S if there exists some potential rooting ( q , u ) of G with respect to S rooted at r.
For each edge { x 1 , x 2 } of S, consider rooting tree S at the point r = S ( x 1 , x 2 , α ) for 0 α d S ( x 1 , x 2 ) . This yields a rooted tree S α on which we can apply Claim 4, using precomputed potential rootings ( q 1 , h 1 ) and ( q 2 , h 2 ) for the two subtrees S 1 and S 2 of S rooted at x 1 and x 2 . Using this claim, we can compute for which values of α we obtain a potential rooting of G with respect to S α .
In particular, Condition 1 of Claim 4 specifies the value of h which does not depend on the unknown distance α = d S ( x , r ) . Condition 2 specifies the position q of the root in G, but for this position to be valid, value of β = h h 1 + α must be from the specified interval. This translates to interval [ h 1 h , h 1 h + d G ( q 1 , q 2 ) ] for α . Possible values of α also must be within edge { x 1 , x 2 } , and thus we take an intersection of two intervals, yielding the following interval of possible values:
α [ max ( 0 , h 1 h ) , min ( d S ( x 1 , x 2 ) , h 1 h + d G ( q 1 , q 2 ) ) ] .
Note that this interval might be empty, signifying that no potential rooting exists, or it might contain only a single value of α .
Finally, to satisfy Condition 3 of Claim 4 for i { 1 , 2 } , we consider two cases. If the path π connecting q 1 and q 2 lies outside of G L ( G i ) except for the endpoints, we can place point q anywhere on this path without violating this condition. However, if some portion of this path is inside G L ( G i ) for some i { 1 , 2 } , we have to place q to q i , restricting possible values of β to a single value (0 or d G ( q 1 , q 2 ) , depending on i), and thus α is also restricted to a single value or potentially to an empty set. Condition 3 has to be satisfied for both values of i { 1 , 2 } .
To algorithmically check whether π is outside of G L ( G i ) , we again use the set A i of representative leaves for q i . For each leaf a A i , we evaluate the predicate between G ( a , q i , q j ) , where j is the index from { 1 , 2 } different from i. If the predicate is true for all representative leaves, the path is outside.
The result of this phase of the algorithm is for every edge { x 1 , x 2 } of S an interval of potential roots of S which yield potential rootings of G. The location of the root q is given in the form G ( a , b , f ( α ) ) where α is the distance of the root of S from node x 1 and f is a function of the form f ( α ) = α + d , where d = h h 1 as discussed above.

2.6. Checking Distances

In the third phase of the algorithm, we are given a set of potential roots, and we need to verify whether they correspond to actual reconciliations. We do so based on comparing distances between pairs of selected leaves in trees S and G, as explained in the following two claims.
Note that the definition of isometric reconciliation requires that distances between a node of G and its descendants and ancestors are preserved by the mapping. However, for other pairs of nodes, the distance in G can be greater than the distance of the corresponding points in S. For example, in Figure 2 leaves a 1 and b 1 of G are at distance 8, but the corresponding leaves a and b from S have a distance of only 4. Next we show that the distances in G cannot be smaller than distances in S.
Claim 5.
Let ( G O , S O , Φ ) be an isometric reconciliation of a triple ( G , S , μ ) , where trees S and G can be either rooted or unrooted. Then for each two nodes u and v from G, we have d G ( u , v ) d S ( Φ ( u ) , Φ ( v ) ) .
Proof. 
Note that the definition of isometric reconciliation implies that if u is an ancestor of v in G; then Φ ( u ) is an ancestor of Φ ( v ) and d G O ( u , v ) = d S O ( Φ ( u ) , Φ ( v ) ) . Additionally, note that for any nodes u and v of G we have d G ( u , v ) = d G O ( u , v ) , and similarly, the distances remain preserved between S and S O .
Let w = lca G O ( u , v ) and x = lca S O ( Φ ( u ) , Φ ( v ) ) . Note that Φ ( w ) must be an ancestor of x, because it is an ancestor of both Φ ( u ) and Φ ( v ) .
d G ( u , v ) = d G O ( w , u ) + d G O ( w , v ) = d S O ( Φ ( w ) , Φ ( u ) ) + d S O ( Φ ( w ) , Φ ( v ) ) d S O ( x , Φ ( u ) ) + d S O ( x , Φ ( v ) ) = d S O ( Φ ( u ) , Φ ( v ) ) = d S ( Φ ( u ) , Φ ( v ) )
Given a rooted tree T, let T be the mapping which maps each node x of T to the smallest leaf in the subtree of T rooted at x under some fixed complete order on the set L ( T ) .
Claim 6.
Let S be a rooted tree and G an unrooted tree. Trees S and G can be reconciled if and only if the following two conditions hold:
  • There is a potential rooting ( q , h ) of G (let G be G rooted in q)
  • For each two nodes v 1 and v 2 which are in G children of the same node we have
    d G ( G ( v 1 ) , G ( v 2 ) ) d S ( G ( v 1 ) , G ( v 2 ) ) .
Note that Equation (8) uses the assumption that the leaves are shared between G, G and S.
Proof. 
If the reconciliation ( G O , S O , Φ ) exists, we can obtain the potential rooting ( q , h ) by taking the root of G O as q and setting h = d S O ( Φ ( q ) , r ) where r is the root of tree S. Inequality (8) is implied by Claim 5.
Let us now assume the existence of a potential rooting ( q , h ) satisfying the two conditions. We will root tree G in q and construct the mapping Φ as follows. Node q is mapped to the point located in distance h above the root of S; let us call this point r and denote tree S extended with r as S . Each node v of the rooted G is then mapped to Φ ( v ) = S ( r , G ( v ) , d G ( q , v ) ) . First of all, we need to prove that this mapping exists, in particular that d G ( q , v ) d S ( r , G ( v ) ) . This is true because the definition of a potential rooting implies that d S ( r , G ( v ) ) = d G ( q , G ( v ) ) , and since the path from q to G ( v ) passes through v, we have the desired inequality. Note that the leaves of G are correctly mapped by Φ to their counterparts in S .
Next we prove that if v is an ancestor of w in G and Φ ( v ) is an ancestor of Φ ( w ) in S , then d G ( v , w ) = d S ( Φ ( v ) , Φ ( w ) ) . Based on the ancestor relationships, the path from w to q passes through v and the path from Φ ( w ) to r passes through Φ ( v ) , and therefore, d G ( w , q ) = d G ( w , v ) + d G ( v , q ) and d S ( Φ ( w ) , r ) = d S ( Φ ( w ) , Φ ( v ) ) + d S ( Φ ( v ) , r ) . Based on the definition of Φ , d G ( w , q ) = d S ( Φ ( w ) , r ) and d G ( v , q ) = d S ( Φ ( v ) , r ) . These equations imply the desired result.
Finally, we need to prove that if v is the parent of w in G then Φ ( v ) is an ancestor of Φ ( w ) in S . Let a w = G ( w ) and a v = G ( v ) . If a w = a v , both Φ ( v ) and Φ ( w ) are on the path from r to a w , and by comparing their distances from the root, we see that Φ ( v ) must be an ancestor of Φ ( w ) .
If a w a v , let w be the child of v on the path to a v . Then G ( w ) = a v , and w and w are two children of the same node of G . Therefore, we can apply Inequality (8) to obtain d G ( a v , a w ) d S ( a v , a w ) . Note that v = lca G ( a v , a w ) and thus d G ( a v , a w ) = d G ( a v , q ) + d G ( a w , q ) 2 d G ( q , v ) . Similarly in S , let x = lca S ( a v , a w ) ; then d S ( a v , a w ) = d S ( a v , r ) + d S ( a w , r ) 2 d S ( r , x ) . By combining these three facts, we get the inequality d G ( v , q ) d S ( x , r ) . As Φ ( q ) = r and r is an ancestor of Φ ( v ) , we have that d G ( v , q ) = d S ( Φ ( v ) , r ) . Therefore, we see that the depth of Φ ( v ) in S is smaller or equal to the depth of x. Both x and Φ ( v ) are ancestors of a v , which implies that Φ ( v ) must be an ancestor of x (which includes the possibility that Φ ( v ) = x ). This in turn implies that Φ ( v ) must be also an ancestor of a w . Again, since both Φ ( v ) and Φ ( w ) are ancestors of a w and Φ ( w ) is in a greater depth than Φ ( v ) , it must be a descendant of Φ ( v ) . □
Claim 5 shows that given unrooted input trees G and S, we can check any pair of leaves a and b and if d G ( a , b ) < d S ( a , b ) , then no reconciliation of these trees exists. Claim 6 shows that for a fixed potential root in S, it is sufficient to check distances between O ( N ) pairs of leaves to verify that the potential rooting corresponds to a valid reconciliation.
However, we would like to verify all potential roots of S in O ( N ) total time. For every rooted subtree sub ( G , v , u ) of G, we can find its smallest leaf; this leaf will correspond to G ( v ) for all rooted versions G of G in which this rooted subtree appears as one of the subtrees. These smallest leaves can be easily computed in O ( N ) using the bottom-up ordering of rooted subtrees of G. Then, given any node u of G, we take all pairs of its neighbors v 1 and v 2 , take the smallest leaves a 1 and a 2 in the subtrees sub ( G , v 1 , u ) and sub ( G , v 2 , u ) and check whether d G ( a 1 , a 2 ) d S ( a 1 , a 2 ) . Provided that tree G has at least one internal node, these checks cover all pairs of leaves G ( v 1 ) and G ( v 2 ) from Claim 6 that can occur for any root location in S. If any of these checks is negative, we reject all potential roots of S (using Claim 5); if all checks are positive, then all potential roots of S are valid (using Claim 6). Note that the case of tree G without an internal node is trivial, as it then has at most two leaves. If the degrees of all nodes in G are O ( 1 ) , the computation can be done in O ( N ) time.

2.7. Final Output and Possible Solution Sets

This section has two goals. First, we want to characterize the set of possible solutions of the isometric reconciliation for two unrooted trees, which is of theoretical interest. We also need the results proved here to efficiently transform the output of our algorithm to its final form. We will characterize sets of potential roots, but these results also apply to the final valid roots, as according to the previous section, either all potential roots are valid or none are.
We start with a generalized version of Claim 2, which can be proved in the same way as the original claim.
Claim 7.
Let S be a rooted species tree with root r and G an unrooted gene tree. Let A be a subset of leaves, and consider trees S A and G A induced by leaves from A and all paths connecting them. Let r be the root of S A , that is, the lowest common ancestor in S of all leaves in A. Let ( q , h ) be a potential rooting of G with respect to S. Then G A has a potential rooting ( q , h ) with respect to S A , where q is the point of G A closest to q (distance measured by d G ). Value h is defined by the following equation:
h = h d G ( q , q ) + d S ( r , r ) .
In particular, if r belongs to S A then r = r and if in addition q belongs to G A , then also q = q and h = h .
Before stating our core observation characterizing the set of potential solutions of the problem in Claim 9, we will add one more technical claim.
Claim 8.
Consider points r 1 and r 2 in unrooted S and q 1 and q 2 in unrooted G and values h 1 and h 2 such that ( q 1 , h 1 ) is a potential rooting of G with respect to S rooted in r 1 and ( q 2 , h 2 ) is a potential rooting with respect to S rooted in r 2 . Let a be any leaf, let x be the point on the path between r 1 and r 2 closest to leaf a under d S , and let u be the point on the path between q 1 and q 2 closest to a under d G . Then
d G ( u , q 1 ) d S ( x , r 1 ) = ( d G ( q 1 , q 2 ) d S ( r 1 , r 2 ) + h 1 h 2 ) / 2 .
In particular, if h 1 = h 2 and d G ( q 1 , q 2 ) = d S ( r 1 , r 2 ) , then d G ( u , q 1 ) = d S ( x , r 1 ) .
Note that we will later show that conditions h 1 = h 2 and d G ( q 1 , q 2 ) = d S ( r 1 , r 2 ) are always satisfied, and thus d G ( u , q 1 ) = d S ( x , r 1 ) .
Proof. 
From the definition of a potential rooting, we get d G ( a , q 1 ) d S ( a , r 1 ) h 1 = d G ( a , q 2 ) d S ( a , r 2 ) h 2 = 0 . By splitting individual distances at points x and u, we get d G ( a , q 1 ) = d G ( a , u ) + d G ( u , q 1 ) , d G ( a , q 2 ) = d G ( a , u ) + d G ( u , q 2 ) = d G ( a , u ) + ( d G ( q 1 , q 2 ) d G ( u , q 1 ) ) and similarly for tree S. By combining these equations, we get the desired claim. □
Claim 9.
Let G and S be unrooted trees. Let R be the set of potential roots of S. Let r 1 and r 2 be two points from R , and let r 3 be some point on the path connecting r 1 and r 2 in S. For i { 1 , 2 , 3 } , let S ( i ) be S rooted in r i , and let ( q i , h i ) be the potential rooting of G with respect to S ( i ) (if it exists). Then the following four statements hold:
1. 
d S ( r 1 , r 2 ) = d G ( q 1 , q 2 ) ;
2. 
h 1 = h 2 ;
3. 
r 3 R and thus the potential rooting ( q 3 , h 3 ) exists;
4. 
q 3 is on the path between q 1 and q 2 .
Proof. 
If both r 1 and r 2 belong to the same edge of S, all four statements are implied by the discussion in Section 2.5, where it is proved that the set of potential rootings for a single edge is either empty or it is an interval of points on this edge. These points all share the same value of h and their counterparts form an interval on some path in G of the same length as the interval in S.
Consider now the case when r 1 and r 2 are not on the same edge. Let x 1 , , x z be the path in S such that r 1 is on the edge { x 1 , x 2 } , and r 2 is on the edge { x z 1 , x z } (refer to Figure 6). All leaves can be partitioned into three classes: let A 1 be the set of leaves a such that between S ( a , x 1 , x z ) is true, A 2 be the set of leaves such that between S ( a , x z , x 1 ) is true and B be the remaining leaves. Let A = A 1 A 2 .
Consider now trees S A and G A . Nodes x 2 , , x z 1 all have degree two in S A , and thus we can replace path x 1 , , x z by a single edge in S A . We can apply Claim 7 to S ( 1 ) and S ( 2 ) to see that points r 1 and r 2 must be potential roots in S A as well (see Figure 7). Since r 1 and r 2 are on a single edge in S A , all four statements of this claim hold for r 1 , r 2 and r 3 in trees G A and S A . Let ( q i , h i ) be the potential rooting of G A with respect to S A ( i ) for i { 1 , 2 , 3 } . We thus have that ( q 3 , h 3 ) exists as a potential rooting of G A with respect to S ( 3 ) ; it is located on the path between q 1 and q 2 , d S ( r 1 , r 2 ) = d G ( q 1 , q 2 ) , and h 1 = h 2 . From now on we will denote the common value h 1 = h 2 as h. We also have that h 3 = h because r 1 , r 2 and r 3 are all on the same edge of S A .
Next we prove that q 1 = q 1 and q 2 = q 2 . According to Claim 7, q 1 is the closest point in G A to q 1 . Consider now the path from q 1 to q 2 , and note that q 2 is in G A . The point where this path first enters G A must be q 1 . Symmetrically, q 2 must be on the path from q 2 to q 1 . This implies that the points q 1 , q 1 , q 2 , q 2 are on a single path in G in this order, although some adjacent points may coincide. Let us now assume that q 1 q 1 , and thus q 1 is not in G A . Then there must be a leaf b B such that q 1 is on the path from b to q 1 . For i { 1 , 2 } we have that h = h i = h i d G ( q i , q i ) by Claim 7. Since r i R , we have d G ( b , q i ) = d S ( b , r i ) + h i . Combining these two facts, we get
d G ( b , q i ) = d S ( b , r i ) + h + d G ( q i , q i ) .
In addition,
( 11 ) d G ( b , q 2 ) = d G ( b , q 1 ) + d G ( q 1 , q 1 ) + d G ( q 1 , q 2 ) + d G ( q 2 , q 2 ) ( 12 )   = ( d S ( b , r 1 ) + h + d G ( q 1 , q 1 ) ) + d G ( q 1 , q 1 ) + d S ( r 1 , r 2 ) + d G ( q 2 , q 2 ) .
By combining the right-hand side of Equation (10) for i = 2 and the right-hand side of Equation (12), we get
d S ( b , r 2 ) ( d S ( b , r 1 ) + d S ( r 1 , r 2 ) ) = 2 d G ( q 1 , q 1 ) .
The left-hand side of this equation is at most 0 due to triangle inequality, and therefore, the right-hand side must be zero, which is a contradiction with our assumption that q 1 is not in G A . Therefore, we have that q 1 = q 1 and analogously q 2 = q 2 . This implies (via Claim 7) that h 1 = h 2 = h , completing the proof of Statements 1 and 2 in the general case for the original trees G and S.
Finally, we need to prove Statements 3 and 4 for original trees G and S. We have proved that ( q 3 , h 3 ) is a potential rooting of G A with respect to S A ( 3 ) and that h 3 = h . We will prove that ( q 3 , h ) is also a potential rooting of G with respect to S ( 3 ) . Consider a leaf a. If a A , then we already know from G A that d G ( q 3 , a ) = d S ( r 3 , a ) + h .
We still need prove the same equality for a B . Consider points u and x as in Claim 8; the claim implies that d S ( x , r 1 ) = d G ( u , q 1 ) . Point x may be located either between r 1 and r 3 or between r 3 and r 2 . We will assume the latter; the former is proved analogously by switching the roles of r 1 and r 2 . Point u is then located between q 3 and q 2 , as thanks to Claim 8, the distances along paths from r 1 to r 2 and from q 1 to q 2 are preserved. Finally, we obtain
d S ( a , r 3 ) = d S ( a , r 1 ) d S ( r 1 , r 2 ) = d G ( a , q 1 ) h d G ( q 1 , q 3 ) = d G ( a , q 3 ) h .
The previous claim broadly characterizes the full set of solutions; the next one observes a useful property of solutions located on a single edge of S.
Claim 10.
Let G and S be unrooted trees. Let { x , y } be an edge in S and let [ α 1 , α 2 ] be an interval such that every point S ( x , y , α ) for α [ α 1 , α 2 ] is a potential root of S. Then there is an edge { u , v } in G and interval [ β 1 , β 2 ] such that when we root S in the potential root S ( x , y , α ) for α [ α 1 , α 2 ] , its corresponding potential rooting ( q , h ) has the form q = G ( u , v , β ) for β [ β 1 , β 2 ] .
Proof. 
Our discussion in Section 2.5 implies that potential rootings of G corresponding to a single edge of S form an interval on some path, that is, they can be expressed as G ( a , b , β ) . It remains to prove that the interval of possible values of β is within one edge of G. This is implied by Claim 8, where as r 1 and r 2 , we use the endpoints S ( x , y , α 1 ) and S ( x , y , α 2 ) , and as q 1 and q 2 the endpoints in the corresponding interval in S. Since the path between r 1 and r 2 is within a single edge of S, point x for any leaf will be either r 1 or r 2 . This implies that point u will be either q 1 or q 2 . As a result, there is no node on the path between q 1 and q 2 , where the paths to other leaves branch out. As tree G has all internal nodes of degree at least 3, q 1 and q 2 must be located on a single edge. □
Claims 9 and 10 are important for the final part of our algorithm, in which we transform the solution to the final form. As we have seen in the proof of Claim 10, the potential roots of G for a single edge of S are specified within an interval on some path. Thanks to Claim 10, we know that they are in fact located on a single edge. Our goal is now to algorithmically find this edge { u , v } in G and the interval [ β 1 , β 2 ] . To keep the running time O ( N ) , we want to avoid doing such computation for each edge of S individually. Instead, we use the connected nature of the set of solutions in both S and G implied by Claim 9. We traverse tree S by a depth-first search, and the first time we encounter an edge with a non-empty set of potential roots, we find the corresponding edge in G; even a naive O ( N ) -time search is sufficient. Each time we encounter another edge { x , y } of S with a non-empty solution set, we have already seen some adjacent edge { x , z } with a solution. The potential root of G corresponding to rooting S in the shared vertex x is some point p, which we have already found, and thus we need to search for appropriate edge { u , v } only among the edges incident to p. Since the node degree in G is bounded by O ( 1 ) , this can be done in O ( 1 ) time. To check if a candidate edge { u , v } is the one containing points of the form G ( a , b , α ) , we need to verify between G ( a , u , b ) , between G ( a , v , b ) and to compare d G ( a , u ) and d G ( a , v ) to the desired range of α .

2.8. Further Algorithmic Details

In this section, we provide further details on the input preprocessing and tree primitives from Section 2.1 and Section 2.2.
First, we need to preprocess our trees so that they have the same set of leaves. Definition of reconciliation allows multiple leaves a 1 , , a k of G to correspond to a single leaf a of S (this corresponds to multiple copies of a gene in a single species). In that case, we add new leaves a 1 , , a k to S, all connected to node a by edges of zero length. Each leaf a i of G will naturally correspond to leaf a i of S. If, on the other hand, some leaf of S does not occur in G, it can be deleted from S. Leaves of G with no corresponding leaf of S are not considered in the reconciliation problem. Thus these changes will satisfy Assumption 1 from Section 2.1.
Assumption 2 can be achieved by replacing nodes of higher degree in S with binary subtrees connected by zero-length edges. A node of degree two in both S and G can be bypassed by an edge connecting its two neighbors. The condition on non-zero lengths in G (Assumption 3) can be achieved by contracting edges of zero length. However, if some leaf a is connected to its neighbor in G by an edge of length 0, contracting this edge would remove the leaf. Therefore, we can instead lengthen the edge to a by some constant, and then also lengthen the edge leading to a in S by the same amount.
It is easy to see that all these transformations leave the set of solutions practically unchanged; any reconciliation in the preprocessed trees can be easily mapped back to the original trees and vice versa. The only exceptions are reconciliations that root the modified trees on edges added or extended in the preprocessing phase. Such rootings have no counterpart in the original trees and can be simply omitted from the final output.
Now let us consider efficient implementation of the tree primitives from Section 2.2 for each tree T { G , S } . In the precomputation phase, we root the tree T in an arbitrary node. On the resulting rooted tree, we precompute data structures allowing O ( 1 ) computation of lca T ; this precomputation can be done in O ( N ) time [16,17]. We also store the distance to the root in each node; let us denote this value for node u as d [ u ] . Then the distance between nodes u and v is d [ u ] + d [ v ] 2 d [ lca T ( u , v ) ] , which can be computed in constant time.
However, we also need to be able to compute distances between points of the form p 1 = T ( u 1 , v 1 , α 1 ) and p 2 = T ( u 2 , v 2 , α 2 ) . Our technique for this computation is to synchronize these points, that is, to express them both in the form p i = T ( w 1 , w 2 , β i ) , where w 1 , w 2 { u 1 , v 1 , u 2 , v 2 } . Once the points are synchronized on a single path between w 1 and w 2 , their distance is simply | β 1 β 2 | .
To synchronize the points, we first consider the path between u 1 and v 1 and node u 2 . The path from u 1 to u 2 diverges from the path from u 1 to v 1 at some node x 1 . We can compute the distance d T ( u 1 , x 1 ) as ( d T ( u 1 , v 1 ) + d T ( u 1 , u 2 ) d T ( v 1 , u 2 ) ) / 2 ; this is well known from the neighbor joining algorithm [18]. Our next goal is to express p 1 in the form T ( u 2 , y 1 , γ 1 ) for some node y 1 { u 1 , v 1 } . If α 1 d T ( u 1 , x 1 ) , p 1 is located on the shared portion of the two paths considered above and thus p 1 = T ( u 2 , u 1 , d T ( u 1 , u 2 ) α 1 ) . Otherwise, p 1 is located after the path from u 1 to v 1 passing through x 1 , and thus p 1 = T ( u 2 , v 1 , γ 1 ) , where γ 1 = d T ( u 2 , v 1 ) d T ( u 1 , v 1 ) + α 1 . To obtain this expression for γ 1 , observe that d T ( v 1 , p 1 ) = d T ( u 1 , v 1 ) α 1 and γ 1 = d T ( u 2 , p 1 ) = d T ( u 2 , v 1 ) d T ( v 1 , p 1 ) .
Now we have both points specified in the form p i = T ( u 2 , y i , γ i ) , where y 2 = v 2 and γ 2 = α 2 . We now consider the node x 2 where paths from u 2 to y 1 and from u 2 to y 2 diverge. Again, we can compute d T ( u 2 , x 2 ) as above. If at least one of p 1 and p 2 is closer to u 2 than x 2 , then both points lie on a path from u 2 to one of the y i and can be synchronized easily. Otherwise, they are synchronized on the path from y 1 to y 2 using similar distance transformations as above. Since the synchronization is only a simple case analysis, it can be easily computed in O ( 1 ) time, and thus we are able to compute distances between any two points in O ( 1 ) time.
The next primitive is to take two points p 1 and p 2 of the form p i = T ( u i , v i , α i ) and to express point p = T ( p 1 , p 2 , β ) in the form p = T ( w 1 , w 2 , γ ) where w 1 , w 2 { u 1 , v 1 , u 2 , v 2 } . This is also easily achieved by synchronization. Once we have both p 1 and p 2 expressed on the same path between some w 1 and w 2 , we easily determine the necessary distance γ of the new point p from w 1 , since we know the distance of p 1 from w 1 and distance of p from p 1 . Again, this works in O ( 1 ) time.
Distance computations can be also used to evaluate predicate between T ( u , v , w ) . In the absence of zero-length edges, this predicate is satisfied if and only if d T ( u , w ) = d T ( u , v ) + d T ( v , w ) . In our algorithm, this predicate is used only for tree G, which is assumed to have strictly positive edge lengths.
Finally, we need to provide a bottom-up ordering of all rooted subtrees of a tree T. This is computed by two tree traversals. Note that the tree is for technical reasons rooted in an arbitrary node.
First, we do a post-order traversal of the tree. After exploring node u and its subtrees, we output subtree sub ( T , u , v ) , where v is the parent of u in the current rooting. If u is a root, we skip this output. This traversal lists for each edge one of the two subtrees corresponding to the removal of this edge—namely, the one rooted in the node, which is lower in the auxiliary rooting. The second traversal proceeds in the pre-order fashion. After reaching node u from its parent v, it outputs sub ( T , v , u ) , and afterwards it recursively traverses children of u.

3. Conclusions

In this paper, we have shown how to compute valid root locations for isometric reconciliation of two unrooted trees in linear time, assuming that the gene tree does not have nodes with very high degrees, which is typically true for phylogenetic trees. Nonetheless, linear-time algorithm for trees with arbitrary degrees is an interesting open question. Full reconciliation can be easily computed for any selected root location discovered by our algorithm. However, root locations themselves might be of interest; indeed rooting unrooted trees is one of the motivations for performing reconciliation [9,10].
Note that in practical applications, we might have one species tree and multiple gene trees, each for a different gene family. Our algorithm can reconcile each gene tree separately with the species tree, and then we can choose a root location in S that agrees with the highest number of gene trees. This in turn implies root locations in these gene trees.
The earlier algorithm for isometric reconciliation of unrooted trees [4] finds all distinct reconciliations in O ( N 5 log N ) time; the high running time is partially caused by the potentially high number of such reconciliations. Perhaps some observations from the present paper can be used to provide a tighter upper bound and thus a more efficient algorithm for completely listing all solutions. In practice, it might be more desirable to find algorithms for efficiently computing various statistics over the set of all solutions, such as the minimum and maximum numbers of duplication events occurring on a particular edge of a species tree.
Unlike classical parsimony-based reconciliation approaches, isometric reconciliation uses edge length information. However, edge lengths computed by phylogeny reconstruction methods are not exact, and thus an extension of this algorithm taking into account edge length uncertainty would be desirable.
In this paper, we also characterize the set of all solutions, showing that they form connected subgraphs in both trees. This is similar to the plateau property defined for parsimony-based reconciliation of an unrooted gene tree with a rooted species tree [9,19].

Author Contributions

Investigation, B.B. and R.K., writing—original draft preparation, B.B. writing—review and editing, B.B. and R.K. Both authors have read and agreed to the published version of manuscript.

Funding

This research was supported in part by grants from the Slovak Research and Development Agency (APVV-18-0239) and VEGA (1/0463/20, 1/0601/20, 1/0458/18).

Acknowledgments

The authors would like to thank Tomáš Vinař, Dana Pardubská and anonymous reviewers for useful comments.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Goodman, M.; Czelusniak, J.; Moore, G.W.; Romero-Herrera, A.; Matsuda, G. Fitting the gene lineage into its species lineage, a parsimony strategy illustrated by cladograms constructed from globin sequences. Syst. Biol. 1979, 28, 132–163. [Google Scholar] [CrossRef]
  2. Ma, J.; Ratan, A.; Raney, B.J.; Suh, B.B.; Miller, W.; Haussler, D. The infinite sites model of genome evolution. Proc. Natl. Acad. Sci. USA 2008, 105, 14254–14261. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Ma, J.; Ratan, A.; Raney, B.J.; Suh, B.B.; Zhang, L.; Miller, W.; Haussler, D. DUPCAR: Reconstructing contiguous ancestral regions with duplications. J. Comput. Biol. 2008, 15, 1007–1027. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  4. Brejová, B.; Gafurov, A.; Pardubská, D.; Sabo, M.; Vinař, T. Isometric gene tree reconciliation revisited. Algorithms Mol. Biol. 2017, 12, 17. [Google Scholar] [CrossRef] [PubMed]
  5. Felsenstein, J. Inferring Phylogenies; Sinauer Associates: Sunderland, MA, USA, 2004. [Google Scholar]
  6. Doyon, J.P.; Ranwez, V.; Daubin, V.; Berry, V. Models, algorithms and programs for phylogeny reconciliation. Brief. Bioinform. 2011, 12, 392–400. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  7. Zhang, L. On a Mirkin-Muchnik-Smith conjecture for comparing molecular phylogenies. J. Comput. Biol. 1997, 4, 177–187. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  8. Eulenstein, O. A Linear Time Algorithm for Tree Mapping; GMD-Forschungszentrum Informationstechnik: Sankt Augustin, Germany, 1997. [Google Scholar]
  9. Górecki, P.; Tiuryn, J. Inferring phylogeny from whole genomes. Bioinformatics 2007, 23, e116–e122. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  10. Emms, D.M.; Kelly, S. STRIDE: Species tree root inference from gene duplication events. Mol. Biol. Evol. 2017, 34, 3267–3278. [Google Scholar] [CrossRef] [PubMed]
  11. Sennblad, B.; Lagergren, J. Probabilistic orthology analysis. Syst. Biol. 2009, 58, 411–424. [Google Scholar] [CrossRef] [PubMed]
  12. Górecki, P.; Burleigh, G.J.; Eulenstein, O. Maximum likelihood models and algorithms for gene tree evolution with duplications and losses. BMC Bioinform. 2011, 12, 1. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  13. Doyon, J.P.; Hamel, S.; Chauve, C. An efficient method for exploring the space of gene tree/species tree reconciliations in a probabilistic framework. IEEE/ACM Trans. Comput. Biol. Bioinform. 2012, 9, 26–39. [Google Scholar] [CrossRef] [PubMed]
  14. Doyon, J.P.; Scornavacca, C.; Gorbunov, K.Y.; Szöllosi, G.J.; Ranwez, V.; Berry, V. An efficient algorithm for gene/species trees parsimonious reconciliation with losses, duplications and transfers. In Comparative Genomics (RECOMB-CG 2012); Springer: Berlin/Heidelberg, Germany, 2010; Volume 6398, pp. 93–108. [Google Scholar]
  15. Bansal, M.S.; Alm, E.J.; Kellis, M. Efficient algorithms for the reconciliation problem with gene duplication, horizontal transfer and loss. Bioinformatics 2012, 28, i283–i291. [Google Scholar] [CrossRef] [PubMed]
  16. Harel, D.; Tarjan, R.E. Fast algorithms for finding nearest common ancestors. SIAM J. Comput. 1984, 13, 338–355. [Google Scholar] [CrossRef] [Green Version]
  17. Bender, M.A.; Farach-Colton, M. The LCA problem revisited. In LATIN 2000: Theoretical Informatics; Springer: Berlin/Heidelberg, Germany, 2000; Volume 1776, pp. 88–94. [Google Scholar]
  18. Saitou, N.; Nei, M. The neighbor-joining method: A new method for reconstructing phylogenetic trees. Mol. Biol. Evol. 1987, 4, 406–425. [Google Scholar] [PubMed]
  19. Górecki, P.; Eulenstein, O.; Tiuryn, J. Unrooted tree reconciliation: A unified approach. IEEE/ACM Trans. Comput. Biol. Bioinform. 2013, 10, 522–536. [Google Scholar] [CrossRef] [PubMed]
Figure 1. An example of a reconciliation of a gene tree and a species tree. Leaves of the gene tree are labeled by the species of origin; for example, b 1 and b 2 are genes from species b. In the history implied by the reconciliation, there was originally a single copy of the gene, which underwent speciation corresponding to nodes q and r and was passed without change to species c. On the other lineage, the gene was first duplicated (node u), and then underwent speciation in node x, followed by one loss in each of the new lineages. As a result, species a had only one copy of the gene. Finally, the gene was again duplicated on the edge leading to b (node v). Note that if u was mapped to node x by the reconciliation, there would be only a single duplication (node v) and no losses in the corresponding history.
Figure 1. An example of a reconciliation of a gene tree and a species tree. Leaves of the gene tree are labeled by the species of origin; for example, b 1 and b 2 are genes from species b. In the history implied by the reconciliation, there was originally a single copy of the gene, which underwent speciation corresponding to nodes q and r and was passed without change to species c. On the other lineage, the gene was first duplicated (node u), and then underwent speciation in node x, followed by one loss in each of the new lineages. As a result, species a had only one copy of the gene. Finally, the gene was again duplicated on the edge leading to b (node v). Note that if u was mapped to node x by the reconciliation, there would be only a single duplication (node v) and no losses in the corresponding history.
Algorithms 13 00225 g001
Figure 2. An example of an isometric reconciliation of two unrooted trees. On the left, the input gene tree G and species tree S are shown, both unrooted. On the right is one possible solution, consisting of rooted trees G O and S O and a mapping between them. The species tree is rooted on edge { x , c } at distance 4 from c. Once the root of S is fixed, the rest of the solution is given uniquely. All possible roots in S are located on the edge { x , c } in distances from 0 to 5 from c. Note that in our algorithm, we preprocess tree S to have two leaves b 1 and b 2 instead of leaf b, so that the leaves of G and S are in one-to-one correspondence (see Section 2.1 and Section 2.8).
Figure 2. An example of an isometric reconciliation of two unrooted trees. On the left, the input gene tree G and species tree S are shown, both unrooted. On the right is one possible solution, consisting of rooted trees G O and S O and a mapping between them. The species tree is rooted on edge { x , c } at distance 4 from c. Once the root of S is fixed, the rest of the solution is given uniquely. All possible roots in S are located on the edge { x , c } in distances from 0 to 5 from c. Note that in our algorithm, we preprocess tree S to have two leaves b 1 and b 2 instead of leaf b, so that the leaves of G and S are in one-to-one correspondence (see Section 2.1 and Section 2.8).
Algorithms 13 00225 g002
Figure 3. An example of two unrooted trees and their isometric reconciliation, in which the root of G O is mapped to a point above the original root of S. Both input trees consist of only a single edge; the length of the edge is greater in G. Tree S can be rooted in any point, while the corresponding roots of G form an interval of length d 1 in the middle of the edge. Valid roots are highlighted in yellow.
Figure 3. An example of two unrooted trees and their isometric reconciliation, in which the root of G O is mapped to a point above the original root of S. Both input trees consist of only a single edge; the length of the edge is greater in G. Tree S can be rooted in any point, while the corresponding roots of G form an interval of length d 1 in the middle of the edge. Valid roots are highlighted in yellow.
Algorithms 13 00225 g003
Figure 4. Construction of representative set A for q from representative sets A 1 = { a 1 , , a g } and A 2 = { b 1 , , b h } . The algorithm in the text considers three different cases depicted from left to right. Construction of set A involves some arbitrary choices; for example, in the first case, a 3 can be replaced in A by b 2 .
Figure 4. Construction of representative set A for q from representative sets A 1 = { a 1 , , a g } and A 2 = { b 1 , , b h } . The algorithm in the text considers three different cases depicted from left to right. Construction of set A involves some arbitrary choices; for example, in the first case, a 3 can be replaced in A by b 2 .
Algorithms 13 00225 g004
Figure 5. Illustration of the algorithm for checking Condition 3 when q q i . We need to check that the path connecting q i and q j is outside G L ( S i ) except for q i . For each leaf a from the representative set A i of q i , we check that between G ( a , q i , q j ) is true. Left: between G ( a , q i , q j ) is true; right: between G ( a , q i , q j ) is false, u G L ( S i ) .
Figure 5. Illustration of the algorithm for checking Condition 3 when q q i . We need to check that the path connecting q i and q j is outside G L ( S i ) except for q i . For each leaf a from the representative set A i of q i , we check that between G ( a , q i , q j ) is true. Left: between G ( a , q i , q j ) is true; right: between G ( a , q i , q j ) is false, u G L ( S i ) .
Algorithms 13 00225 g005
Figure 6. The path containing r 1 , r 2 and r 3 in tree S. Leaves are partitioned into sets A 1 , A 2 and B, where B is in the figure represented by the union B 1 B 2 B k .
Figure 6. The path containing r 1 , r 2 and r 3 in tree S. Leaves are partitioned into sets A 1 , A 2 and B, where B is in the figure represented by the union B 1 B 2 B k .
Algorithms 13 00225 g006
Figure 7. Tree S A ( i ) (left) and tree G A with potential rooting ( q 1 , h 1 ) (right).
Figure 7. Tree S A ( i ) (left) and tree G A with potential rooting ( q 1 , h 1 ) (right).
Algorithms 13 00225 g007

Share and Cite

MDPI and ACS Style

Brejová, B.; Královič, R. A Linear-Time Algorithm for the Isometric Reconciliation of Unrooted Trees. Algorithms 2020, 13, 225. https://0-doi-org.brum.beds.ac.uk/10.3390/a13090225

AMA Style

Brejová B, Královič R. A Linear-Time Algorithm for the Isometric Reconciliation of Unrooted Trees. Algorithms. 2020; 13(9):225. https://0-doi-org.brum.beds.ac.uk/10.3390/a13090225

Chicago/Turabian Style

Brejová, Broňa, and Rastislav Královič. 2020. "A Linear-Time Algorithm for the Isometric Reconciliation of Unrooted Trees" Algorithms 13, no. 9: 225. https://0-doi-org.brum.beds.ac.uk/10.3390/a13090225

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop