Bayesian inference in phylogeny

Last updated
Bayesian inference in phylogeny
Classification Evolutionary biology
Subclassification Molecular phylogenetics
Optimally search criteria Bayesian inference

Bayesian inference of phylogeny combines the information in the prior and in the data likelihood to create the so-called posterior probability of trees, which is the probability that the tree is correct given the data, the prior and the likelihood model. Bayesian inference was introduced into molecular phylogenetics in the 1990s by three independent groups: Bruce Rannala and Ziheng Yang in Berkeley, [1] [2] Bob Mau in Madison, [3] and Shuying Li in University of Iowa, [4] the last two being PhD students at the time. The approach has become very popular since the release of the MrBayes software in 2001, [5] and is now one of the most popular methods in molecular phylogenetics.

Contents

Bayesian inference of phylogeny background and bases

Bayes' Theorem Bayes' Theorem MMB 01.jpg
Bayes' Theorem
Metaphor illustrating MCMC method steps Robot metaphor.png
Metaphor illustrating MCMC method steps

Bayesian inference refers to a probabilistic method developed by Reverend Thomas Bayes based on Bayes' theorem. Published posthumously in 1763 it was the first expression of inverse probability and the basis of Bayesian inference. Independently, unaware of Bayes' work, Pierre-Simon Laplace developed Bayes' theorem in 1774. [6]

Bayesian inference or the inverse probability method was the standard approach in statistical thinking until the early 1900s before RA Fisher developed what's now known as the classical/frequentist/Fisherian inference. Computational difficulties and philosophical objections had prevented the widespread adoption of the Bayesian approach until the 1990s, when Markov Chain Monte Carlo (MCMC) algorithms revolutionized Bayesian computation.

The Bayesian approach to phylogenetic reconstruction combines the prior probability of a tree P(A) with the likelihood of the data (B) to produce a posterior probability distribution on trees P(A|B). [7] The posterior probability of a tree will be the probability that the tree is correct, given the prior, the data, and the correctness of the likelihood model.

MCMC methods can be described in three steps: first using a stochastic mechanism a new state for the Markov chain is proposed. Secondly, the probability of this new state to be correct is calculated. Thirdly, a new random variable (0,1) is proposed. If this new value is less than the acceptance probability the new state is accepted and the state of the chain is updated. This process is run thousands or millions of times. The number of times a single tree is visited during the course of the chain is an approximation of its posterior probability. Some of the most common algorithms used in MCMC methods include the Metropolis–Hastings algorithms, the Metropolis-Coupling MCMC (MC³) and the LOCAL algorithm of Larget and Simon.

Metropolis–Hastings algorithm

One of the most common MCMC methods used is the Metropolis–Hastings algorithm, [8] a modified version of the original Metropolis algorithm. [9] It is a widely used method to sample randomly from complicated and multi-dimensional distribution probabilities. The Metropolis algorithm is described in the following steps: [10] [11]

  1. An initial tree, Ti, is randomly selected.
  2. A neighbour tree, Tj, is selected from the collection of trees.
  3. The ratio, R, of the probabilities (or probability density functions) of Tj and Ti is computed as follows: R = f(Tj)/f(Ti)
  4. If R ≥ 1, Tj is accepted as the current tree.
  5. If R < 1, Tj is accepted as the current tree with probability R, otherwise Ti is kept.
  6. At this point the process is repeated from Step 2 N times.

The algorithm keeps running until it reaches an equilibrium distribution. It also assumes that the probability of proposing a new tree Tj when we are at the old tree state Ti, is the same probability of proposing Ti when we are at Tj. When this is not the case Hastings corrections are applied. The aim of Metropolis-Hastings algorithm is to produce a collection of states with a determined distribution until the Markov process reaches a stationary distribution. The algorithm has two components:

  1. A potential transition from one state to another (i → j) using a transition probability function qi,j
  2. Movement of the chain to state j with probability αi,j and remains in i with probability 1 – αi,j. [2]

Metropolis-coupled MCMC

Metropolis-coupled MCMC algorithm (MC³) [12] has been proposed to solve a practical concern of the Markov chain moving across peaks when the target distribution has multiple local peaks, separated by low valleys, are known to exist in the tree space. This is the case during heuristic tree search under maximum parsimony (MP), maximum likelihood (ML), and minimum evolution (ME) criteria, and the same can be expected for stochastic tree search using MCMC. This problem will result in samples not approximating correctly to the posterior density. The (MC³) improves the mixing of Markov chains in presence of multiple local peaks in the posterior density. It runs multiple (m) chains in parallel, each for n iterations and with different stationary distributions , , where the first one, is the target density, while , are chosen to improve mixing. For example, one can choose incremental heating of the form:

so that the first chain is the cold chain with the correct target density, while chains are heated chains. Note that raising the density to the power with has the effect of flattening out the distribution, similar to heating a metal. In such a distribution, it is easier to traverse between peaks (separated by valleys) than in the original distribution. After each iteration, a swap of states between two randomly chosen chains is proposed through a Metropolis-type step. Let be the current state in chain , . A swap between the states of chains and is accepted with probability:

At the end of the run, output from only the cold chain is used, while those from the hot chains are discarded. Heuristically, the hot chains will visit the local peaks rather easily, and swapping states between chains will let the cold chain occasionally jump valleys, leading to better mixing. However, if is unstable, proposed swaps will seldom be accepted. This is the reason for using several chains which differ only incrementally.

An obvious disadvantage of the algorithm is that chains are run and only one chain is used for inference. For this reason, is ideally suited for implementation on parallel machines, since each chain will in general require the same amount of computation per iteration.

LOCAL algorithm of Larget and Simon

The LOCAL algorithms [13] offers a computational advantage over previous methods and demonstrates that a Bayesian approach is able to assess uncertainty computationally practical in larger trees. The LOCAL algorithm is an improvement of the GLOBAL algorithm presented in Mau, Newton and Larget (1999) [14] in which all branch lengths are changed in every cycle. The LOCAL algorithms modifies the tree by selecting an internal branch of the tree at random. The nodes at the ends of this branch are each connected to two other branches. One of each pair is chosen at random. Imagine taking these three selected edges and stringing them like a clothesline from left to right, where the direction (left/right) is also selected at random. The two endpoints of the first branch selected will have a sub-tree hanging like a piece of clothing strung to the line. The algorithm proceeds by multiplying the three selected branches by a common random amount, akin to stretching or shrinking the clothesline. Finally the leftmost of the two hanging sub-trees is disconnected and reattached to the clothesline at a location selected uniformly at random. This would be the candidate tree.

Suppose we began by selecting the internal branch with length that separates taxa and from the rest. Suppose also that we have (randomly) selected branches with lengths and from each side, and that we oriented these branches. Let , be the current length of the clothesline. We select the new length to be , where is a uniform random variable on . Then for the LOCAL algorithm, the acceptance probability can be computed to be:

Assessing convergence

To estimate a branch length of a 2-taxon tree under JC, in which sites are unvaried and are variable, assume exponential prior distribution with rate . The density is . The probabilities of the possible site patterns are:

for unvaried sites, and

Thus the unnormalized posterior distribution is:

or, alternately,

Update branch length by choosing new value uniformly at random from a window of half-width centered at the current value:

where is uniformly distributed between and . The acceptance probability is:

Example: , . We will compare results for two values of , and . In each case, we will begin with an initial length of and update the length times.

Maximum parsimony and maximum likelihood

Tiger phylogenetic relationships, bootstrap values shown in branches. Tiger phylogenetic relationships.png
Tiger phylogenetic relationships, bootstrap values shown in branches.
Example of long branch attraction. Longer branches (A & C) appear to be more closely related. LongBranch.png
Example of long branch attraction. Longer branches (A & C) appear to be more closely related. 

There are many approaches to reconstructing phylogenetic trees, each with advantages and disadvantages, and there is no straightforward answer to “what is the best method?”. Maximum parsimony (MP) and maximum likelihood (ML) are traditional methods widely used for the estimation of phylogenies and both use character information directly, as Bayesian methods do.

Maximum Parsimony recovers one or more optimal trees based on a matrix of discrete characters for a certain group of taxa and it does not require a model of evolutionary change. MP gives the most simple explanation for a given set of data, reconstructing a phylogenetic tree that includes as few changes across the sequences as possible. The support of the tree branches is represented by bootstrap percentage. For the same reason that it has been widely used, its simplicity, MP has also received criticism and has been pushed into the background by ML and Bayesian methods. MP presents several problems and limitations. As shown by Felsenstein (1978), MP might be statistically inconsistent, [15] meaning that as more and more data (e.g. sequence length) is accumulated, results can converge on an incorrect tree and lead to long branch attraction, a phylogenetic phenomenon where taxa with long branches (numerous character state changes) tend to appear more closely related in the phylogeny than they really are. For morphological data, recent simulation studies suggest that parsimony may be less accurate than trees built using Bayesian approaches, [16] potentially due to overprecision, [17] although this has been disputed. [18] Studies using novel simulation methods have demonstrated that differences between inference methods result from the search strategy and consensus method employed, rather than the optimization used. [19]

As in maximum parsimony, maximum likelihood will evaluate alternative trees. However it considers the probability of each tree explaining the given data based on a model of evolution. In this case, the tree with the highest probability of explaining the data is chosen over the other ones. [20] In other words, it compares how different trees predict the observed data. The introduction of a model of evolution in ML analyses presents an advantage over MP as the probability of nucleotide substitutions and rates of these substitutions are taken into account, explaining the phylogenetic relationships of taxa in a more realistic way. An important consideration of this method is the branch length, which parsimony ignores, with changes being more likely to happen along long branches than short ones. This approach might eliminate long branch attraction and explain the greater consistency of ML over MP. Although considered by many to be the best approach to inferring phylogenies from a theoretical point of view, ML is computationally intensive and it is almost impossible to explore all trees as there are too many. Bayesian inference also incorporates a model of evolution and the main advantages over MP and ML are that it is computationally more efficient than traditional methods, it quantifies and addresses the source of uncertainty and is able to incorporate complex models of evolution.

Pitfalls and controversies

MrBayes software

MrBayes is a free software tool that performs Bayesian inference of phylogeny. It was originally written by John P. Huelsenbeck and Frederik Ronquist in 2001. [28] As Bayesian methods increased in popularity, MrBayes became one of the software of choice for many molecular phylogeneticists. It is offered for Macintosh, Windows, and UNIX operating systems and it has a command-line interface. The program uses the standard MCMC algorithm as well as the Metropolis coupled MCMC variant. MrBayes reads aligned matrices of sequences (DNA or amino acids) in the standard NEXUS format. [29]

MrBayes uses MCMC to approximate the posterior probabilities of trees. [9] The user can change assumptions of the substitution model, priors and the details of the MC³ analysis. It also allows the user to remove and add taxa and characters to the analysis. The program includes, among several nucleotide models, the most standard model of DNA substitution, the 4x4 also called JC69, which assumes that changes across nucleotides occur with equal probability. [30] It also implements a number of 20x20 models of amino acid substitution, and codon models of DNA substitution. It offers different methods for relaxing the assumption of equal substitutions rates across nucleotide sites. [31] MrBayes is also able to infer ancestral states accommodating uncertainty to the phylogenetic tree and model parameters.

MrBayes 3 [32] was a completely reorganized and restructured version of the original MrBayes. The main novelty was the ability of the software to accommodate heterogeneity of data sets. This new framework allows the user to mix models and take advantages of the efficiency of Bayesian MCMC analysis when dealing with different type of data (e.g. protein, nucleotide, and morphological). It uses the Metropolis-Coupling MCMC by default.

MrBayes 3.2 was released in 2012 [33] The new version allows the users to run multiple analyses in parallel. It also provides faster likelihood calculations and allow these calculations to be delegated to graphics processing unites (GPUs). Version 3.2 provides wider outputs options compatible with FigTree and other tree viewers.

List of phylogenetics software

This table includes some of the most common phylogenetic software used for inferring phylogenies under a Bayesian framework. Some of them do not use exclusively Bayesian methods.

NameDescriptionMethodAuthorWebsite link
MrBayesPhylogenetic inferenceA program for Bayesian inference and model choice across a wide range of phylogenetic and evolutionary models.Zangh, Huelsenbeck, Der Mark, Ronquist & Teslenko https://nbisweden.github.io/MrBayes/
BEASTBayesian Evolutionary Analysis Sampling TreesBayesian inference, relaxed molecular clock, demographic historyA. J. Drummond, A. Rambaut & M. A. Suchard [34] https://beast.community
BEAST 2 A software platform for Bayesian evolutionary analysisBayesian inference, packages, multiple modelsR Bouckaert, J Heled, D Kühnert, T Vaughan, CH Wu, D Xie, MA Suchard, A Rambaut, AJ Drummond. [35] http://www.beast2.org
PhyloBayes / PhyloBayes MPIBayesian Monte Carlo Markov Chain (MCMC) sampler for phylogenetic reconstruction.Non-parametric methods for modeling among-site variation in nucleotide or amino-acid propensities.N. Lartillot, N. Rodrigue, D. Stubbs, J. Richer [36] http://www.atgc-montpellier.fr/phylobayes/
Bali-PhySimultaneous Bayesian inference of alignment and phylogenyBayesian inference, alignment as well as tree searchSuchard MA, Redelings BD [37] http://www.bali-phy.org
BUCKyBayesian concordance of gene treesBayesian concordance using modified greedy consensus of unrooted quartets C. Ané, B. Larget, D.A. Baum, S.D. Smith, A. Rokas and B. Larget, S.K. Kotha, C.N. Dewey, C. Ané [38] http://www.stat.wisc.edu/~ane/bucky/
BATWINGBayesian Analysis of Trees With Internal Node GenerationBayesian inference, demographic history, population splitsI. J. Wilson, D. Weale, D.Balding [39] http://www.maths.abdn.ac.uk/˜ijw%5B%5D
Bayes PhylogeniesBayesian inference of trees using Markov Chain Monte Carlo methodsBayesian inference, multiple models, mixture model (auto-partitioning)M. Pagel, A. Meade [40] http://www.evolution.rdg.ac.uk/BayesPhy.html Archived 2020-02-19 at the Wayback Machine
Armadillo Workflow PlatformWorkflow platform dedicated to phylogenetic and general bioinformatic analysisGUI wrapper around MrBayesE. Lord, M. Leclercq, A. Boc, A.B. Diallo and V. Makarenkov [41] https://github.com/armadilloUQAM/armadillo2/
Geneious (MrBayes plugin)Geneious provides genome and proteome research toolsGUI wrapper around MrBayesA. J. Drummond,M.Suchard,V.Lefort et al. http://www.geneious.com
TOPALiPhylogenetic inferenceGUI wrapper around MrBayesI.Milne, D.Lindner, et al. [42] http://www.topali.org

Applications

Bayesian Inference has extensively been used by molecular phylogeneticists for a wide number of applications. Some of these include:

Chronogram obtained from molecular clock analysis using BEAST. Pie chart in each node indicates the possible ancestral distributions inferred from Bayesian Binary MCMC analysis (BBM) Divergence time estimation and ancestral area reconstruction of porcini s.s..png
Chronogram obtained from molecular clock analysis using BEAST. Pie chart in each node indicates the possible ancestral distributions inferred from Bayesian Binary MCMC analysis (BBM)

Related Research Articles

In biology, phylogenetics is the study of the evolutionary history and relationships among or within groups of organisms. These relationships are determined by phylogenetic inference methods that focus on observed heritable traits, such as DNA sequences, protein amino acid sequences, or morphology. The result of such an analysis is a phylogenetic tree—a diagram containing a hypothesis of relationships that reflects the evolutionary history of a group of organisms.

<span class="mw-page-title-main">Cladogram</span> Diagram used to show relations among groups of organisms with common origins

A cladogram is a diagram used in cladistics to show relations among organisms. A cladogram is not, however, an evolutionary tree because it does not show how ancestors are related to descendants, nor does it show how much they have changed, so many differing evolutionary trees can be consistent with the same cladogram. A cladogram uses lines that branch off in different directions ending at a clade, a group of organisms with a last common ancestor. There are many shapes of cladograms but they all have lines that branch off from other lines. The lines can be traced back to where they branch off. These branching off points represent a hypothetical ancestor which can be inferred to exhibit the traits shared among the terminal taxa above it. This hypothetical ancestor might then provide clues about the order of evolution of various features, adaptation, and other evolutionary narratives about ancestors. Although traditionally such cladograms were generated largely on the basis of morphological characters, DNA and RNA sequencing data and computational phylogenetics are now very commonly used in the generation of cladograms, either on their own or in combination with morphology.

A hidden Markov model (HMM) is a Markov model in which the observations are dependent on a latent Markov process. An HMM requires that there be an observable process whose outcomes depend on the outcomes of in a known way. Since cannot be observed directly, the goal is to learn about state of by observing By definition of being a Markov model, an HMM has an additional requirement that the outcome of at time must be "influenced" exclusively by the outcome of at and that the outcomes of and at must be conditionally independent of at given at time Estimation of the parameters in an HMM can be performed using maximum likelihood. For linear chain HMMs, the Baum–Welch algorithm can be used to estimate the parameters.

A phylogenetic tree, phylogeny or evolutionary tree is a graphical representation which shows the evolutionary history between a set of species or taxa during a specific time. In other words, it is a branching diagram or a tree showing the evolutionary relationships among various biological species or other entities based upon similarities and differences in their physical or genetic characteristics. In evolutionary biology, all life on Earth is theoretically part of a single phylogenetic tree, indicating common ancestry. Phylogenetics is the study of phylogenetic trees. The main challenge is to find a phylogenetic tree representing optimal evolutionary ancestry between a set of species or taxa. Computational phylogenetics focuses on the algorithms involved in finding optimal phylogenetic tree in the phylogenetic landscape.

A Bayesian network is a probabilistic graphical model that represents a set of variables and their conditional dependencies via a directed acyclic graph (DAG). While it is one of several forms of causal notation, causal networks are special cases of Bayesian networks. Bayesian networks are ideal for taking an event that occurred and predicting the likelihood that any one of several possible known causes was the contributing factor. For example, a Bayesian network could represent the probabilistic relationships between diseases and symptoms. Given symptoms, the network can be used to compute the probabilities of the presence of various diseases.

In statistics, Markov chain Monte Carlo (MCMC) methods comprise a class of algorithms for sampling from a probability distribution. By constructing a Markov chain that has the desired distribution as its equilibrium distribution, one can obtain a sample of the desired distribution by recording states from the chain. The more steps that are included, the more closely the distribution of the sample matches the actual desired distribution. Various algorithms exist for constructing chains, including the Metropolis–Hastings algorithm.

Bayesian statistics is a theory in the field of statistics based on the Bayesian interpretation of probability where probability expresses a degree of belief in an event. The degree of belief may be based on prior knowledge about the event, such as the results of previous experiments, or on personal beliefs about the event. This differs from a number of other interpretations of probability, such as the frequentist interpretation that views probability as the limit of the relative frequency of an event after many trials. More concretely, analysis in Bayesian methods codifies prior knowledge in the form of a prior distribution.

In phylogenetics and computational phylogenetics, maximum parsimony is an optimality criterion under which the phylogenetic tree that minimizes the total number of character-state changes. Under the maximum-parsimony criterion, the optimal tree will minimize the amount of homoplasy. In other words, under this criterion, the shortest possible tree that explains the data is considered best. Some of the basic ideas behind maximum parsimony were presented by James S. Farris in 1970 and Walter M. Fitch in 1971.

<span class="mw-page-title-main">Substitution model</span> Description of the process by which states in sequences change into each other and back

In biology, a substitution model, also called models of DNA sequence evolution, are Markov models that describe changes over evolutionary time. These models describe evolutionary changes in macromolecules represented as sequence of symbols. Substitution models are used to calculate the likelihood of phylogenetic trees using multiple sequence alignment data. Thus, substitution models are central to maximum likelihood estimation of phylogeny as well as Bayesian inference in phylogeny. Estimates of evolutionary distances are typically calculated using substitution models. Substitution models are also central to phylogenetic invariants because they are necessary to predict site pattern frequencies given a tree topology. Substitution models are also necessary to simulate sequence data for a group of organisms related by a specific tree.

Coalescent theory is a model of how alleles sampled from a population may have originated from a common ancestor. In the simplest case, coalescent theory assumes no recombination, no natural selection, and no gene flow or population structure, meaning that each variant is equally likely to have been passed from one generation to the next. The model looks backward in time, merging alleles into a single ancestral copy according to a random process in coalescence events. Under this model, the expected time between successive coalescence events increases almost exponentially back in time. Variance in the model comes from both the random passing of alleles from one generation to the next, and the random occurrence of mutations in these alleles.

Computational phylogenetics, phylogeny inference, or phylogenetic inference focuses on computational and optimization algorithms, heuristics, and approaches involved in phylogenetic analyses. The goal is to find a phylogenetic tree representing optimal evolutionary ancestry between a set of genes, species, or taxa. Maximum likelihood, parsimony, Bayesian, and minimum evolution are typical optimality criteria used to assess how well a phylogenetic tree topology describes the sequence data. Nearest Neighbour Interchange (NNI), Subtree Prune and Regraft (SPR), and Tree Bisection and Reconnection (TBR), known as tree rearrangements, are deterministic algorithms to search for optimal or the best phylogenetic tree. The space and the landscape of searching for the optimal phylogenetic tree is known as phylogeny search space.

Ancestral reconstruction is the extrapolation back in time from measured characteristics of individuals, populations, or specie to their common ancestors. It is an important application of phylogenetics, the reconstruction and study of the evolutionary relationships among individuals, populations or species to their ancestors. In the context of evolutionary biology, ancestral reconstruction can be used to recover different kinds of ancestral character states of organisms that lived millions of years ago. These states include the genetic sequence, the amino acid sequence of a protein, the composition of a genome, a measurable characteristic of an organism (phenotype), and the geographic range of an ancestral population or species. This is desirable because it allows us to examine parts of phylogenetic trees corresponding to the distant past, clarifying the evolutionary history of the species in the tree. Since modern genetic sequences are essentially a variation of ancient ones, access to ancient sequences may identify other variations and organisms which could have arisen from those sequences. In addition to genetic sequences, one might attempt to track the changing of one character trait to another, such as fins turning to legs.

Approximate Bayesian computation (ABC) constitutes a class of computational methods rooted in Bayesian statistics that can be used to estimate the posterior distributions of model parameters.

Ziheng Yang FRS is a Chinese biologist. He holds the R.A. Fisher Chair of Statistical Genetics at University College London, and is the Director of R.A. Fisher Centre for Computational Biology at UCL. He was elected a Fellow of the Royal Society in 2006.

Horizontal or lateral gene transfer is the transmission of portions of genomic DNA between organisms through a process decoupled from vertical inheritance. In the presence of HGT events, different fragments of the genome are the result of different evolutionary histories. This can therefore complicate investigations of the evolutionary relatedness of lineages and species. Also, as HGT can bring into genomes radically different genotypes from distant lineages, or even new genes bearing new functions, it is a major source of phenotypic innovation and a mechanism of niche adaptation. For example, of particular relevance to human health is the lateral transfer of antibiotic resistance and pathogenicity determinants, leading to the emergence of pathogenic lineages.

Multispecies Coalescent Process is a stochastic process model that describes the genealogical relationships for a sample of DNA sequences taken from several species. It represents the application of coalescent theory to the case of multiple species. The multispecies coalescent results in cases where the relationships among species for an individual gene can differ from the broader history of the species. It has important implications for the theory and practice of phylogenetics and for understanding genome evolution.

Phylogenetic invariants are polynomial relationships between the frequencies of various site patterns in an idealized DNA multiple sequence alignment. They have received substantial study in the field of biomathematics, and they can be used to choose among phylogenetic tree topologies in an empirical setting. The primary advantage of phylogenetic invariants relative to other methods of phylogenetic estimation like maximum likelihood or Bayesian MCMC analyses is that invariants can yield information about the tree without requiring the estimation of branch lengths of model parameters. The idea of using phylogenetic invariants was introduced independently by James Cavender and Joseph Felsenstein and by James A. Lake in 1987.

<span class="mw-page-title-main">Phylogenetic reconciliation</span> Technique in evolutionary study

In phylogenetics, reconciliation is an approach to connect the history of two or more coevolving biological entities. The general idea of reconciliation is that a phylogenetic tree representing the evolution of an entity can be drawn within another phylogenetic tree representing an encompassing entity to reveal their interdependence and the evolutionary events that have marked their shared history. The development of reconciliation approaches started in the 1980s, mainly to depict the coevolution of a gene and a genome, and of a host and a symbiont, which can be mutualist, commensalist or parasitic. It has also been used for example to detect horizontal gene transfer, or understand the dynamics of genome evolution.

In the field of epidemiology, source attribution refers to a category of methods with the objective of reconstructing the transmission of an infectious disease from a specific source, such as a population, individual, or location. For example, source attribution methods may be used to trace the origin of a new pathogen that recently crossed from another host species into humans, or from one geographic region to another. It may be used to determine the common source of an outbreak of a foodborne infectious disease, such as a contaminated water supply. Finally, source attribution may be used to estimate the probability that an infection was transmitted from one specific individual to another, i.e., "who infected whom".

References

  1. Rannala, Bruce; Yang, Ziheng (September 1996). "Probability distribution of molecular evolutionary trees: A new method of phylogenetic inference". Journal of Molecular Evolution. 43 (3): 304–311. Bibcode:1996JMolE..43..304R. doi:10.1007/BF02338839. PMID   8703097. S2CID   8269826.
  2. 1 2 Yang, Z.; Rannala, B. (1 July 1997). "Bayesian phylogenetic inference using DNA sequences: a Markov Chain Monte Carlo Method". Molecular Biology and Evolution. 14 (7): 717–724. doi: 10.1093/oxfordjournals.molbev.a025811 . PMID   9214744.
  3. Mau, Bob; Newton, Michael A.; Larget, Bret (March 1999). "Bayesian Phylogenetic Inference via Markov Chain Monte Carlo Methods". Biometrics. 55 (1): 1–12. doi: 10.1111/j.0006-341x.1999.00001.x . JSTOR   2533889. PMID   11318142. S2CID   932887.
  4. Li, Shuying; Pearl, Dennis K.; Doss, Hani (June 2000). "Phylogenetic Tree Construction Using Markov Chain Monte Carlo". Journal of the American Statistical Association. 95 (450): 493–508. doi:10.1080/01621459.2000.10474227. JSTOR   2669394. S2CID   122459537.
  5. Huelsenbeck, J. P.; Ronquist, F. (1 August 2001). "MRBAYES: Bayesian inference of phylogenetic trees". Bioinformatics. 17 (8): 754–755. doi: 10.1093/bioinformatics/17.8.754 . PMID   11524383.
  6. Laplace P (1774). "Memoire sur la Probabilite des Causes par les Evenements". L'Académie Royale des Sciences. 6: 621–656. NAID   10010866843. English translation by Stigler SM (1986). "Memoir on the Probability of the Causes of Events". Statistical Science. 1 (3): 359–378. doi: 10.1214/ss/1177013620 .
  7. Nascimento, Fabrícia F.; Reis, Mario dos; Yang, Ziheng (October 2017). "A biologist's guide to Bayesian phylogenetic analysis". Nature Ecology & Evolution. 1 (10): 1446–1454. Bibcode:2017NatEE...1.1446N. doi:10.1038/s41559-017-0280-x. PMC   5624502 . PMID   28983516.
  8. Hastings WK (April 1970). "Monte Carlo sampling methods using Markov chains and their applications". Biometrika. 57 (1): 97–109. Bibcode:1970Bimka..57...97H. doi:10.1093/biomet/57.1.97.
  9. 1 2 Metropolis N, Rosenbluth AW, Rosenbluth MN, Teller AH, Teller E (June 1953). "Equation of state calculations by fast computing machines". The Journal of Chemical Physics. 21 (6): 1087–92. Bibcode:1953JChPh..21.1087M. doi:10.1063/1.1699114. OSTI   4390578. S2CID   1046577.
  10. Felsenstein J (2004). Inferring phylogenies. Sunderland, Massachusetts: Sinauer Associates.
  11. Yang Z (2014). Molecular Evolution: A Statistical Approach. Oxford, England: Oxford University Press.
  12. Geyer CJ (1991). "Markov chain Monte Carlo maximum likelihood.". In Keramidas EM, Kaufman SM (eds.). Computing Science and Statistics: Proceedings of the 23rd Symposium on the Interface. Fairfax Station: Interface Foundation. pp. 156–163. OCLC   26603816.
  13. Larget B, Simon DL (June 1999). "Markov chain Monte Carlo algorithms for the Bayesian analysis of phylogenetic trees". Molecular Biology and Evolution. 16 (6): 750–9. doi: 10.1093/oxfordjournals.molbev.a026160 .
  14. Mau B, Newton MA, Larget B (March 1999). "Bayesian phylogenetic inference via Markov chain Monte Carlo methods". Biometrics. 55 (1): 1–12. doi: 10.1111/j.0006-341x.1999.00001.x . PMID   11318142. S2CID   932887.
  15. Felsenstein J (December 1978). "Cases in which parsimony or compatibility methods will be positively misleading". Systematic Zoology. 27 (4): 401–10. doi:10.1093/sysbio/27.4.401.
  16. Castorani MC, Reed DC, Raimondi PT, Alberto F, Bell TW, Cavanaugh KC, et al. (January 2017). "Fluctuations in population fecundity drive variation in demographic connectivity and metapopulation dynamics". Proceedings. Biological Sciences. 284 (1847): 20162086. doi:10.1098/rspb.2016.2086. PMC   5310032 . PMID   28123088.
  17. O'Reilly JE, Puttick MN, Parry L, Tanner AR, Tarver JE, Fleming J, Pisani D, Donoghue PC (April 2016). "Bayesian methods outperform parsimony but at the expense of precision in the estimation of phylogeny from discrete morphological data". Biology Letters. 12 (4): 20160081. doi:10.1098/rsbl.2016.0081. PMC   4881353 . PMID   27095266.
  18. Goloboff PA, Torres A, Arias JS (2018). "Weighted parsimony outperforms other methods of phylogenetic inference under models appropriate for morphology". Cladistics. 34 (4): 407–437. doi: 10.1111/cla.12205 . ISSN   0748-3007. PMID   34649370.
  19. Keating JN, Sansom RS, Sutton MD, Knight CG, Garwood RJ (February 2020). "Morphological phylogenetics evaluated using novel evolutionary simulations". Systematic Biology. 69 (5): 897–912. doi: 10.1093/sysbio/syaa012 . PMC   7440746 . PMID   32073641.
  20. Swofford DL, Olsen GJ, Waddell PJ, Hillis DM (1996). "Phylogenetic inference". In Hillis DM, Moritz C, Mable BK (eds.). Molecular Systematics, 2nd edition. Sunderland, MA: Sinauer. pp. 407–514. ISBN   9780878932825.
  21. 1 2 Suzuki Y, Glazko GV, Nei M (December 2002). "Overcredibility of molecular phylogenies obtained by Bayesian phylogenetics". Proceedings of the National Academy of Sciences of the United States of America. 99 (25): 16138–43. Bibcode:2002PNAS...9916138S. doi: 10.1073/pnas.212646199 . PMC   138578 . PMID   12451182.
  22. Alfaro ME, Zoller S, Lutzoni F (February 2003). "Bayes or bootstrap? A simulation study comparing the performance of Bayesian Markov chain Monte Carlo sampling and bootstrapping in assessing phylogenetic confidence". Molecular Biology and Evolution. 20 (2): 255–66. doi: 10.1093/molbev/msg028 . PMID   12598693.
  23. Douady CJ, Delsuc F, Boucher Y, Doolittle WF, Douzery EJ (February 2003). "Comparison of Bayesian and maximum likelihood bootstrap measures of phylogenetic reliability". Molecular Biology and Evolution. 20 (2): 248–54. doi: 10.1093/molbev/msg042 . PMID   12598692.
  24. García-Sandoval R (January 2014). "Why some clades have low bootstrap frequencies and high Bayesian posterior probabilities". Israel Journal of Ecology & Evolution. 60 (1): 41–4. doi:10.1080/15659801.2014.937900.
  25. Yang, Z. (18 April 2007). "Fair-Balance Paradox, Star-tree Paradox, and Bayesian Phylogenetics". Molecular Biology and Evolution. 24 (8): 1639–1655. doi: 10.1093/molbev/msm081 . PMID   17488737.
  26. Yang, Ziheng; Zhu, Tianqi (20 February 2018). "Bayesian selection of misspecified models is overconfident and may cause spurious posterior probabilities for phylogenetic trees". Proceedings of the National Academy of Sciences. 115 (8): 1854–1859. Bibcode:2018PNAS..115.1854Y. doi: 10.1073/pnas.1712673115 . PMC   5828583 . PMID   29432193.
  27. Erixon P, Svennblad B, Britton T, Oxelman B (October 2003). "Reliability of Bayesian posterior probabilities and bootstrap frequencies in phylogenetics". Systematic Biology. 52 (5): 665–73. doi: 10.1080/10635150390235485 . PMID   14530133.
  28. Huelsenbeck JP, Ronquist F (August 2001). "MRBAYES: Bayesian inference of phylogenetic trees". Bioinformatics. Oxford, England. 17 (8): 754–5. doi: 10.1093/bioinformatics/17.8.754 . PMID   11524383.
  29. Maddison DR, Swofford DL, Maddison WP (December 1997). "NEXUS: an extensible file format for systematic information". Systematic Biology. 46 (4): 590–621. doi: 10.1093/sysbio/46.4.590 . PMID   11975335.
  30. Jukes TH, Cantor CR (1969). Evolution of Protein Molecules. New York: Academic Press. pp. 21–132.
  31. Yang Z (November 1993). "Maximum-likelihood estimation of phylogeny from DNA sequences when substitution rates differ over sites". Molecular Biology and Evolution. 10 (6): 1396–401. doi: 10.1093/oxfordjournals.molbev.a040082 . PMID   8277861.
  32. Ronquist F, Huelsenbeck JP (August 2003). "MrBayes 3: Bayesian phylogenetic inference under mixed models". Bioinformatics. Oxford, England. 19 (12): 1572–4. doi: 10.1093/bioinformatics/btg180 . PMID   12912839.
  33. Ronquist F, Teslenko M, van der Mark P, Ayres DL, Darling A, Höhna S, Larget B, Liu L, Suchard MA, Huelsenbeck JP (May 2012). "MrBayes 3.2: efficient Bayesian phylogenetic inference and model choice across a large model space". Systematic Biology. 61 (3): 539–42. doi:10.1093/sysbio/sys029. PMC   3329765 . PMID   22357727.
  34. Drummond AJ, Suchard MA, Xie D, Rambaut A (August 2012). "Bayesian phylogenetics with BEAUti and the BEAST 1.7". Molecular Biology and Evolution. 29 (8): 1969–73. doi:10.1093/molbev/mss075. PMC   3408070 . PMID   22367748.
  35. Bouckaert R, Heled J, Kühnert D, Vaughan T, Wu CH, Xie D, Suchard MA, Rambaut A, Drummond AJ (April 2014). "BEAST 2: a software platform for Bayesian evolutionary analysis". PLOS Computational Biology. 10 (4): e1003537. Bibcode:2014PLSCB..10E3537B. doi: 10.1371/journal.pcbi.1003537 . PMC   3985171 . PMID   24722319.
  36. Lartillot N, Philippe H (June 2004). "A Bayesian mixture model for across-site heterogeneities in the amino-acid replacement process". Molecular Biology and Evolution. 21 (6): 1095–109. doi: 10.1093/molbev/msh112 . PMID   15014145.
  37. Suchard MA, Redelings BD (August 2006). "BAli-Phy: simultaneous Bayesian inference of alignment and phylogeny". Bioinformatics. 22 (16): 2047–8. doi: 10.1093/bioinformatics/btl175 . PMID   16679334.
  38. Ané C, Larget B, Baum DA, Smith SD, Rokas A (February 2007). "Bayesian estimation of concordance among gene trees". Molecular Biology and Evolution. 24 (2): 412–26. doi: 10.1093/molbev/msl170 . PMID   17095535.
  39. Wilson IJ, Weale ME, Balding DJ (June 2003). "Inferences from DNA data: population histories, evolutionary processes and forensic match probabilities". Journal of the Royal Statistical Society, Series A (Statistics in Society). 166 (2): 155–88. doi: 10.1111/1467-985X.00264 .
  40. Pagel M, Meade A (June 2006). "Bayesian analysis of correlated evolution of discrete characters by reversible-jump Markov chain Monte Carlo". The American Naturalist. 167 (6): 808–25. doi:10.1086/503444. PMID   16685633. S2CID   205984494.
  41. Lord E, Leclercq M, Boc A, Diallo AB, Makarenkov V (2012). "Armadillo 1.1: an original workflow platform for designing and conducting phylogenetic analysis and simulations". PLOS ONE. 7 (1): e29903. Bibcode:2012PLoSO...729903L. doi: 10.1371/journal.pone.0029903 . PMC   3256230 . PMID   22253821.
  42. Milne I, Lindner D, Bayer M, Husmeier D, McGuire G, Marshall DF, Wright F (January 2009). "TOPALi v2: a rich graphical interface for evolutionary analyses of multiple alignments on HPC clusters and multi-core desktops". Bioinformatics. 25 (1): 126–7. doi:10.1093/bioinformatics/btn575. PMC   2638937 . PMID   18984599.
  43. Alonso R, Crawford AJ, Bermingham E (March 2012). "Molecular phylogeny of an endemic radiation of Cuban toads (Bufonidae: Peltophryne) based on mitochondrial and nuclear genes". Journal of Biogeography. 39 (3): 434–51. Bibcode:2012JBiog..39..434A. doi:10.1111/j.1365-2699.2011.02594.x. S2CID   4152245.
  44. Antonelli A, Sanmartín I (October 2011). "Mass extinction, gradual cooling, or rapid radiation? Reconstructing the spatiotemporal evolution of the ancient angiosperm genus Hedyosmum (Chloranthaceae) using empirical and simulated approaches". Systematic Biology. 60 (5): 596–615. doi: 10.1093/sysbio/syr062 . hdl: 10261/34829 . PMID   21856636.
  45. de Villemereuil P, Wells JA, Edwards RD, Blomberg SP (June 2012). "Bayesian models for comparative analysis integrating phylogenetic uncertainty". BMC Evolutionary Biology. 12 (1): 102. Bibcode:2012BMCEE..12..102V. doi: 10.1186/1471-2148-12-102 . PMC   3582467 . PMID   22741602.
  46. Ronquist F (September 2004). "Bayesian inference of character evolution". Trends in Ecology & Evolution. 19 (9): 475–81. doi:10.1016/j.tree.2004.07.002. PMID   16701310.
  47. Schäffer S, Koblmüller S, Pfingstl T, Sturmbauer C, Krisper G (August 2010). "Ancestral state reconstruction reveals multiple independent evolution of diagnostic morphological characters in the "Higher Oribatida" (Acari), conflicting with current classification schemes". BMC Evolutionary Biology. 10 (1): 246. Bibcode:2010BMCEE..10..246S. doi: 10.1186/1471-2148-10-246 . PMC   2930640 . PMID   20701742.
  48. Filipowicz N, Renner SS (July 2012). "Brunfelsia (Solanaceae): a genus evenly divided between South America and radiations on Cuba and other Antillean islands". Molecular Phylogenetics and Evolution. 64 (1): 1–11. doi:10.1016/j.ympev.2012.02.026. PMID   22425729.
  49. Bacon CD, Baker WJ, Simmons MP (May 2012). "Miocene dispersal drives island radiations in the palm tribe Trachycarpeae (Arecaceae)". Systematic Biology. 61 (3): 426–42. doi: 10.1093/sysbio/syr123 . PMID   22223444.
  50. Särkinen T, Bohs L, Olmstead RG, Knapp S (September 2013). "A phylogenetic framework for evolutionary study of the nightshades (Solanaceae): a dated 1000-tip tree". BMC Evolutionary Biology. 13 (1): 214. Bibcode:2013BMCEE..13..214S. doi: 10.1186/1471-2148-13-214 . PMC   3850475 . PMID   24283922.
  51. Silvestro D, Schnitzler J, Liow LH, Antonelli A, Salamin N (May 2014). "Bayesian estimation of speciation and extinction from incomplete fossil occurrence data". Systematic Biology. 63 (3): 349–67. doi:10.1093/sysbio/syu006. PMC   4361715 . PMID   24510972.
  52. Lemey P, Rambaut A, Drummond AJ, Suchard MA (September 2009). "Bayesian phylogeography finds its roots". PLOS Computational Biology. 5 (9): e1000520. Bibcode:2009PLSCB...5E0520L. doi: 10.1371/journal.pcbi.1000520 . PMC   2740835 . PMID   19779555.
  53. Cybis G, Sinsheimer J, Bedford T, Mather A, Lemey P, Suchard MA (2015). "Assessing phenotypic correlation through the multivariate phylogenetic latent liability model". The Annals of Applied Statistics. 9 (2): 969–991. doi:10.1214/15-AOAS821. ISSN   1932-6157. PMC   4820077 . PMID   27053974.
  54. Tolkoff M, Alfaro M, Baele G, Lemey P, Suchard MA (2018). "Phylogenetic Factor Analysis". Systematic Biology. 67 (3): 384–399. doi:10.1093/sysbio/syx066. ISSN   1063-5157. PMC   5920329 . PMID   28950376.