Phenotypic Evolution. and phylogenetic comparative methods. G562 Geometric Morphometrics. Department of Geological Sciences Indiana University

Size: px
Start display at page:

Download "Phenotypic Evolution. and phylogenetic comparative methods. G562 Geometric Morphometrics. Department of Geological Sciences Indiana University"

Transcription

1 Phenotypic Evolution and phylogenetic comparative methods

2 Phenotypic Evolution Change in the mean phenotype from generation to generation... Evolution = Mean(genetic variation * selection) + Mean(genetic variation * drift) + Mean(nongenetic variation)

3 Quantitative evolutionary theory Lande s formula for multivariate phenotypic evolution Selection coefficients Random Directional Stabilizing Etc. Δz = βg Change in phenotype Population variance (additive genetic variancecovariance matrix) Lande, R Quantitative genetic analysis of multivariate evolution, applied to brain: body size allometry. Evolution, 33:

4 Phenotypic trait divergence less predictable than genetic divergence Molar shape divergence Mitochondrial DNA divergence Brown, W.M., M. George, Jr., & A.C. Wilson Rapid evolution of animal mitochondrial DNA. PNAS, 76: Polly, P.D Paleophylogeography: the tempo of geographic differentiation in marmots (Marmota). Journal of Mammalogy, 84:

5 Monte Carlo simulation of Brownian Motion properties Monte Carlo is a type of modelling in which you simulate random samples of variables or systems of interest. Here we simulate 1000 random walks to see whether it is true that the average outcome is the same as the starting point and whether the variance and standard deviation of outcomes occur as expected. walks = Table[RandomWalk[100, 1], {1000}]; ListPlot[walks, Joined -> True, Axes -> False, Frame -> True, PlotRange -> All] Histogram[walks[[1 ;;, -1]], Axes -> False] Mean[walks[[1;;, -1]]] Variance[walks[[1;;,-1]]] StandardDeviation[walks[[1;;,-1]]]

6 Random walks 1 random walk 100 random walks

7 Statistics of Brownian motion evolution Random walk evolution: 1. Change at each generation is random in direction and magnitude 2. Direction of change at any point does not depend on previous changes Consequently The most likely endpoint is the starting point 4. The distribution of possible endpoints has a variance that equals the average squared change per generation * number of generations 5. The standard deviation of possible endpoints increases with the square root of number of generations

8 Random Walks in Mathematica In Phylogenetics for Mathematica 1.1: RandomWalk[n, i] where n is the number of generations and i is the rate of change per generation. walk = RandomWalk[100, 1]; ListPlot[walk, Joined -> True, Axes -> False, Frame -> True, PlotRange -> All]

9 Results of Monte Carlo experiment 100 generations, rate of 1.0 per generation, squared rate of 1.0 per generation, 10,000 runs Expected Observed Mean = 0 Mean = Variance = * 100 =100 Variance = SD = Sqrt[1.0 2 * 100] =10 SD = 10.10

10 Two ways to think about phenotypic evolution Phenotype graphs (phenotypic value over time) Divergence graphs (phenotypic change over time)

11 Divergence graphs Plots of divergence against phylogenetic, genetic, or geographic distance Mophometric Divergence (Procrustes distance) Each data point records the differences (morphological and phylogenetic) between two taxa (known as pairwise distances) Phylogenetic or Genetic Distance (time elapsed)

12 Divergence graphs can be constructed from phylogenetic data Difference Divergence Difference Divergence (2x) Polly, P.D Paleontology and the comparative method: ancestral node reconstructions versus observed node values. American Naturalist, 157:

13 Monte Carlo with Divergence Graph ListPlot[Sqrt[walks^2], Joined -> True, Axes -> False, Frame -> True, PlotRange -> All]

14 How does one model evolution of shape? Random walks of landmark coordinates are not realistic because the landmarks are highly correlated in real shapes. Polly, P. D On the simulation of the evolution of morphological shape: multivariate shape under selection and drift. Palaeontologia Electronica, 7.2.7A: 28pp, 2.3MB. palaeo-electronica.org/paleo/2004_2/evo/issue2_04.htm

15 How does one model evolution of shape? Random walks of landmark coordinates are not realistic because the landmarks are highly correlated in real shapes. Polly, P. D On the simulation of the evolution of morphological shape: multivariate shape under selection and drift. Palaeontologia Electronica, 7.2.7A: 28pp, 2.3MB. palaeo-electronica.org/paleo/2004_2/evo/issue2_04.htm

16 Shape evolution can be simulated in morphospace This approach takes covariances in landmarks into account 1. Collect landmarks, calculate covariance matrix 2. Convert covariance matrix to one without correlations by rotating data to principal components 3. Perform simulation in shape space, convert simulated scores back into landmark shape models

17 1 million generations of random selection 100 lineages, 18 dimensional trait Arrangement of cusps (red dots at right) Positions of 100 lineages in first two dimensions of morphospace Divergence graph of 100 lineages Polly, P. D On the simulation of the evolution of morphological shape: multivariate shape under selection and drift. Palaeontologia Electronica, 7.2.7A: 28pp, 2.3MB. palaeo-electronica.org/paleo/2004_2/evo/issue2_04.htm

18 1 million generations of directional selection 100 lineages, 18 dimensional trait Arrangement of cusps (red dots at right) Positions of 100 lineages in first two dimensions of morphospace Divergence graph of 100 lineages Polly, P. D On the simulation of the evolution of morphological shape: multivariate shape under selection and drift. Palaeontologia Electronica, 7.2.7A: 28pp, 2.3MB. palaeo-electronica.org/paleo/2004_2/evo/issue2_04.htm

19 1 million generations of stabilizing selection 100 lineages, 18 dimensional trait Arrangement of cusps (red dots at right) Positions of 100 lineages in first two dimensions of morphospace Divergence graph of 100 lineages Polly, P. D On the simulation of the evolution of morphological shape: multivariate shape under selection and drift. Palaeontologia Electronica, 7.2.7A: 28pp, 2.3MB. palaeo-electronica.org/paleo/2004_2/evo/issue2_04.htm

20 Background Forward: landmarks to scores in shape space proc = Procrustes[landmarks, 10, 2]; consensus = Mean[proc]; resids = # - consensus &/@proc; CM = Covariance[resids]; {eigenvectors, v, w} = SingularValueDecomposition[CM]; eigenvalues = Tr[v, List]; scores = resids.eigenvectors; Backward: scores in shape space to landmarks resids = scores.transpose[eigenvectors]; proc = # + consensus &/@ resids;

21 Random walk in one-dimensional morphospace walk = Transpose[{Table[x,{x,101}], RandomWalk[100, 1]}]; Graphics[Line[walk], Frame -> True, AspectRatio-> 1/GoldenRatio] 0-5 PC Steps

22 Random walk in two dimensions of shape space z1=0; z2=0; walk2d = Table[{t,z1=z1+Random[NormalDistribution[0,1], z2=z2+random[normaldistribution[0,1]},{t,100}]; Graphics3D[Line[walk2d]] PC2 Steps PC1

23 Same 2D random walk shown in two dimensions z1=0; z2=0; walk2d = Table[{z1=z1+Random[NormalDistribution[0,1], z2=z2+random[normaldistribution[0,1]},{t,100}]; Graphics3D[Line[walk2d]] 0-5 PC PC1

24 What rate to choose? Variance = Eigenvalues 0.15 DOG 0.10 OTTER Node PC FOSSA Node 2 Node 3 Node 1 Node LEOPARD HUMAN WALLABY PC 1 Variance of random walk = rate 2 * number of steps rate = Sqrt[Eigenvalues / number of steps]

25 Monte carlo simulation of evolving turtles turtlespace = Graphics[{PointSize[0.02], Black, Point[scores[[1 ;;, {1, 2}]]]}, AspectRatio -> Automatic, Frame -> True]

26 Monte carlo simulation of evolving turtles rates = Sqrt[eigvals[[1 ;; 2]]/100]; walk2d = Transpose[Table[RandomWalk[100, rates[[x]]], {x, Length[rates]}]]; Show[Graphics[{Gray, Line[walk2d]}, Frame -> True], turtlespace, PlotRange -> All]

27 Animated turtle evolution ListAnimate[Table[tpSpline[consensus, (walk2d[[x]].(transpose[eigenvectors][[1 ;; 2]])) + consensus], {x, Length[walk2d]}]]

28 Important notes These simulations are based on the covariances of the taxa, not the covariances of a single population. Therefore they are not a true model of the evolution of a population by means of random selection. The rates used in this simulation are estimated without taking into account phylogenetic relationships among the taxa. The rates estimated using the variance of the taxa will be approximately correct, but one might really want to estimate them by taking into account phylogenetic relationships (e.g., Martins and Hansen, 1993).

29 Reconstructing evolution of shape Brownian motion in reverse Most likely ancestral phenotype is same as descendant, variance in likelihood is proportional time since the ancestor lived Descendant Ancestor?

30 Ancestor of two branches on phylogenetic tree If likelihood of ancestor of one descendant is normal distribution with variance proportional to time, then likelihood of two ancestors is the product of their probabilities. This is the maximum likelihood method for estimating phylogeny, and for reconstructing ancestral phenotypes. (Felsenstein, Descendant 1 Descendant 2 Common ancestor?

31 Phylogenetic tree projected into morphospace Ancestral shape scores reconstructed using maximum likelihood (assuming Brownian motion process of evolution) Ancestors plotted in morphospace Tree branches drawn to connect ancestors and nodes 0.15 DOG 0.10 OTTER 0.05 Node 4 PC FOSSA Node 2 Node 3 Node 1 Node LEOPARD HUMAN WALLABY PC 1

32 (c) 2016, P. David Polly Selection and drift: Lande s adaptive peak model Note: each geographic cell in the simulation has its own adaptive peak. Selection acts on local populations, not entire species. Probability of extinction Local Phenotype (crown height in local population) Direction of Selection Mean Optiumum Local Adaptive Peak (selection on crown height based on local conditions) Change in phenotype Variance Peak Width election coefficients can be: andom irectional tabilizing tc. Parameters Selection coefficients Additive genetic variance covariance matrix Lande, R Evolution, 30: Selection vector = proportional to log slope of adaptive peak at population mean Extirpation probability = chance event with probability that increases with distance from optimum Genetic variance = population variance times heritability Drift (not shown) = chance sampling based on heritable phenotypic variance and local population size

33 Evolution on an adaptive landscape Loosely following Lande (1976) Δz = h 2 *σ 2 * δ ln(w)/δz(t) z mean phenotype h 2 heritability σ 2 phenotypic variance W selective surface (adaptive landscape) δ derivative (slope) Lande, R Natural Selection and random genetic drift in phenotypic evolution. Evolution, 30:

34 Simulating an adaptive landscape from observational data Convert PDF to adaptive landscape and selection coefficients Probability meadow Trait value Ln(Probability) meadow Trait value Derivative Ln(Probability) Trait value Adaptive landscape Fitness Selection Coefficient

35 Evolution on an adaptive landscape Time (generations) Trait value

Quantitative evolution of morphology

Quantitative evolution of morphology Quantitative evolution of morphology Properties of Brownian motion evolution of a single quantitative trait Most likely outcome = starting value Variance of the outcomes = number of step * (rate parameter)

More information

Phylogeny, trees and morphospace

Phylogeny, trees and morphospace G562 Geometric Morphometrics Phylogeny, trees and morphospace Hierarchical patterns in morphometric data WALLABY HUMAN Node 0 LEOPARD Node 1 Node 3 FOSSA Node 2 DOG Node 4 OTTER 0 20 40 60 80 Cottonwood

More information

Optimum selection and OU processes

Optimum selection and OU processes Optimum selection and OU processes 29 November 2016. Joe Felsenstein Biology 550D Optimum selection and OU processes p.1/15 With selection... life is harder There is the Breeder s Equation of Wright and

More information

GENETICS - CLUTCH CH.22 EVOLUTIONARY GENETICS.

GENETICS - CLUTCH CH.22 EVOLUTIONARY GENETICS. !! www.clutchprep.com CONCEPT: OVERVIEW OF EVOLUTION Evolution is a process through which variation in individuals makes it more likely for them to survive and reproduce There are principles to the theory

More information

Bootstrapping, Randomization, 2B-PLS

Bootstrapping, Randomization, 2B-PLS Bootstrapping, Randomization, 2B-PLS Statistics, Tests, and Bootstrapping Statistic a measure that summarizes some feature of a set of data (e.g., mean, standard deviation, skew, coefficient of variation,

More information

Contrasts for a within-species comparative method

Contrasts for a within-species comparative method Contrasts for a within-species comparative method Joseph Felsenstein, Department of Genetics, University of Washington, Box 357360, Seattle, Washington 98195-7360, USA email address: joe@genetics.washington.edu

More information

Some of these slides have been borrowed from Dr. Paul Lewis, Dr. Joe Felsenstein. Thanks!

Some of these slides have been borrowed from Dr. Paul Lewis, Dr. Joe Felsenstein. Thanks! Some of these slides have been borrowed from Dr. Paul Lewis, Dr. Joe Felsenstein. Thanks! Paul has many great tools for teaching phylogenetics at his web site: http://hydrodictyon.eeb.uconn.edu/people/plewis

More information

"PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION" Integrative Biology 200B Spring 2011 University of California, Berkeley

PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION Integrative Biology 200B Spring 2011 University of California, Berkeley "PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION" Integrative Biology 200B Spring 2011 University of California, Berkeley B.D. Mishler Feb. 1, 2011. Qualitative character evolution (cont.) - comparing

More information

Statistical nonmolecular phylogenetics: can molecular phylogenies illuminate morphological evolution?

Statistical nonmolecular phylogenetics: can molecular phylogenies illuminate morphological evolution? Statistical nonmolecular phylogenetics: can molecular phylogenies illuminate morphological evolution? 30 July 2011. Joe Felsenstein Workshop on Molecular Evolution, MBL, Woods Hole Statistical nonmolecular

More information

BINF6201/8201. Molecular phylogenetic methods

BINF6201/8201. Molecular phylogenetic methods BINF60/80 Molecular phylogenetic methods 0-7-06 Phylogenetics Ø According to the evolutionary theory, all life forms on this planet are related to one another by descent. Ø Traditionally, phylogenetics

More information

UoN, CAS, DBSC BIOL102 lecture notes by: Dr. Mustafa A. Mansi. The Phylogenetic Systematics (Phylogeny and Systematics)

UoN, CAS, DBSC BIOL102 lecture notes by: Dr. Mustafa A. Mansi. The Phylogenetic Systematics (Phylogeny and Systematics) - Phylogeny? - Systematics? The Phylogenetic Systematics (Phylogeny and Systematics) - Phylogenetic systematics? Connection between phylogeny and classification. - Phylogenetic systematics informs the

More information

How can molecular phylogenies illuminate morphological evolution?

How can molecular phylogenies illuminate morphological evolution? How can molecular phylogenies illuminate morphological evolution? 27 October 2016. Joe Felsenstein UNAM How can molecular phylogenies illuminate morphological evolution? p.1/81 Where this lecture fits

More information

Discrete & continuous characters: The threshold model

Discrete & continuous characters: The threshold model Discrete & continuous characters: The threshold model Discrete & continuous characters: the threshold model So far we have discussed continuous & discrete character models separately for estimating ancestral

More information

SCIENTIFIC EVIDENCE TO SUPPORT THE THEORY OF EVOLUTION. Using Anatomy, Embryology, Biochemistry, and Paleontology

SCIENTIFIC EVIDENCE TO SUPPORT THE THEORY OF EVOLUTION. Using Anatomy, Embryology, Biochemistry, and Paleontology SCIENTIFIC EVIDENCE TO SUPPORT THE THEORY OF EVOLUTION Using Anatomy, Embryology, Biochemistry, and Paleontology Scientific Fields Different fields of science have contributed evidence for the theory of

More information

3D Data, Phylogenetics, and Trees In this lecture.

3D Data, Phylogenetics, and Trees In this lecture. 3D Data, Phylogenetics, and Trees In this lecture. 1. Analysis of 3D landmarks 2. Controversies about use of morphometrics in phylogene>cs 3. Empirical data on phylogene>c component of morphometric varia>on

More information

Phylogeny 9/8/2014. Evolutionary Relationships. Data Supporting Phylogeny. Chapter 26

Phylogeny 9/8/2014. Evolutionary Relationships. Data Supporting Phylogeny. Chapter 26 Phylogeny Chapter 26 Taxonomy Taxonomy: ordered division of organisms into categories based on a set of characteristics used to assess similarities and differences Carolus Linnaeus developed binomial nomenclature,

More information

Phylogenies & Classifying species (AKA Cladistics & Taxonomy) What are phylogenies & cladograms? How do we read them? How do we estimate them?

Phylogenies & Classifying species (AKA Cladistics & Taxonomy) What are phylogenies & cladograms? How do we read them? How do we estimate them? Phylogenies & Classifying species (AKA Cladistics & Taxonomy) What are phylogenies & cladograms? How do we read them? How do we estimate them? Carolus Linneaus:Systema Naturae (1735) Swedish botanist &

More information

Evolutionary Physiology

Evolutionary Physiology Evolutionary Physiology Yves Desdevises Observatoire Océanologique de Banyuls 04 68 88 73 13 desdevises@obs-banyuls.fr http://desdevises.free.fr 1 2 Physiology Physiology: how organisms work Lot of diversity

More information

Macroevolution Part I: Phylogenies

Macroevolution Part I: Phylogenies Macroevolution Part I: Phylogenies Taxonomy Classification originated with Carolus Linnaeus in the 18 th century. Based on structural (outward and inward) similarities Hierarchal scheme, the largest most

More information

Appendix from L. J. Revell, On the Analysis of Evolutionary Change along Single Branches in a Phylogeny

Appendix from L. J. Revell, On the Analysis of Evolutionary Change along Single Branches in a Phylogeny 008 by The University of Chicago. All rights reserved.doi: 10.1086/588078 Appendix from L. J. Revell, On the Analysis of Evolutionary Change along Single Branches in a Phylogeny (Am. Nat., vol. 17, no.

More information

"PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION" Integrative Biology 200 Spring 2018 University of California, Berkeley

PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION Integrative Biology 200 Spring 2018 University of California, Berkeley "PRINCIPLES OF PHYLOGENETICS: ECOLOGY AND EVOLUTION" Integrative Biology 200 Spring 2018 University of California, Berkeley D.D. Ackerly Feb. 26, 2018 Maximum Likelihood Principles, and Applications to

More information

How should we organize the diversity of animal life?

How should we organize the diversity of animal life? How should we organize the diversity of animal life? The difference between Taxonomy Linneaus, and Cladistics Darwin What are phylogenies? How do we read them? How do we estimate them? Classification (Taxonomy)

More information

PHYLOGENY WHAT IS EVOLUTION? 1/22/2018. Change must occur in a population via allele

PHYLOGENY WHAT IS EVOLUTION? 1/22/2018. Change must occur in a population via allele PHYLOGENY EXERCISE 1 AND 2 WHAT IS EVOLUTION? The theory that all living organisms on earth are related and have a common ancestor. These organism have changed over time and are continuing to change. Changes

More information

Amira A. AL-Hosary PhD of infectious diseases Department of Animal Medicine (Infectious Diseases) Faculty of Veterinary Medicine Assiut

Amira A. AL-Hosary PhD of infectious diseases Department of Animal Medicine (Infectious Diseases) Faculty of Veterinary Medicine Assiut Amira A. AL-Hosary PhD of infectious diseases Department of Animal Medicine (Infectious Diseases) Faculty of Veterinary Medicine Assiut University-Egypt Phylogenetic analysis Phylogenetic Basics: Biological

More information

Dr. Amira A. AL-Hosary

Dr. Amira A. AL-Hosary Phylogenetic analysis Amira A. AL-Hosary PhD of infectious diseases Department of Animal Medicine (Infectious Diseases) Faculty of Veterinary Medicine Assiut University-Egypt Phylogenetic Basics: Biological

More information

Modularity for Mathematica User s Guide Version 2.0

Modularity for Mathematica User s Guide Version 2.0 Modularity 2.0 for Mathematica P. David Polly and Anjali Goswami, 2010 (updated April 2018) User s Guide Version 2.0 For use with: Goswami, A. & Polly, P. D. 2010 Methods for studying morphological integration,

More information

Chapter 26: Phylogeny and the Tree of Life Phylogenies Show Evolutionary Relationships

Chapter 26: Phylogeny and the Tree of Life Phylogenies Show Evolutionary Relationships Chapter 26: Phylogeny and the Tree of Life You Must Know The taxonomic categories and how they indicate relatedness. How systematics is used to develop phylogenetic trees. How to construct a phylogenetic

More information

Anatomy of a tree. clade is group of organisms with a shared ancestor. a monophyletic group shares a single common ancestor = tapirs-rhinos-horses

Anatomy of a tree. clade is group of organisms with a shared ancestor. a monophyletic group shares a single common ancestor = tapirs-rhinos-horses Anatomy of a tree outgroup: an early branching relative of the interest groups sister taxa: taxa derived from the same recent ancestor polytomy: >2 taxa emerge from a node Anatomy of a tree clade is group

More information

Statistical Analysis. G562 Geometric Morphometrics PC 2 PC 2 PC 3 PC 2 PC 1. Department of Geological Sciences Indiana University

Statistical Analysis. G562 Geometric Morphometrics PC 2 PC 2 PC 3 PC 2 PC 1. Department of Geological Sciences Indiana University PC 2 PC 2 G562 Geometric Morphometrics Statistical Analysis PC 2 PC 1 PC 3 Basic components of GMM Procrustes Whenever shapes are analyzed together, they must be superimposed together This aligns shapes

More information

Introduction to characters and parsimony analysis

Introduction to characters and parsimony analysis Introduction to characters and parsimony analysis Genetic Relationships Genetic relationships exist between individuals within populations These include ancestordescendent relationships and more indirect

More information

GEOMETRIC MORPHOMETRICS. Adrian Castellanos, Michelle Chrpa, & Pedro Afonso Leite

GEOMETRIC MORPHOMETRICS. Adrian Castellanos, Michelle Chrpa, & Pedro Afonso Leite GEOMETRIC MORPHOMETRICS Adrian Castellanos, Michelle Chrpa, & Pedro Afonso Leite WHAT IS MORPHOMETRICS? Quantitative analysis of form, a concept that encompasses size and shape. Analyses performed on live

More information

Chapter 26 Phylogeny and the Tree of Life

Chapter 26 Phylogeny and the Tree of Life Chapter 26 Phylogeny and the Tree of Life Biologists estimate that there are about 5 to 100 million species of organisms living on Earth today. Evidence from morphological, biochemical, and gene sequence

More information

Concepts and Methods in Molecular Divergence Time Estimation

Concepts and Methods in Molecular Divergence Time Estimation Concepts and Methods in Molecular Divergence Time Estimation 26 November 2012 Prashant P. Sharma American Museum of Natural History Overview 1. Why do we date trees? 2. The molecular clock 3. Local clocks

More information

BRIEF COMMUNICATIONS

BRIEF COMMUNICATIONS Evolution, 59(12), 2005, pp. 2705 2710 BRIEF COMMUNICATIONS THE EFFECT OF INTRASPECIFIC SAMPLE SIZE ON TYPE I AND TYPE II ERROR RATES IN COMPARATIVE STUDIES LUKE J. HARMON 1 AND JONATHAN B. LOSOS Department

More information

THEORY. Based on sequence Length According to the length of sequence being compared it is of following two types

THEORY. Based on sequence Length According to the length of sequence being compared it is of following two types Exp 11- THEORY Sequence Alignment is a process of aligning two sequences to achieve maximum levels of identity between them. This help to derive functional, structural and evolutionary relationships between

More information

Bio94 Discussion Activity week 3: Chapter 27 Phylogenies and the History of Life

Bio94 Discussion Activity week 3: Chapter 27 Phylogenies and the History of Life Bio94 Discussion Activity week 3: Chapter 27 Phylogenies and the History of Life 1. Constructing a phylogenetic tree using a cladistic approach Construct a phylogenetic tree using the following table:

More information

Lecture 11 Friday, October 21, 2011

Lecture 11 Friday, October 21, 2011 Lecture 11 Friday, October 21, 2011 Phylogenetic tree (phylogeny) Darwin and classification: In the Origin, Darwin said that descent from a common ancestral species could explain why the Linnaean system

More information

APPENDIX S1: DESCRIPTION OF THE ESTIMATION OF THE VARIANCES OF OUR MAXIMUM LIKELIHOOD ESTIMATORS

APPENDIX S1: DESCRIPTION OF THE ESTIMATION OF THE VARIANCES OF OUR MAXIMUM LIKELIHOOD ESTIMATORS APPENDIX S1: DESCRIPTION OF THE ESTIMATION OF THE VARIANCES OF OUR MAXIMUM LIKELIHOOD ESTIMATORS For large n, the negative inverse of the second derivative of the likelihood function at the optimum can

More information

Reconstructing the history of lineages

Reconstructing the history of lineages Reconstructing the history of lineages Class outline Systematics Phylogenetic systematics Phylogenetic trees and maps Class outline Definitions Systematics Phylogenetic systematics/cladistics Systematics

More information

Chapter 26. Phylogeny and the Tree of Life. Lecture Presentations by Nicole Tunbridge and Kathleen Fitzpatrick Pearson Education, Inc.

Chapter 26. Phylogeny and the Tree of Life. Lecture Presentations by Nicole Tunbridge and Kathleen Fitzpatrick Pearson Education, Inc. Chapter 26 Phylogeny and the Tree of Life Lecture Presentations by Nicole Tunbridge and Kathleen Fitzpatrick Investigating the Tree of Life Phylogeny is the evolutionary history of a species or group of

More information

The Origin of Species

The Origin of Species The Origin of Species Introduction A species can be defined as a group of organisms whose members can breed and produce fertile offspring, but who do not produce fertile offspring with members of other

More information

Algorithms in Bioinformatics

Algorithms in Bioinformatics Algorithms in Bioinformatics Sami Khuri Department of Computer Science San José State University San José, California, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri Distance Methods Character Methods

More information

Multiple Sequence Alignment. Sequences

Multiple Sequence Alignment. Sequences Multiple Sequence Alignment Sequences > YOR020c mstllksaksivplmdrvlvqrikaqaktasglylpe knveklnqaevvavgpgftdangnkvvpqvkvgdqvl ipqfggstiklgnddevilfrdaeilakiakd > crassa mattvrsvksliplldrvlvqrvkaeaktasgiflpe

More information

DNA-based species delimitation

DNA-based species delimitation DNA-based species delimitation Phylogenetic species concept based on tree topologies Ø How to set species boundaries? Ø Automatic species delimitation? druhů? DNA barcoding Species boundaries recognized

More information

Vertebrate Biogeography and Evolution

Vertebrate Biogeography and Evolution Vertebrate Biogeography and Evolution Phylogeny, Plate Tectonics, and Climate Less Digitigrady More Location 1 Location 2 Location 3 Location 4 Biogeography The study of the distribution of species, organisms,

More information

What is the purpose of the Classifying System? To allow the accurate identification of a particular organism

What is the purpose of the Classifying System? To allow the accurate identification of a particular organism What is the purpose of the Classifying System? To allow the accurate identification of a particular organism Taxonomy The practice of classifying organisms -Taxonomy was founded nearly 300 years ago by

More information

Biol 206/306 Advanced Biostatistics Lab 11 Models of Trait Evolution Fall 2016

Biol 206/306 Advanced Biostatistics Lab 11 Models of Trait Evolution Fall 2016 Biol 206/306 Advanced Biostatistics Lab 11 Models of Trait Evolution Fall 2016 By Philip J. Bergmann 0. Laboratory Objectives 1. Explore how evolutionary trait modeling can reveal different information

More information

Biology 211 (2) Week 1 KEY!

Biology 211 (2) Week 1 KEY! Biology 211 (2) Week 1 KEY Chapter 1 KEY FIGURES: 1.2, 1.3, 1.4, 1.5, 1.6, 1.7 VOCABULARY: Adaptation: a trait that increases the fitness Cells: a developed, system bound with a thin outer layer made of

More information

Measuring rates of phenotypic evolution and the inseparability of tempo and mode

Measuring rates of phenotypic evolution and the inseparability of tempo and mode Measuring rates of phenotypic evolution and the inseparability of tempo and mode Gene Hunt This pdf file is licensed for distribution in the form of electronic reprints and by way of personal or institutional

More information

Phylogenetic Trees. Phylogenetic Trees Five. Phylogeny: Inference Tool. Phylogeny Terminology. Picture of Last Quagga. Importance of Phylogeny 5.

Phylogenetic Trees. Phylogenetic Trees Five. Phylogeny: Inference Tool. Phylogeny Terminology. Picture of Last Quagga. Importance of Phylogeny 5. Five Sami Khuri Department of Computer Science San José State University San José, California, USA sami.khuri@sjsu.edu v Distance Methods v Character Methods v Molecular Clock v UPGMA v Maximum Parsimony

More information

How to read and make phylogenetic trees Zuzana Starostová

How to read and make phylogenetic trees Zuzana Starostová How to read and make phylogenetic trees Zuzana Starostová How to make phylogenetic trees? Workflow: obtain DNA sequence quality check sequence alignment calculating genetic distances phylogeny estimation

More information

Chapter 26 Phylogeny and the Tree of Life

Chapter 26 Phylogeny and the Tree of Life Chapter 26 Phylogeny and the Tree of Life Chapter focus Shifting from the process of how evolution works to the pattern evolution produces over time. Phylogeny Phylon = tribe, geny = genesis or origin

More information

I. Short Answer Questions DO ALL QUESTIONS

I. Short Answer Questions DO ALL QUESTIONS EVOLUTION 313 FINAL EXAM Part 1 Saturday, 7 May 2005 page 1 I. Short Answer Questions DO ALL QUESTIONS SAQ #1. Please state and BRIEFLY explain the major objectives of this course in evolution. Recall

More information

Michael Yaffe Lecture #5 (((A,B)C)D) Database Searching & Molecular Phylogenetics A B C D B C D

Michael Yaffe Lecture #5 (((A,B)C)D) Database Searching & Molecular Phylogenetics A B C D B C D 7.91 Lecture #5 Database Searching & Molecular Phylogenetics Michael Yaffe B C D B C D (((,B)C)D) Outline Distance Matrix Methods Neighbor-Joining Method and Related Neighbor Methods Maximum Likelihood

More information

Evolution of Body Size in Bears. How to Build and Use a Phylogeny

Evolution of Body Size in Bears. How to Build and Use a Phylogeny Evolution of Body Size in Bears How to Build and Use a Phylogeny Lesson II Using a Phylogeny Objectives for Lesson II: 1. Overview of concepts 1. Simple ancestral state reconstruction on the bear phylogeny

More information

Quantifying sequence similarity

Quantifying sequence similarity Quantifying sequence similarity Bas E. Dutilh Systems Biology: Bioinformatic Data Analysis Utrecht University, February 16 th 2016 After this lecture, you can define homology, similarity, and identity

More information

Processes of Evolution

Processes of Evolution 15 Processes of Evolution Forces of Evolution Concept 15.4 Selection Can Be Stabilizing, Directional, or Disruptive Natural selection can act on quantitative traits in three ways: Stabilizing selection

More information

Hominid Evolution What derived characteristics differentiate members of the Family Hominidae and how are they related?

Hominid Evolution What derived characteristics differentiate members of the Family Hominidae and how are they related? Hominid Evolution What derived characteristics differentiate members of the Family Hominidae and how are they related? Introduction. The central idea of biological evolution is that all life on Earth shares

More information

Integrative Biology 200 "PRINCIPLES OF PHYLOGENETICS" Spring 2018 University of California, Berkeley

Integrative Biology 200 PRINCIPLES OF PHYLOGENETICS Spring 2018 University of California, Berkeley Integrative Biology 200 "PRINCIPLES OF PHYLOGENETICS" Spring 2018 University of California, Berkeley B.D. Mishler Feb. 14, 2018. Phylogenetic trees VI: Dating in the 21st century: clocks, & calibrations;

More information

Constructing Evolutionary/Phylogenetic Trees

Constructing Evolutionary/Phylogenetic Trees Constructing Evolutionary/Phylogenetic Trees 2 broad categories: istance-based methods Ultrametric Additive: UPGMA Transformed istance Neighbor-Joining Character-based Maximum Parsimony Maximum Likelihood

More information

Cladistics and Bioinformatics Questions 2013

Cladistics and Bioinformatics Questions 2013 AP Biology Name Cladistics and Bioinformatics Questions 2013 1. The following table shows the percentage similarity in sequences of nucleotides from a homologous gene derived from five different species

More information

Algorithmic Methods Well-defined methodology Tree reconstruction those that are well-defined enough to be carried out by a computer. Felsenstein 2004,

Algorithmic Methods Well-defined methodology Tree reconstruction those that are well-defined enough to be carried out by a computer. Felsenstein 2004, Tracing the Evolution of Numerical Phylogenetics: History, Philosophy, and Significance Adam W. Ferguson Phylogenetic Systematics 26 January 2009 Inferring Phylogenies Historical endeavor Darwin- 1837

More information

Package OUwie. August 29, 2013

Package OUwie. August 29, 2013 Package OUwie August 29, 2013 Version 1.34 Date 2013-5-21 Title Analysis of evolutionary rates in an OU framework Author Jeremy M. Beaulieu , Brian O Meara Maintainer

More information

Testing quantitative genetic hypotheses about the evolutionary rate matrix for continuous characters

Testing quantitative genetic hypotheses about the evolutionary rate matrix for continuous characters Evolutionary Ecology Research, 2008, 10: 311 331 Testing quantitative genetic hypotheses about the evolutionary rate matrix for continuous characters Liam J. Revell 1 * and Luke J. Harmon 2 1 Department

More information

Name Date Class. Patterns of Evolution

Name Date Class. Patterns of Evolution Concept Mapping Patterns of Evolution Complete the flowchart about patterns of evolution. These terms may be used more than once: adaptive radiation, change in response to each other, convergent evolution,

More information

PHYLOGENY & THE TREE OF LIFE

PHYLOGENY & THE TREE OF LIFE PHYLOGENY & THE TREE OF LIFE PREFACE In this powerpoint we learn how biologists distinguish and categorize the millions of species on earth. Early we looked at the process of evolution here we look at

More information

Phylogenetics - IB 200B 15 Feb Morphometrics

Phylogenetics - IB 200B 15 Feb Morphometrics Morphometrics Morphometrics is the branch of mathematics studying the metrical and statistical properties of shapes and shape changes of geometric objects like molecules, fossils, brains, bird wings, ancient

More information

Basic Tree Thinking Assessment David A. Baum, Stacey DeWitt Smith, Samuel S. Donovan

Basic Tree Thinking Assessment David A. Baum, Stacey DeWitt Smith, Samuel S. Donovan Basic Tree Thinking Assessment David A. Baum, Stacey DeWitt Smith, Samuel S. Donovan This quiz includes a number of multiple-choice questions you can use to test yourself on your ability to accurately

More information

PHYLOGENY AND SYSTEMATICS

PHYLOGENY AND SYSTEMATICS AP BIOLOGY EVOLUTION/HEREDITY UNIT Unit 1 Part 11 Chapter 26 Activity #15 NAME DATE PERIOD PHYLOGENY AND SYSTEMATICS PHYLOGENY Evolutionary history of species or group of related species SYSTEMATICS Study

More information

CHAPTERS 24-25: Evidence for Evolution and Phylogeny

CHAPTERS 24-25: Evidence for Evolution and Phylogeny CHAPTERS 24-25: Evidence for Evolution and Phylogeny 1. For each of the following, indicate how it is used as evidence of evolution by natural selection or shown as an evolutionary trend: a. Paleontology

More information

University of Groningen

University of Groningen University of Groningen Can clade age alone explain the relationship between body size and diversity? Etienne, Rampal S.; de Visser, Sara N.; Janzen, Thijs; Olsen, Jeanine L.; Olff, Han; Rosindell, James

More information

CHAPTER 26 PHYLOGENY AND THE TREE OF LIFE Connecting Classification to Phylogeny

CHAPTER 26 PHYLOGENY AND THE TREE OF LIFE Connecting Classification to Phylogeny CHAPTER 26 PHYLOGENY AND THE TREE OF LIFE Connecting Classification to Phylogeny To trace phylogeny or the evolutionary history of life, biologists use evidence from paleontology, molecular data, comparative

More information

Constructing Evolutionary/Phylogenetic Trees

Constructing Evolutionary/Phylogenetic Trees Constructing Evolutionary/Phylogenetic Trees 2 broad categories: Distance-based methods Ultrametric Additive: UPGMA Transformed Distance Neighbor-Joining Character-based Maximum Parsimony Maximum Likelihood

More information

Phylogenetics. BIOL 7711 Computational Bioscience

Phylogenetics. BIOL 7711 Computational Bioscience Consortium for Comparative Genomics! University of Colorado School of Medicine Phylogenetics BIOL 7711 Computational Bioscience Biochemistry and Molecular Genetics Computational Bioscience Program Consortium

More information

The phylogenetic effective sample size and jumps

The phylogenetic effective sample size and jumps arxiv:1809.06672v1 [q-bio.pe] 18 Sep 2018 The phylogenetic effective sample size and jumps Krzysztof Bartoszek September 19, 2018 Abstract The phylogenetic effective sample size is a parameter that has

More information

Chapter 26: Phylogeny and the Tree of Life

Chapter 26: Phylogeny and the Tree of Life Chapter 26: Phylogeny and the Tree of Life 1. Key Concepts Pertaining to Phylogeny 2. Determining Phylogenies 3. Evolutionary History Revealed in Genomes 1. Key Concepts Pertaining to Phylogeny PHYLOGENY

More information

Organizing Life s Diversity

Organizing Life s Diversity 17 Organizing Life s Diversity section 2 Modern Classification Classification systems have changed over time as information has increased. What You ll Learn species concepts methods to reveal phylogeny

More information

A (short) introduction to phylogenetics

A (short) introduction to phylogenetics A (short) introduction to phylogenetics Thibaut Jombart, Marie-Pauline Beugin MRC Centre for Outbreak Analysis and Modelling Imperial College London Genetic data analysis with PR Statistics, Millport Field

More information

Phylogenetic Analysis

Phylogenetic Analysis Phylogenetic Analysis Aristotle Through classification, one might discover the essence and purpose of species. Nelson & Platnick (1981) Systematics and Biogeography Carl Linnaeus Swedish botanist (1700s)

More information

Phylogeny & Systematics: The Tree of Life

Phylogeny & Systematics: The Tree of Life Phylogeny & Systematics: The Tree of Life An unexpected family tree. What are the evolutionary relationships among a human, a mushroom, and a tulip? Molecular systematics has revealed that despite appearances

More information

Reproduction- passing genetic information to the next generation

Reproduction- passing genetic information to the next generation 166 166 Essential Question: How has biological evolution led to the diversity of life? B-5 Natural Selection Traits that make an organism more or less likely to survive in an environment and reproduce

More information

POSITIVE CORRELATION BETWEEN DIVERSIFICATION RATES AND PHENOTYPIC EVOLVABILITY CAN MIMIC PUNCTUATED EQUILIBRIUM ON MOLECULAR PHYLOGENIES

POSITIVE CORRELATION BETWEEN DIVERSIFICATION RATES AND PHENOTYPIC EVOLVABILITY CAN MIMIC PUNCTUATED EQUILIBRIUM ON MOLECULAR PHYLOGENIES doi:10.1111/j.1558-5646.2012.01631.x POSITIVE CORRELATION BETWEEN DIVERSIFICATION RATES AND PHENOTYPIC EVOLVABILITY CAN MIMIC PUNCTUATED EQUILIBRIUM ON MOLECULAR PHYLOGENIES Daniel L. Rabosky 1,2,3 1 Department

More information

Intraspecific gene genealogies: trees grafting into networks

Intraspecific gene genealogies: trees grafting into networks Intraspecific gene genealogies: trees grafting into networks by David Posada & Keith A. Crandall Kessy Abarenkov Tartu, 2004 Article describes: Population genetics principles Intraspecific genetic variation

More information

Lecture 6 Phylogenetic Inference

Lecture 6 Phylogenetic Inference Lecture 6 Phylogenetic Inference From Darwin s notebook in 1837 Charles Darwin Willi Hennig From The Origin in 1859 Cladistics Phylogenetic inference Willi Hennig, Cladistics 1. Clade, Monophyletic group,

More information

Estimating Evolutionary Trees. Phylogenetic Methods

Estimating Evolutionary Trees. Phylogenetic Methods Estimating Evolutionary Trees v if the data are consistent with infinite sites then all methods should yield the same tree v it gets more complicated when there is homoplasy, i.e., parallel or convergent

More information

Big Idea #1: The process of evolution drives the diversity and unity of life

Big Idea #1: The process of evolution drives the diversity and unity of life BIG IDEA! Big Idea #1: The process of evolution drives the diversity and unity of life Key Terms for this section: emigration phenotype adaptation evolution phylogenetic tree adaptive radiation fertility

More information

Page 1. Evolutionary Trees. Why build evolutionary tree? Outline

Page 1. Evolutionary Trees. Why build evolutionary tree? Outline Page Evolutionary Trees Russ. ltman MI S 7 Outline. Why build evolutionary trees?. istance-based vs. character-based methods. istance-based: Ultrametric Trees dditive Trees. haracter-based: Perfect phylogeny

More information

AP Biology. Cladistics

AP Biology. Cladistics Cladistics Kingdom Summary Review slide Review slide Classification Old 5 Kingdom system Eukaryote Monera, Protists, Plants, Fungi, Animals New 3 Domain system reflects a greater understanding of evolution

More information

Theory of Evolution Charles Darwin

Theory of Evolution Charles Darwin Theory of Evolution Charles arwin 858-59: Origin of Species 5 year voyage of H.M.S. eagle (83-36) Populations have variations. Natural Selection & Survival of the fittest: nature selects best adapted varieties

More information

Evolution. Species Changing over time

Evolution. Species Changing over time Evolution Species Changing over time Charles Darwin Evolution by Means of Natural Selection Reasons for Change Mutation A mutation could cause parents with genes for bright green coloration to have offspring

More information

Markov chain Monte-Carlo to estimate speciation and extinction rates: making use of the forest hidden behind the (phylogenetic) tree

Markov chain Monte-Carlo to estimate speciation and extinction rates: making use of the forest hidden behind the (phylogenetic) tree Markov chain Monte-Carlo to estimate speciation and extinction rates: making use of the forest hidden behind the (phylogenetic) tree Nicolas Salamin Department of Ecology and Evolution University of Lausanne

More information

MIPoD: A Hypothesis-Testing Framework for Microevolutionary Inference from Patterns of Divergence

MIPoD: A Hypothesis-Testing Framework for Microevolutionary Inference from Patterns of Divergence vol. 171, no. 3 the american naturalist march 2008 MIPoD: A Hypothesis-Testing Framework for Microevolutionary Inference from Patterns of Divergence Paul A. Hohenlohe 1,2,* and Stevan J. Arnold 1, 1. Department

More information

HUMAN EVOLUTION 17 APRIL 2013

HUMAN EVOLUTION 17 APRIL 2013 HUMAN EVOLUTION 17 APRIL 2013 Lesson Description In this lesson, we: Consider the following aspects of Human Evolution: - Interpretation of a phylogenetic tree to show the place of the family Hominidae

More information

The practice of naming and classifying organisms is called taxonomy.

The practice of naming and classifying organisms is called taxonomy. Chapter 18 Key Idea: Biologists use taxonomic systems to organize their knowledge of organisms. These systems attempt to provide consistent ways to name and categorize organisms. The practice of naming

More information

Chapter 7: Models of discrete character evolution

Chapter 7: Models of discrete character evolution Chapter 7: Models of discrete character evolution pdf version R markdown to recreate analyses Biological motivation: Limblessness as a discrete trait Squamates, the clade that includes all living species

More information

The Tempo of Macroevolution: Patterns of Diversification and Extinction

The Tempo of Macroevolution: Patterns of Diversification and Extinction The Tempo of Macroevolution: Patterns of Diversification and Extinction During the semester we have been consider various aspects parameters associated with biodiversity. Current usage stems from 1980's

More information

Classification and Phylogeny

Classification and Phylogeny Classification and Phylogeny The diversity of life is great. To communicate about it, there must be a scheme for organization. There are many species that would be difficult to organize without a scheme

More information

Patterns in Evolution - Novelty

Patterns in Evolution - Novelty Patterns in Evolution - Novelty Uses of Phylogenetic Analysis Allows mapping order of character state changes Documents evolutionary trends in development Reveals that Homoplasy is common Can attempt to

More information

Patterns in Evolution - Novelty. Uses of Phylogenetic Analysis. Allows mapping order of character state changes

Patterns in Evolution - Novelty. Uses of Phylogenetic Analysis. Allows mapping order of character state changes Patterns in Evolution - Novelty Uses of Phylogenetic Analysis Allows mapping order of character state changes Documents evolutionary trends in development Reveals that Homoplasy is common Can attempt to

More information

3 Hours 18 / 06 / 2012 EXAMS OFFICE USE ONLY University of the Witwatersrand, Johannesburg Course or topic No(s) ANAT 4000

3 Hours 18 / 06 / 2012 EXAMS OFFICE USE ONLY University of the Witwatersrand, Johannesburg Course or topic No(s) ANAT 4000 3 Hours 18 / 06 / 2012 EXAMS OFFICE USE ONLY University of the Witwatersrand, Johannesburg Course or topic No(s) ANAT 4000 Course or topic name(s) Paper Number & title HUMAN BIOLOGY HONOURS: PAPER 1 Examination

More information