Skip to main content
Bioinformatics logoLink to Bioinformatics
. 2022 Jun 27;38(Suppl 1):i413–i421. doi: 10.1093/bioinformatics/btac265

QuCo: quartet-based co-estimation of species trees and gene trees

Maryam Rabiee 1, Siavash Mirarab 2,
PMCID: PMC9235488  PMID: 35758818

Abstract

Motivation

Phylogenomics faces a dilemma: on the one hand, most accurate species and gene tree estimation methods are those that co-estimate them; on the other hand, these co-estimation methods do not scale to moderately large numbers of species. The summary-based methods, which first infer gene trees independently and then combine them, are much more scalable but are prone to gene tree estimation error, which is inevitable when inferring trees from limited-length data. Gene tree estimation error is not just random noise and can create biases such as long-branch attraction.

Results

We introduce a scalable likelihood-based approach to co-estimation under the multi-species coalescent model. The method, called quartet co-estimation (QuCo), takes as input independently inferred distributions over gene trees and computes the most likely species tree topology and internal branch length for each quartet, marginalizing over gene tree topologies and ignoring branch lengths by making several simplifying assumptions. It then updates the gene tree posterior probabilities based on the species tree. The focus on gene tree topologies and the heuristic division to quartets enables fast likelihood calculations. We benchmark our method with extensive simulations for quartet trees in zones known to produce biased species trees and further with larger trees. We also run QuCo on a biological dataset of bees. Our results show better accuracy than the summary-based approach ASTRAL run on estimated gene trees.

Availability and implementation

QuCo is available on https://github.com/maryamrabiee/quco.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

Species tree estimation from multi-locus genome-wide datasets while accounting for gene tree discordance is now routinely attempted. There has been much effort to develop methods that can infer species trees and gene trees accurately, and in particular, methods focused on handling incomplete lineage sorting (ILS) as modeled by multi-species coalescent (MSC) (Rannala et al., 2020) abound (e.g. Chifman and Kubatko, 2014; Liu, 2008; Liu et al., 2010; Mirarab et al., 2014a; Ogilvie et al., 2017; Vachaspati and Warnow, 2015). Yet, a major challenge remains. The most accurate methods for species tree estimation have been Bayesian methods that co-estimate gene trees and species trees, while the most scalable methods have been summary methods that first estimate gene trees independently and then combine them to infer a species tree (Mirarab et al., 2021). This dichotomy has left practitioners with a choice between using methods that can handle large data or more accurate methods that will have to be run on subsets of the data (Smith et al., 2014). Neither solution is ideal.

Theoretical expectations and empirical evidence suggest that inferring all gene trees together should be more accurate than the two-step approach that independently computes gene trees (Bayzid and Warnow, 2013; Dasarathy et al., 2015; Leaché and Rannala, 2011; Ogilvie et al., 2016; Szöllősi et al., 2015). Gene tree estimation from limited-length locus data is error-prone, and gene tree estimation error impacts species trees (Huang et al., 2010; Lanier and Knowles, 2015; Mirarab et al., 2014b; Molloy and Warnow, 2018; Patel, 2013). Importantly, gene tree estimation error is not just random noise and can create biases. Roch et al. (2019) have proved that under challenging cases, long-branch attraction in gene trees could lead to long-branch attraction in species trees and statistically inconsistent estimates. Dealing with gene tree estimation error has motivated several remedies, including binning genes (Bayzid and Warnow, 2013; Mirarab et al., 2014b), collapsing low support branches (OneKP Initiative, 2019; Zhang et al., 2018), and sampling posterior distributions of gene trees (Bossert et al., 2021). However, these methods have their own drawbacks. Binning has the possibility of combining discordant genes, collapsing low support requires selecting a threshold, and simply combining samples from gene tree posteriors as input to summary methods shows mixed results in simulations (Mirarab, 2019). Thus, co-estimation methods are still the ideal option. Yet, current co-estimation methods such as *BEAST (Ogilvie et al., 2017) scale only to tens of species (McCormack et al., 2009).

The scalability of co-estimation methods has remained limited because they address a challenging problem using the slow MCMC process. The space of parameters for the joint species/gene tree inference is extremely large and consists of both discrete (gene tree and species tree topologies) and continuous parameters (per-branch lengths and rates, population sizes, and per-gene transition rate matrices). To explore this large and heterogeneous space to convergence, MCMC needs to run for a long time. Developing theoretically justified scalable co-estimation methods requires simplifying the model and heuristic methods. Wang and Nakhleh (2018) sped up co-estimation by avoiding full sampling of the entire space using an EM-like algorithm that iteratively switches between species tree and gene tree estimation. While this method increased gene tree accuracy, it was not clear that it improved species tree accuracy, perhaps because the estimated species tree was used to improve gene trees.

This article is an attempt at providing a likelihood-based approach to co-estimation under MSC designed to scale using simplifying assumptions and heuristics while keeping a likelihood-based core. We observe that while joint sampling of continuous parameters of gene trees, such as their branch lengths, slows down co-estimation, these are often nuisance parameters. Therefore, we focus on topology, marginalizing over gene tree branch lengths and other continuous parameters. However, this marginalization would still be intractable if done jointly. Instead, we ignore the dependency among substitution unit branch lengths (similar to a no-common-mechanism model) and assume continuous parameters across gene trees are fully unlinked. This admittedly strong assumption enables us to decouple genes. We first use existing methods to estimate gene tree distributions independently across genes, marginalize continuous parameters, and finally infer the species tree jointly. This approach can still be called co-estimation because we combine results from multiple genes and adjust their distribution jointly at the end. This insight is not new for species tree inference (Ané et al., 2007; Larget et al., 2010, pioneered the idea in the method BUCKy) or improving gene trees (Szöllõsi et al., 2013). Finally, building on the success of quartet-based methods for handling ILS (e.g. Chifman and Kubatko, 2014; Mirarab et al., 2014a), we estimate quartet species trees using a likelihood-based approach but combine the quartet species trees heuristically using supertree methods. Lest the reader worries about lowered taxon sampling and increased long branch attraction (LBA) when using quartets, we note that gene tree estimation is performed on the full set of taxa, but the amalgamation step uses induced quartets.

Based on these insights, we introduce a method called quartet-based co-estimation (QuCo for short) that takes as input a Bayesian posterior tree distribution per each of k genes, infers the distribution of quartet trees in that input, and summarizes the posteriors in a 3×k table per quartet. Next, for each quartet of species, it computes the maximum likelihood species tree topology and its single internal branch length in the coalescent unit, marginalizing over gene trees. It then improves the gene tree topologies using the species tree. Finally, it combines the inferred quartet species trees to obtain a final tree topology on the complete set of taxa (Supplementary Fig. S1). We evaluate the method on a set of simulations with four to 101 species and a real bee dataset and show that it increases accuracy while providing a path for scalable co-estimation.

2 Materials and methods

2.1 QuCo: maximum likelihood quartet species trees

We start with the maximum likelihood quartet species tree inference. Throughout, we assume gene trees are made of single-copy orthologous genes and differ due to ILS only, as modeled by MSC. The input to QuCo is the posterior distributions of the gene trees. It computes the maximum likelihood species tree for each quartet of species. Then, using that estimated species tree, it updates the gene tree posterior distributions. While our method for analyzing each quartet is based on likelihood calculations with several simplifying assumptions, to extend to more than four species, we rely on the heuristic method of examining all or a subset of quartets, a procedure we introduce at the end.

2.1.1. Marginalized likelihood of the quartet species trees

For a quartet of species {A,B,C,D}, we denote the three topologies AB|CD,AD|BC,AC|BD by j{1,2,3}. Let D={D1,,Dk} be the set of sequences obtained for each available gene. Given D, we seek to compute the likelihood of the species tree, parameterized by θ=(t,d) where t{1,2,3} is the topology and d is the internal branch length in coalescent unit. This parameterization fully identifies the distribution of unrooted gene tree topologies (Allman et al., 2011). We seek the species tree likelihood marginalized over all possibilities for the k gene trees, and show the log-likelihood function as l(θ;D)=log(P(D;θ)). Let C={1,2,3}k. Any set of k quartet tree topologies, one per gene, can be indexed by a tuple c=(c1,,ck)C. Let the true gene tree topologies be represented by G*=(G1*,,Gk*). Then, our goal is to maximize:

P(D;θ)=cCP(D|G*=c;θ).P(G*=c;θ)=cCP(D|G*=c;θ)sequence  likelihood.i=1kP(Gi*=ci;θ)gene  tree  likelihood, (1)

where the last equation uses the conditional independence of gene trees for a fixed species tree. Working on quartet gene tree topologies makes the calculation of gene tree likelihood trivial. Under the MSC model (Allman et al., 2011; Pamilo and Nei, 1988), for any j{1,2,3}:

P(Gi*=j;θ=(t,d))={12/3ed if j=t1/3ed o.w. (2)

However, working on gene tree topologies (c) makes sequence likelihood calculation challenging because we cannot readily write it as a product over genes. To do so, we need all continuous parameters (gene tree substitution unit branch lengths and rate matrices), which we jointly specify using ri for each gene and r=(r1,,rk). Letting f(r) be the density function,

P(D|G*=c;θ)=rf(r;θ)P(D|r,G*=c;θ)dr=ri=1kf(ri;θ)P(Di|ri,Gi*=ci)dr=ri=1kf(ri;θ)P(ri,Gi*=ci|Di)P(Di)f(Gi*=ci,ri)dr, (3)

where the second equation uses the fact that given all gene tree parameters, gene sequence data are independent of each other and the species tree, and given the species tree, gene trees (thus ri) are independent.

Assumptions. Even for a quartet, computing (3) is not easy. To move forward, we make two assumptions regarding branch lengths. (i) We assume f(Gi*=ci,ri)=13f(ri), which is reasonable by symmetry when the species tree is not given. It requires assuming that a priori all three unrooted gene tree topologies are equiprobable, sequence evolution parameters are independent from gene tree topology, and substitution unit branch lengths are independent from unrooted gene tree topologies. (ii) We assume f(ri;θ)=f(ri). The species tree clearly impacts the distribution of coalescent unit gene tree branch lengths. Typical ways of mapping branch lengths to substitution units assume distributions over population size and mutation rates. These two parameters are ideally drawn per branch, or else gene trees will be ultrametric. When drawn per branch, substitution unit branch lengths are still dependent on the species tree, though the dependence reduces as the variation of rates across branches increase. We assume an extreme case where the mutation rate branch lengths are drawn from distributions independent from the species tree parameter θ. In other words, each branch of the gene tree is assigned a substitution unit length that is independent of the coalescent units length of internal branch (d). We also assume that other continuous parameters (e.g. rate matrices) are either constant across the tree or drawn from distributions independent from θ. These assumptions are not entirely realistic but have the advantage of allowing arbitrary and unlimited deviations from the clock, eliminating the need to assume any clock models. Also, they make (3) tractable. Let P be the 3×k matrix where Pj,i=P(Gi*=j|Di). Then:

P(D|G*=c;θ)=ri=1kf(ri)P(ri,Gi*=ci|Di)P(Di)13f(ri)dr=Ar1=1kP(ri,Gi*=ci|Di)dr=Ai=1kriP(ri,Gi*=ci|Di)dri=Ai=1kP(Gi*=ci|Di)=Ai=1kPci,i

where A=1k3P(Di), and integral and product swap in the third line is possible because no term has two elements of r. Replacing RHS in (1):

P(D;θ)=cCAi=1kPci,iP(Gi*=ci;θ)=Ai=1kj=13Pj,i.P(Gi*=j;θ), (4)

where the second equation uses the fact that for any 3×k matrix (x)j,i, we have cCi=1kxci,i=i=1kj=13xj,i (easy to confirm).

To compute matrix P (posterior gene tree topology probabilities marginalized over branch lengths and substitution parameters), many options are available (Fourment et al., 2020). We mainly take advantage of Bayesian MCMC sampling implemented in standard methods such as MrBayes (Ronquist et al., 2012). Thus, the input to QuCo is a set of k gene tree posterior distributions, each inferred separately on its full set of taxa without a species tree. The fraction of times any tree topology appears in the MCMC chain (after some burnout period) is a valid approximation of its posterior probability, marginalized over branch length and other continuous parameters, giving us all values of P. We also approximate P using normalized quartet log-likelihood as implemented in IQ-TREE (-wql) (Minh et al., 2020). Either way, recalling (2), note that:

j=13Pj,i.P(Gi*=j;θ)=(12/3ed)Pt,i+1/3ed(1Pt,i)=Pt,i+ed(1/3Pt,i)

which, when replaced in (4), gives us the log-likelihood function:

l(θ=(t,d);P)=log(A)+log(i=1k(Pt,i+ed(1/3Pt,i)))=A+i=1klog(Pt,i+ed(1/3Pt,i)), (5)

where A is independent of θ and thus can be ignored. Note that the likelihood is a function of both the topology t and the branch length d.

For each t{1,2,3}, we compute l(t)=argmaxdl((t,d);P) numerically; then, we simply select the topology t with the maximum l(t) value as the species tree. Maximizing the l(θ;P) function numerically is easy because it is twice differentiable and while it is not a convex function of d (the sign of its second derivative changes with different input parameters), we can prove (see Appendix A.1):

Proposition 1.

For a fixedt˜, thel((t˜,d);P)  function (5) can have only one maximizer for0<d<.

Thus, we can seek the global maximum of l((t,d);P) for each t{1,2,3} by simple numerical search using any modern optimizer package. We use scipy.optimize package with the constraint d >0 imposed using the trust-region constrained algorithm (Conn et al., 2000). To help faster convergence, we provide the first and second derivatives of l(.) to the optimizer, as shown in Appendix A.1.1. Finally, we add a small pseudo-count of 108 to every element of P and normalize it appropriately.

2.1.2. Gene tree updates

Once a species tree θ=(t,d) is inferred, QuCo updates the gene tree posterior distribution to:

P(Gi*=j|Di;θ)=Pj,i.P(Gi*=j;θ)a=13Pa,i.P(Gi*=a;θ), (6)

where P(Gi*=a;θ) is computed using (2). This update is what makes the method a co-estimation. Note that this approach is not an iterative method switching between updating gene tree topologies and re-estimating species trees; if attempted, the gene tree updates can only increase the probability of the selected species tree compared to the alternative topologies, and will not lead to a change in the next iteration.

2.1.3. More than four species

To move beyond four species, QuCo uses a heuristic supertree approach that ignores the dependency between quartets and analyzes them independently. We first select a set of quartets such that the resolution of all these quartets (perhaps in addition to auxiliary information such as a guide tree) is sufficient to infer the species tree. The simplest choice is to select all (n4) quartets but we describe an alternative below. Once the set of quartets is selected, QuCo induces all trees in the MCMC samples of all k gene trees down to each selected quartet to compute the quartet posterior probabilities. Thus, for each quartet, a 3×k matrix is obtained. Note that this step, while conceptually simple, needs to process a very large number of trees and thus needs to be implemented with care to obtain high efficiency. Next, for each quartet, we infer the maximum likelihood species tree as described earlier, obtaining a set of quartet species trees. The last step is to combine all the quartet species trees into a full tree using a quartet amalgamation method. While any such method can be used for this step, we will use ASTRAL (as a supertree method, not as a gene summary method) and will show that using wMaxCut (Avni et al., 2015) generates very similar results.

Sampling quartets. For sufficiently small datasets (e.g. <50 species), we afford to examine all the quartets. For larger input, we use a two-step approach. We first run ASTRAL on input gene trees, defined for each gene as the majority-rule consensus (MRC) of the trees in the input distribution for that gene. Next, we contract all the branches in the ASTRAL tree with local-pp support (Sayyari and Mirarab, 2016b) less than a threshold (default: 1.0). We then use an algorithm to sample quartets around polytomies of the resulting multifurcating guide tree, and this strategy focuses the quartet sampling on difficult parts of the tree. For a multifucating node u of degree d, we sample a single species from each side of u (or a uniformly sampled set of 12 sides when d >12), and choose all quartets made with sampled species. To choose a species on each side, we use probabilistic sampling: Rooting the tree at u, we traverse the tree to reach a leaf, at each node choosing a child uniformly at random. The closer the leaf is to the polytomy, the higher the chance we sample it. We repeat the sampling procedure many times, and by default, reduce the rounds proportionally to the degree d (default number of rounds: 1200/d). Note that since each round generates (d4) quartets for d12, we perform fewer rounds for larger d. In the end, in addition to the QuCo-resolved species tree quartets, we give the multifurcating guide tree to the subsequent supertree method (e.g. ASTRAL) as input. Thus, in effect, we use QuCo to resolve polytomies of the input guide tree.

2.2 Simulations

2.2.1. New simulation datasets and protocols

Felsenstein’s zone. Long branch attraction is among the most challenging sources of systematic bias in phylogenomics (Brinkmann et al., 2005; Jeffroy et al., 2006), and Roch et al. (2019) have shown that both summary methods and concatenation are inconsistent under conditions that induce LBA. Thus, we perform simulation studies close to the Felsenstein zone (Felsenstein, 1978) to assess the resiliency of our method to LBA. To do so, we designed a way of simulating gene trees that tend to be in Felsenstein’s zone. First, gene trees in coalescent units are generated according to MSC on a fixed balanced species quartet tree (Fig. 1a). Each branch of the species tree has one of two mutation rates μs and μl assigned to it. Each gene tree branch length is multiplied by the rates of corresponding species branches (a gene tree branch may cover one to three species tree branches) to obtain their length in substitution units. We set μs and μl so that two non-sister terminal branches (B and D) and the internal branch in the unrooted gene trees share a short expected length s and the other two terminal branch lengths have expected length l. Setting μs and μl properly requires a lemma (proved in Appendix A.2):

Fig. 1.

Fig. 1.

Felsenstein’s zone simulation. (a) Each gene tree branch length is scaled by μs and/or μl; for example, the length of the terminal branch of C becomes μlτ1+μsτ2. Rates μs and μl are selected such that terminal branches of A and C in the unrooted gene tree have expected length l, and other branches have expected length s, as shown. (b) MAP gene trees estimated using MrBayes with simulations in Felsenstein’s zone can have large estimation error, especially when l/s is high and sequence lengths (boxes) are short

Lemma 2.

Under MSC, for a balanced quartet species tree with internal branch lengthsd2  (Fig. 1a), the expected length of terminal branch lengths in unrooted gene trees above the speciation nodes isτ2=113ed.

Let τ1 be the fixed coalescent unit terminal branch lengths for all species, and let μl and μs be mutation rates assigned to the tree as shown in Figure 1. The expected substitution unit length of terminal branches of A and C (l) and terminal branches of B and D (s) are: l=μlτ1+μsτ2 and s=μs(τ1+τ2). Thus, we assign μs=sτ1+τ2 and μl=lτ2s/(τ1+τ2)τ1 so that the expected branch lengths are as desired. Finally, note that the expected length of the internal unrooted gene tree branch is 1 in coalescent units and μs in substitution units. To force the expected internal branch length in substitution units to be also s (as in Felsenstein’s zone), we need to set τ1=1τ2=ed3.

With this setting, each simulation is parameterized by the coalescent unit internal branch d (controlling amount of ILS) and expected length of long and short terminal branches, l, s, respectively. LBA is expected for high l/s. We used this simulator to create very hard conditions meant to break methods. We vary l, s, and d in 48 combinations, each with 20 replicate runs. We set d{0.1,0.2,0.3}, which corresponds to 40%, 45%, and 51% of gene trees matching the species tree. We use the Dendropy package (Sukumaran and Holder, 2010) to simulate 500 gene trees (simulated trees are called true gene trees hereafter) under neutral coalescent model conditioned on a species tree shown in Figure 1. For each d, we consider 16 combinations of short and long branch lengths: s{0.01,0.02,0.04,0.08} and l{0.1,0.2,0.3,0.4} and convert gene tree branch lengths to substitution units, as described earlier. Then, we use INDELible (Fletcher and Yang, 2009) to simulate sequences down these trees, setting the sequence length to 200, 400, 800, and 1600 bp. Thus, in total, we have 48 × 4 = 192 model conditions, 3840 replicates, and 1 920 000 gene trees. We infer gene trees using MrBayes and ensure convergence by checking the average SDs of split frequencies, which is less than 0.08 for all runs with 99 percentile equal to 0.025.

We compare QuCo to ASTRAL and BUCKy-quartet (Larget et al., 2010). BUCKy has been shown to have accuracy similar to MSC-based co-estimation methods (Chung and Ané, 2011). As input to ASTRAL, we use maximum a posteriori (MAP) MrBayes. Gene trees estimated using MrBayes from simulated alignments can have high rates of error, depending on l/s and sequence length (Fig. 1b). Note that a random selection of tree topology will still be correct 1/3 of times; thus, the MAP gene trees have more error (due to LBA bias) than randomly estimated trees in some conditions. Moreover, incorrect gene trees are not randomly distributed but are heavily biased towards putting long terminals (A and C) together. Thus, conditions with gene tree error above 1/3 are particularly difficult. Note that here, the ASTRAL tree is equivalent to the most common topology among the MAP gene trees.

Anomaly zone. We simulate a dataset with a 6-taxon caterpillar species tree that based on the calculations presented by Degnan (2013) is in both rooted and unrooted anomaly zone (Supplementary Fig. S2). The anomaly zone refers to species trees that define gene tree distributions where the most likely gene tree is different from the species tree and may present a particularly challenging part of the parameter space (Degnan and Rosenberg, 2006). To make the dataset more realistic, we also create deviations from ultrametricity. We assign substitution unit branch lengths to gene trees by multiplying each coalescent unit length by overall rate 0.02 and a rate multiplier sampled independently from a Gamma distribution with shape and scale set to 5 and 1/5 (mean: 1, variance: 1/5). We generate 10 000 gene trees in total and use INDELible to simulate 600-bp sequences down these trees. We run MrBayes separately on each of these sequences and check convergence by checking the average SDs of split frequencies, which are less than 0.015 for all runs. We divide the 10 000 genes into 50 replicates of 10, 50, 100, and 200 genes, 20 replicates of 500 genes, 10 replicates of 1000 genes, or five replicates of 2000 genes. For each replicate, we run QuCo on all 15 quartets of species and combine them using the exact ASTRAL.

2.2.2. Existing datasets

30-taxon datasets. We reuse a dataset simulated by Mai and Mirarab (2017) using Simphy (Mallo et al., 2016) with three model conditions, and 500 genes, each with 50 replicates (sampled out of 100 original replicates). The three conditions are differentiated by their level of deviations from the molecular clock, as controlled by α, which is the inverse of the variance of the rate multipliers applied to gene tree branch lengths. Because of difficulties in running MrBayes to convergence for all of the 3×500×50=75000 gene trees, we use IQ-TREE instead. We use IQ-TREE -wql option to compute the log-likelihood for all quartet topologies, which we then normalize and exponentiate to approximate posteriors and use as input to QuCo. See Appendix B.1 in Supplementary Material for exact commands. We run QuCo on all (304)=27405 quartets and combine these quartet trees using ASTRAL or wMaxCut.

101-taxon datasets. We use one model condition of a dataset simulated by us and colleagues (Zhang et al., 2018) with 101 taxa, 400-bp sequences, 200 genes, and 30 replicates sampled out of a total of 50 replicates, each with a distinct species tree. The species trees are simulated under the birth-only process with the birth rate 107, fixed haploid Ne of 400K, and the number of generations sampled from a log-normal distribution with the mean 2.5M. The average normalized RF distance between true species trees and true gene trees was in most replicates in the [0.3, 0.6] range, with an average of 0.46. The simulation process is similar to the 30-taxon dataset and uses Simphy and INDELible. We run two chains of MrBayes MCMC for 600 000 generations on each gene alignment. Here, we use the quartet sampling strategy described before.

3 Results

3.1 Simulation results

3.1.1. Felsenstein’s zone simulations

Topological accuracy. QuCo is at least as accurate as and in many conditions far more accurate than ASTRAL in finding the correct topology (Fig. 2a). Across all conditions, QuCo finds the correct tree in 1953 out of 3840 replicates, whereas ASTRAL is correct in 1572 cases. The improvements are most clear in model conditions where l/s=10. For example, with l=10, s=0.2 and 800-bp sequences, QuCo has 100% and 60% accuracy, respectively, with d =0.3 and d =0.2 compared to 65% and 10% for ASTRAL. When s and l are close, both ASTRAL and QuCo work well. For example, both methods recover the true species tree in all replicates when l/s5/2 (top right corner) with d =0.2 or d =0.3 and in most cases for d =0.1. On the other hand, when l/s>20 (bottom left corner), even with 1600-bp sequences, neither method recovers true topology in any replicate; with l/s=20, QuCo recovers the true species tree between 5% and 70% of times if the sequence length is at least 800 bp, but ASTRAL continues to infer the wrong tree in every case.

Fig. 2.

Fig. 2.

Felsenstein’s zone quartet simulations comparing QuCo to ASTRAL (a) or Bucky-Quartet (b). Each box shows a combination of long l (rows) and short s branch lengths (columns), and colors delineate ILS level controlled by d. Each ribbon shows the improvement of QuCo over ASTRAL or BUCKy, all run on MrBayes gene trees. When the ribbon is patterned, BUCKy is better than QuCo

Compared to BUCKy, QuCo shows improvements in many but not all conditions, and improvements are less substantial (Fig. 2b). When ILS is lower (d =0.3), the two methods are identical or similar except in three l, s combinations where QuCo has a substantial advantage for 400 bp or longer alignments and one case where BUCKy has a small advantage with 400-bp alignments. Across all conditions with d =0.3, QuCo is correct in 811 out of 1280 replicates tested, which is 3% higher than BUCKy (788). With d =0.2, the two methods are similar to small advantages for QuCo in nine conditions out of 64 and for BUCKy in four conditions. With the highest level of ILS, QuCo and BUCKy are each substantially better in some conditions. Among all species trees tested, the number of times QuCo is correct is 50 times more than BUCKy.

Consistently through all model conditions, longer sequences (hence more signal) in the gene trees result in more accurate species tree estimation, as expected. When sequence are as short as 200 bp, the correct topology is almost never recovered when l/s10; with 400-bp alignments, all methods fail in most cases when l/s15. Even some difficult cases such as l =0.3, s =0.02 or l =0.4, s =0.04 are rescued when using QuCo and to a lesser degree using BUCKy as long as sequences are sufficiently long; in these conditions, the accuracy can go from zero up to one with d =0.3. The impact of longer sequences is also clearly observed in conditions with moderate l/s (e.g. l=5×s=0.1 or l=5×s=0.2) where close to perfect accuracy is obtained by QuCo and BUCKy but not ASTRAL with 1600-bp sequences even with d =0.1.

As expected, higher levels of ILS (i.e. lower d) make inference harder for both methods. There are, however, conditions where QuCo is quite robust to the level of ILS while ASTRAL is not. For example, for l =0.3, s =0.04, with 1600-bp sequences, QuCo has 70% accuracy for the highest ILS level and 100% in the other cases. In contrast, ASTRAL accuracy degrades with increased ILS (perfect for d =0.3, 85% for d =0.2, and 20% for d =0.1).

Branch lengths. To evaluate the branch length accuracy, we report the ratio between d estimated by QuCo or ASTRAL to the true branch length, only considering cases where the species tree topology is correct. QuCo branch lengths are much closer to true branch lengths than ASTRAL branch lengths with all sequence lengths (Fig. 3). The under-estimation bias of ASTRAL branch lengths as a result of inaccurate gene trees, as shown by Sayyari and Mirarab (2016b), is vastly reduced by QuCo. With the most difficult model conditions, both methods under-estimate the internal branch length while QuCo produces far more accurate estimates. In most model conditions, longer sequences help QuCo to estimate more accurate branch lengths. However, when s =0.08, QuCo can surprisingly over-estimate branch lengths by 12% with 800-bp data.

Fig. 3.

Fig. 3.

Branch length accuracy on Felsenstein’s zone simulations, showing the distribution of estimated branch length divided by true branch length for correctly estimated species tree (the number of such cases shown in each case). Lines show the four quartiles and the dot shows the mean. Each box corresponds to a value of s, combining all l values. See Supplementary Figure S5 for better resolution

Gene tree error. We evaluate gene tree accuracy by comparing how often the MAP estimate is correct before or after the co-estimation update step performed by QuCo using Equation (6). Unlike universal improvements in the species tree accuracy, the gene tree accuracy of QuCo is mixed (Fig. 4). The quartet gene trees produced by QuCo are better than the original MAP gene trees under most conditions where the species trees are improved compared to ASTRAL and under most ‘easy’ conditions where both ASTRAL and QuCo find the correct tree. However, under the most challenging conditions where neither method can find the correct species tree (e.g. for l/s>20), the QuCo gene trees are less accurate than the raw MAP trees. Note that co-estimation by QuCo first computes the species tree and then strictly increases the probability for gene tree topologies that match the species tree at the expense of those that disagree with it. Thus, a reduced gene tree accuracy with incorrect species trees can be expected.

Fig. 4.

Fig. 4.

Gene tree estimation error on Felsenstein’s zone simulations. Each dot corresponds to one model condition, with the x-axis showing the improvement in species tree accuracy by QuCo compared to ASTRAL and the y-axis showing the improvement in the average gene tree accuracy for all genes. The size of dots corresponds to the accuracy of ASTRAL species trees

3.1.2. Anomaly zone

We next test the 6-taxon anomaly zone dataset, where we report the portion of true branches missing in the estimated tree (which is equal to the normalized RF distance because all trees are fully resolved). Here, the error is high for all methods when given tens of genes but decreases quickly when the number of genes increases to hundreds (Fig. 5). As we go to large numbers of genes, we get to zero error with all methods. ASTRAL run on MAP gene trees is slightly less accurate than BUCKy and QuCo, which have similar levels of accuracy. Interestingly, running ASTRAL on MRC gene trees improves its accuracy to levels that match or surpass BUCKy and QuCo.

Fig. 5.

Fig. 5.

Species tree topological error (mean, standard error) under anomaly zone simulations versus the number of genes

3.1.3. 30-taxon datasets

Here, instead of MrBayes, we run QuCo on maximum likelihood (ML) IQ-TREE gene trees. On the larger 30-taxon dataset, depending on the model condition, QuCo+IQ-TREE either matches or improves on the accuracy of ASTRAL+IQ-TREE (Fig. 6). Note that testing BUCKy was not possible for these larger data. The improvements are obtained both for conditions with high and low deviations from the strict clock but are less clear for conditions with moderate deviations. When deviations are high, accuracy improves as a result of increasing the number of gene trees from 200 to 500 for both methods, but the improvements are larger for QuCo (from mean error of 11% to 7% versus from 12% to 10%). Note that the inputs to ASTRAL and QuCo are not identical in this experiment: The ML gene trees are inferred from the entire set of species, whereas quartet tree likelihoods are inferred per quartet. Thus, it is reasonable to expect the input to QuCo to be more prone to LBA than ASTRAL, making it more remarkable that it has a lower error in its output.

Fig. 6.

Fig. 6.

30-taxon dataset. Left: Comparison of the error rate of the species tree generated by running ASTRAL on IQ-Tree ML gene trees and QuCo on IQ-Tree quartet likelihoods with 200 and 500 genes of 30-taxon dataset. The x-axis shows deviation from clock represented by parameter α (inverse of the variance of rate multipliers). Each box is over 50 replicates

On this dataset, we also compare ASTRAL and wMaxCut as supertree methods for the step where quartet species trees are combined (Supplementary Fig. S3). The two ways of combining the quartets are similar to ASTRAL performing slightly better (worse) for low (high) deviations from the clock. We use ASTRAL as the default supertree method elsewhere.

3.1.4. The large 101-taxon dataset

On the larger dataset, where the sampling strategy is necessary, the number of internal nodes in the ASTRAL guide trees ranges from 69 to 84 (mean 78) compared to 99 nodes for a fully resolved tree. Our sampling strategy selects between 3127 and 51 272 quartets (mean: 22 508), which we resolve using QuCo. The polytomies range from small (degree 4) to a maximum degree of 19 (mean: 5), and the guide trees have no incorrect branches. After the polytomies of the guide tree are refined using QuCo, we observe a 12% decrease in the average topological error (Supplementary Table S1) compared to the original ASTRAL tree run on MrBayes MRC gene trees and a 40% decrease compared to ASTRAL run on Fasttree gene trees with branches with bootstrap support below 10% contracted, which is our recommended setting from Zhang et al. (2018). Note that here MAP becomes impossible to estimate; thus, we use the MRC summary instead.

3.2 Application on a biological dataset

We test QuCo on the dataset of Pseudapis genus of bees of Bossert et al. (2021) with 32 species and 1291 UCEs from the subfamily Nomiinae (Halictidae). We use the MrBayes posterior estimations from the original study and run QuCo on all 35 960 quartets. Then, we combine quartets using ASTRAL and enrich its search space with 853 IQ-TREE gene trees.

The species tree that we recover by running QuCo matches the ASTRAL tree reported by Bossert et al. (2021) on gene trees created using Phylobayes, which is designed to reduce LBA (Lartillot et al., 2007). Bossert et al. (2021) have reported 30 ASTRAL trees from gene trees created by ML and Bayesian methods, and these trees differ in five areas compared to the concatenation tree. The tree reported by QuCo differs from concatenation in two nodes and is identical for the other nodes (Supplementary Fig. S4) and also differs from ASTRAL on MrBayes in one of those two nodes. These two nodes involve the two samples with the worst sequencing success, Ruginomia rugiventris and Stictonomia schubotzi. Both of these taxa have over 75% undetermined positions in the concatenated matrix and are present in less than half of all loci, making them hard to place.

4 Discussion

We introduced the algorithm QuCo for quartet co-estimation of species trees and gene trees. We showed that QuCo had better accuracy than ASTRAL in quartet simulations with LBA. By considering gene tree uncertainty, QuCo also outperformed ASTRAL under the anomaly zone simulations when the number of genes was limited. It can be easily proved that if all Pt,i values are either 0 or 1 (i.e. in the absence of gene tree estimation uncertainty), QuCo is equivalent to picking the most frequent quartet as the species tree, as is done in ASTRAL. The improvements, then, are a result of considering gene tree uncertainty. As the number of genes increased, better handling of uncertainty appeared to be less consequential as QuCo and ASTRAL converged in accuracy in the anomaly zone simulations. Compared to the alternative co-estimation method BUCKy, QuCo had a small advantage in accuracy; however, note that BUCKy has limited scalability (Yang and Warnow, 2011).

Despite the fact that the method first infers gene trees independently, it is a co-estimation method because the species tree maximizes the joint likelihood marginalized over all possible gene tree topologies. This marginalization was computationally tractable because we consider quartets independently and can use a simple Equation (2) for the likelihood. The likelihood of gene trees for more taxa is much harder to compute and requires exponential time (Wu, 2012). Alternatively, one can assign branch lengths to gene trees in the same unit as the species tree to make likelihood calculation fast. However, this imposes a different challenge: the need to assume a distribution for mutation rates and population sizes, which further increases the number of parameters that need to be sampled. Many co-estimation methods side-step this challenge by assuming a strict molecular clock, an assumption that decades of research has proved problematic.

By focusing on gene tree topologies and species tree branch length in the coalescent unit, we avoid using a strict gene tree clock model while making the problem easier to solve (i.e. requiring fewer parameters). Our approach did require assuming the independence of substitution branch lengths from the species tree topology and internal branch length. This assumption, which is probably violated on all biological datasets, can be understood as ignoring the shared information about branch lengths across genes. Thus, it makes the co-estimation less powerful than a method that does consider correlation between branch lengths, especially if it can do so under a correct model of rate evolution. However, we note that none of our experimental tests made any such assumptions. Thus, the high empirical performance of the method indicates these assumptions are not lethal; they just may reduce the power of the method in exchange for scalability. Furthermore, the caveat in working with topologies is that QuCo does not output gene tree branch lengths. Moreover, using topologies makes the likelihood calculations fast for four species, and going beyond four species requires the heuristic supertree approach. Thus, our simplifying assumptions have the benefits of: (i) freeing us from assuming restrictive models of rate change across the tree, and (ii) fast calculations of likelihood; however, they also render our method more heuristic than full Bayesian co-estimation methods.

Interestingly, while QuCo clearly increased species tree accuracy, it appeared less effective in increasing gene tree accuracy, especially when the species tree was not improved. This trend is in contrast to some of the existing co-estimation methods, such as the iterative method of Wang and Nakhleh (2018), that are effective in increasing the gene tree accuracy but less so in terms of the species tree. While these patterns call for further study in the future, two points should be emphasized. By marginalizing over gene tree distribution, QuCo can improve the species tree, even when the maximum likelihood gene tree (given the species tree) is not improved. Moreover, when QuCo fails to improve the quartet species tree, it has no chance of improving the gene tree, and in fact, it likely degrades it. Finally, note that QuCo essentially generates a distribution over topologies for each quartet in each gene tree. When more than four species are available, a quartet amalgamation method such as wMaxCut needs to be used to compute the final updated gene trees.

The scalability of QuCo comes from the fact that the inference for each quartet is fast. Given the P matrix, the optimization step takes a fraction of a second per quartet. Even on the 30-taxon data, the optimization step takes close to 1 h across all 27 405 quartets. Given MrBayes outputs, computing P is conceptually easy, and with appropriate implementation, can be fast (with I/O being the bottleneck). The entire running time, including the I/O heavy calculation of P, is still reasonably fast. For example, for the biological dataset with 32 species, QuCo took 12 h to analyze all 35 960 quartets across 1200 genes with no parallelization (mostly calculation of P). This can be run in parallel; using 80 cores, 13 min is enough to analyze all quartets. The final step of combining the quartet trees is also fast, taking 36 s using ASTRAL and only a couple of seconds using wMaxCut. The more time-consuming part of the pipeline, by far, is to run MrBayes on all gene trees. However, this step can be done in parallel and is much more manageable than co-estimation. For example, Bossert et al. (2021) reported that each MrBayes run on 32 taxa took 6.7 min on average. Running methods like MrBayes on thousands of genes with hundreds of species is doable. For even larger datasets where MrBayes may not scale, our results showed that using IQ-TREE quartet likelihoods, which are extremely fast to compute, can be very accurate. To summarize, 101-taxon is by no means the limit of the method.

Analyzing a large number of taxa (e.g. beyond 50) requires quartet selection strategies instead of using all (n4) quartets. Quartet subsampling is a problem that has been studied in the literature (Davidson et al., 2018; Snir et al., 2008) and solutions with quadratic (Sayyari and Mirarab, 2016a) or even quasi-linear (Brown and Truszkowski, 2011) numbers of quartets have been proposed. We left the exploration of such approaches to the future. Instead, we tried a simple method where a guide tree (here, ASTRAL) is estimated and uncertain branches are contracted. The polytomies left in the tree are the difficult parts of the tree, hence our desire to focus the quartet sampling around the polytomies. Our probabilistic leaf sampling strategy uses the well-established insight that short quartets (those with leaves closer to the polytomy) are easier to resolve correctly than long quartets (Erdos et al., 1999; Snir et al., 2008). While our sampling strategy proved effective, we believe better methods may be possible, including those that would guarantee that the number of quartets increases quasi-linearly or quadratically with the number of species.

Data availability

The data underlying this article are available in GitLab at https://gitlab.com/mrabiee/quo-data.

Funding

This work has been supported by the NSF (IIS-1845967) to S.M. and M.R. Computations were performed through XSEDE allocations, which is supported by the NSF (ACI-1053575).

Conflict of Interest: none declared.

Supplementary Material

btac265_Supplementary_Data

Appendix

A.1 Likelihood maximization

Proof of Proposition 1.

We can rewrite (5) without the logarithm as

P(D;θ)=Ai=1k(βi+xαi)

where βi=Pt,i, and αi=1/3Pt,i=1/3βi, and x=ed. Since αis and βis are constant, P(D;θ) is a polynomial in x and can have at most k roots of the form

βiαi=βiβi1/3

and k−1 local optima that must each be between two roots. Note that only valid values of x in our optimization are 0<x<1 corresponding to 0<d<. Thus, we are interested in local optima in that region. However, every root of the form shown is negative when β<1/3 and is >1 for 1/3<βi1. Thus, none the roots are in the 0<x<1 region we are interested in. Since the polynomial has no root in 0 to 1, it can have only one local optimum in that region. Note also that x0 and x1 both result in non-negative likelihood values, and thus, there must be one valid maximizer to the function.

A.1.1 Derivatives

The derivatives of the log likelihood function are given to the optimizer:

l(t,d;P)=i=1k3Pt,i11+3Pt,i(ed1))l(t,d;P)=i=1k3Pt,ied(13Pt,i)(1+3Pt,i(ed1))2

A.2 Simulating long branch attraction with MSC

Proof (sketch), Lemma 2.

Recall the balanced quartet tree with length d2 above the two speciation nodes as shown in Figure 1. By symmetry, all terminal branches have the same length in coalescent units. W.l.o.g., we take branch A. Recall that the probability density function for the coalescence of two lineages in time t before present is given by et in coalescent time units. We compute the expectation by conditioning on three scenarios: (I) lineages A and B coalesce before the root, (II) lineage A and B do not coalesce before the root but lineage C and D do, and (III) neither lineage A and B nor lineages C and D coalesce before the root. Let c3 and c4 be the expected time to coalescence between A and another branch among three and four branches in total, respectively. Then, the expected length of terminal branch of A above its common ancestor with B in the species tree is:

0d2tetdtI+ed2(1ed2)(c3+d2)II+e2d2(c4+d2)III

The first term simply follows from the definition of expectation. The second and third terms first compute the probability of lack of coalescence (ed/2) on one or both sides, and multiple by the expected length in each case. The c3 and c4 terms give the expected length in the root (by definition) and d/2 is added to account for the length on the branch above common ancestor of A and B. We compute c3 again using conditional expectation:

c3=1323+13(13+1+1)=1

The first term conditions on A being the first lineage to coalesce with another (probability 23), and uses the fact that the expected length of the first coalescent among N lineages is 1/(N2)=13. The second term is conditioned on A not being the first lineage to coalesce with another and is computed similarly. In this scenario, A will continue for the first coalescent event (length13), up to the final coalescence 1/(22)=1; we also need to add the length of the branch to the other side of the deepest coalescence because we are dealing with unrooted trees. With similar logic, we can compute:

c4=1612+13(16+13)+16(16+13+1+1)=23

where the three terms correspond to A being the first, the second, and the last branch to coalesce. Replacing these terms in the first equation, we get the expectation equals:

1ed2(1+d2)+ed2(1ed2)(1+d2)+e2d2(23+d2)=1ed3

Contributor Information

Maryam Rabiee, Department of Computer Science and Engineering, University of California, San Diego, La Jolla, CA 92093, USA.

Siavash Mirarab, Department of Electrical and Computer Engineering, University of California, San Diego, La Jolla, CA 92093, USA.

References

  1. Allman E.S.  et al. (2011) Identifying the rooted species tree from the distribution of unrooted gene trees under the coalescent. J. Math. Biol., 62, 833–862. [DOI] [PubMed] [Google Scholar]
  2. Ané C.  et al. (2007) Bayesian estimation of concordance among gene trees. Mol. Biol. Evol., 24, 412–426. [DOI] [PubMed] [Google Scholar]
  3. Avni E.  et al. (2015) Weighted quartets phylogenetics. Syst. Biol., 64, 233–242. [DOI] [PubMed] [Google Scholar]
  4. Bayzid M.S., Warnow T. (2013) Naive binning improves phylogenomic analyses. Bioinformatics, 29, 2277–2284. [DOI] [PubMed] [Google Scholar]
  5. Bossert S.  et al. (2021) Gene tree estimation error with ultraconserved elements: an empirical study on Pseudapis bees. Syst. Biol., 70, 803–821. [DOI] [PubMed] [Google Scholar]
  6. Brinkmann H.  et al. (2005) An empirical assessment of long-branch attraction artefacts in deep eukaryotic phylogenomics. Syst. Biol., 54, 743–757. [DOI] [PubMed] [Google Scholar]
  7. Brown D.G., Truszkowski J. (2011) Towards a Practical O(n Logn) Phylogeny Algorithm. In: Przytycka,T.M. and Sagot,MF. (eds) Algorithms in Bioinformatics. WABI 2011. Lecture Notes in Computer Science, Vol. 6833. Springer, Berlin, Heidelberg. pp. 14–25. https://doi.org/10.1007/978-3-642-23038-7_2. [Google Scholar]
  8. Chifman J., Kubatko L.S. (2014) Quartet inference from SNP data under the coalescent model. Bioinformatics, 30, 3317–3324. [DOI] [PMC free article] [PubMed] [Google Scholar]
  9. Chung Y., Ané C. (2011) Comparing two Bayesian methods for gene tree/species tree reconstruction: simulations with incomplete lineage sorting and horizontal gene transfer. Syst. Biol., 60, 261–275. [DOI] [PubMed] [Google Scholar]
  10. Conn A.R.  et al. (2000). Trust Region Methods. SIAM. Society for Industrial and Applied Mathematics, Philadelphia. [Google Scholar]
  11. Dasarathy G.  et al. (2015) Data requirement for phylogenetic inference from multiple loci: a new distance method. IEEE/ACM Trans. Comput. Biol. Bioinform. 12, 422–432. [DOI] [PubMed] [Google Scholar]
  12. Davidson R.  et al. (2018) Efficient quartet representations of trees and applications to supertree and summary methods. IEEE/ACM Trans. Comput. Biol. Bioinform., 15, 1010–1015. [DOI] [PubMed] [Google Scholar]
  13. Degnan J.H. (2013) Anomalous unrooted gene trees. Syst. Biol., 62, 574–590. [DOI] [PubMed] [Google Scholar]
  14. Degnan J.H., Rosenberg N.A. (2006) Discordance of species trees with their most likely gene trees. PLoS Genet., 2, e68. [DOI] [PMC free article] [PubMed] [Google Scholar]
  15. Erdos P.  et al. (1999) A few logs suffice to build (almost) all trees: part II. Theor. Comput. Sci., 221, 77–118. [Google Scholar]
  16. Felsenstein J. (1978) Cases in which parsimony or compatibility methods will be positively misleading. Syst. Zool., 27, 401–410. [Google Scholar]
  17. Fletcher W., Yang Z. (2009) INDELible: a flexible simulator of biological sequence evolution. Mol. Biol. Evol., 26, 1879–1888. [DOI] [PMC free article] [PubMed] [Google Scholar]
  18. Fourment M.  et al. (2020) 19 Dubious ways to compute the marginal likelihood of a phylogenetic tree topology. Syst. Biol., 69, 209–220. [DOI] [PMC free article] [PubMed] [Google Scholar]
  19. Huang H.  et al. (2010) Sources of error inherent in Species-Tree estimation: impact of mutational and coalescent effects on accuracy and implications for choosing among different methods. Syst. Biol., 59, 573–583. [DOI] [PubMed] [Google Scholar]
  20. Jeffroy O.  et al. (2006) Phylogenomics: the beginning of incongruence?  Trends Genet., 22, 225–231. [DOI] [PubMed] [Google Scholar]
  21. Lanier H.C., Knowles L.L. (2015) Applying species-tree analyses to deep phylogenetic histories: challenges and potential suggested from a survey of empirical phylogenetic studies. Mol. Phylogenet. Evol., 83, 191–199. [DOI] [PubMed] [Google Scholar]
  22. Larget B.R.  et al. (2010) BUCKy: gene tree/species tree reconciliation with Bayesian concordance analysis. Bioinformatics, 26, 2910–2911. [DOI] [PubMed] [Google Scholar]
  23. Lartillot N.  et al. (2007) Suppression of long-branch attraction artefacts in the animal phylogeny using a site-heterogeneous model. BMC Evol. Biol., 7, S4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  24. Leaché A.D., Rannala B. (2011) The accuracy of species tree estimation under simulation: a comparison of methods. Syst. Biol., 60, 126–137. [DOI] [PubMed] [Google Scholar]
  25. Liu L. (2008) BEST: Bayesian estimation of species trees under the coalescent model. Bioinformatics, 24, 2542–2543. [DOI] [PubMed] [Google Scholar]
  26. Liu L.  et al. (2010) A maximum pseudo-likelihood approach for estimating species trees under the coalescent model. BMC Evol. Biol., 10, 302. [DOI] [PMC free article] [PubMed] [Google Scholar]
  27. Mai U., Mirarab S. (2017). TreeShrink: efficient detection of outlier tree leaves. In: Meidanis J., Nakhleh L. (eds) Comparative Genomics. RECOMB-CG 2017. Lecture Notes in Computer Science. Vol. 10562. Springer International Publishing, Cham, pp. 116–140. [Google Scholar]
  28. Mallo D.  et al. (2016) SimPhy: phylogenomic simulation of gene, locus, and species trees. Syst. Biol., 65, 334–344. [DOI] [PMC free article] [PubMed] [Google Scholar]
  29. McCormack J.E.  et al. (2009) Maximum likelihood estimates of species trees: how accuracy of phylogenetic inference depends upon the divergence history and sampling design. Syst. Biol., 58, 501–508. [DOI] [PubMed] [Google Scholar]
  30. Minh B.Q.  et al. (2020) IQ-TREE 2: new models and efficient methods for phylogenetic inference in the genomic era. Mol. Biol. Evol., 37, 1530–1534. [DOI] [PMC free article] [PubMed] [Google Scholar]
  31. Mirarab S. (2019). Species tree estimation using ASTRAL: practical considerations. Arxiv preprint, 1904.03826.
  32. Mirarab S.  et al. (2014a) ASTRAL: genome-scale coalescent-based species tree estimation. Bioinformatics, 30, i541–i548. [DOI] [PMC free article] [PubMed] [Google Scholar]
  33. Mirarab S.  et al. (2014b) Statistical binning enables an accurate coalescent-based estimation of the avian tree. Science, 346, 1250463–1250463. [DOI] [PubMed] [Google Scholar]
  34. Mirarab S.  et al. (2021) Multispecies coalescent: theory and applications in phylogenetics. Annu. Rev. Ecol. Evol. Syst., 52, 247–268. [Google Scholar]
  35. Molloy E.K., Warnow T. (2018) To include or not to include: the impact of gene filtering on species tree estimation methods. Syst. Biol., 67, 285–303. [DOI] [PubMed] [Google Scholar]
  36. ΡOgilvie H.A.  et al. (2016) Computational performance and statistical accuracy of *BEAST and comparisons with other methods. Syst. Biol., 65, 381–396. [DOI] [PMC free article] [PubMed] [Google Scholar]
  37. Ogilvie H.A.  et al. (2017) StarBEAST2 brings faster species tree inference and accurate estimates of substitution rates. Mol. Biol. Evol., 34, 2101–2114. [DOI] [PMC free article] [PubMed] [Google Scholar]
  38. OneKP Initiative. (2019) One thousand plant transcriptomes and the phylogenomics of green plants. Nature, 574, 679–685. [DOI] [PMC free article] [PubMed] [Google Scholar]
  39. Pamilo P., Nei M. (1988) Relationships between gene trees and species trees. Mol. Biol. Evol., 5, 568–583. [DOI] [PubMed] [Google Scholar]
  40. Patel S. (2013) Error in phylogenetic estimation for bushes in the tree of life. Phylogenet. Evol., 01, 110. [Google Scholar]
  41. Rannala B.  et al. (2020). The multi-species coalescent model and species tree inference. In: Scornavacca C., Delsuc F., Galtier N. (eds.) Phylogenetics in the Genomic Era. pp. 3.3:1–3.3:21. No commercial publisher | Authors open access book. [Google Scholar]
  42. Roch S.  et al. (2019) Long-branch attraction in species tree estimation: inconsistency of partitioned likelihood and topology-based summary methods. Syst. Biol., 68, 281–297. [DOI] [PubMed] [Google Scholar]
  43. Ronquist F.  et al. (2012) MrBayes 3.2: efficient Bayesian phylogenetic inference and model choice across a large model space. Syst. Biol., 61, 539–542. [DOI] [PMC free article] [PubMed] [Google Scholar]
  44. Sayyari E., Mirarab S. (2016a) Anchoring quartet-based phylogenetic distances and applications to species tree reconstruction. BMC Genomics, 17, 101–113. [DOI] [PMC free article] [PubMed] [Google Scholar]
  45. Sayyari E., Mirarab S. (2016b) Fast coalescent-based computation of local branch support from quartet frequencies. Mol. Biol. Evol., 33, 1654–1668. [DOI] [PMC free article] [PubMed] [Google Scholar]
  46. Smith B.T.  et al. (2014) Target capture and massively parallel sequencing of ultraconserved elements for comparative studies at shallow evolutionary time scales. Syst. Biol., 63, 83–95. [DOI] [PubMed] [Google Scholar]
  47. Snir S.  et al. (2008) Short quartet puzzling: a new quartet-based phylogeny reconstruction algorithm. J. Comput. Biol., 15, 91–103. [DOI] [PubMed] [Google Scholar]
  48. Sukumaran J., Holder M.T. (2010) DendroPy: a python library for phylogenetic computing. Bioinformatics, 26, 1569–1571. [DOI] [PubMed] [Google Scholar]
  49. Szöllõsi G.J.  et al. (2013) Efficient exploration of the space of reconciled gene trees. Syst. Biol., 62, 901–912. [DOI] [PMC free article] [PubMed] [Google Scholar]
  50. Szöllősi G.J.  et al. (2015) The inference of gene trees with species trees. Syst. Biol., 64, e42–e62. [DOI] [PMC free article] [PubMed] [Google Scholar]
  51. Vachaspati P., Warnow T. (2015) ASTRID: accurate species TRees from internode distances. BMC Genomics, 16, S3. [DOI] [PMC free article] [PubMed] [Google Scholar]
  52. Wang Y., Nakhleh L. (2018) Towards an accurate and efficient heuristic for species/gene tree co-estimation. Bioinformatics, 34, i697–i705. [DOI] [PubMed] [Google Scholar]
  53. Wu Y. (2012) Coalescent-based species tree inference from gene tree topologies under incomplete lineage sorting by maximum likelihood. Evolution, 66, 763–775. [DOI] [PubMed] [Google Scholar]
  54. Yang J., Warnow T. (2011) Fast and accurate methods for phylogenomic analyses. BMC Bioinformatics, 12, S4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  55. Zhang C.  et al. (2018) ASTRAL-III: polynomial time species tree reconstruction from partially resolved gene trees. BMC Bioinformatics, 19, 153. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

btac265_Supplementary_Data

Data Availability Statement

The data underlying this article are available in GitLab at https://gitlab.com/mrabiee/quo-data.


Articles from Bioinformatics are provided here courtesy of Oxford University Press

RESOURCES