MOLECULAR PHYLOGENETIC METHODS Course Contents - I

Total Page:16

File Type:pdf, Size:1020Kb

MOLECULAR PHYLOGENETIC METHODS Course Contents - I MOLECULAR PHYLOGENETIC METHODS Course Contents - I. UPGMA II. Neighbor Joining III. Minimum Evolution IV. Maximum Parsimony V. Maximum Likelihood VI. Bayesian Inference Gurumayum Suraj Sharma MOLECULAR PHYLOGENETIC TREE BUILDING METHODS Mathematical/Statistical Methods for inferring divergence order of taxa, as well as the lengths of the branches that connect them. Many phylogenetic methods available: Each having strengths and weaknesses Cluster analysis is one such method in which OTUs are arranged in the in the order of decreasing similarity Gurumayum Suraj Sharma DISTANCE BASED METHODS Distance-based methods begin construction of tree by calculating pairwise distances between molecular sequences. A matrix of pairwise scores for all aligned proteins (or nucleic acid sequences) is used to generate a tree. GOAL - Find a tree in which branch lengths correspond as closely as possible to the observed distances. Main distance-based methods I. Unweighted Pair Group Method with Arithmetic Mean [UPGMA] II. Neighbor Joining [NJ] Distance-based methods of phylogeny Computationally fast Particularly useful for analyses of larger number of sequences (e.g., .50 or 100). Gurumayum Suraj Sharma USES DISTANCE METRIC o Number of amino acid changes between the sequences o Distance score. Distance is calculated as dissimilarity between the sequences of each pair of taxa. While similarities are useful, distances (which differ from differences) offer appealing properties for describing the relationships between objects. Distance based methods are fast but overlook substantial amount of information in a multiple sequence alignment Gurumayum Suraj Sharma DISTANCE-BASED METHOD UPGMA UPGMA algorithm introduced by Sokal & Michener [1958] Example: Consider five sequences whose distances can be represented as points in a plane. Also represent them in a distance matrix. Some protein sequences, such as 1 & 2, closely similar Others (1 & 3) are far less related. UPGMA clusters these sequences Gurumayum Suraj Sharma 1. Begin with a distance matrix . o Identify the least dissimilar groups (i.e. the two OTUs that are most closely related). o All OTUs given equal weights. If there are several equidistant minimal pairs, one is picked randomly. o Eg. OTUs 1 and 2 have the smallest distance. 2. Combine to form a new group. o Eg. Groups 1 & 2 have smallest distance (0.1) and are combined to form cluster (1, 2). o Results in formation of a new, clustered distance matrix having one fewer row and column than the initial matrix. o Dissimilarities that are not involved in formation of new cluster remain unchanged. o The values for clustered taxa (1,2) reflect average of OTUs 1 and 2 to each of the other OTUs. o The distance of OTU 1 to OTU 4 was initially 0.8, of OTU 2 to OTU 4 was 1.0, and then the distance of OTU (1,2) to OTU 4 becomes 0.9. Gurumayum Suraj Sharma 3. Connect through a new node on nascent tree. o This node corresponds to group. 4. Identify next smallest dissimilarity, & combine those taxa to generate a second clustered dissimilarity matrix. o It is possible that two OTUs will be joined (if they share the least dissimilarity), or a single OTU will be joined with a cluster, or two clusters will be joined. o The dissimilarity of a single OTU with a cluster is computed simply by taking average dissimilarity. o In this process a new distance matrix is formed, and the tree continues to be constructed. 5. Continue until there are only two remaining groups, and join these. Gurumayum Suraj Sharma I. Each sequence is assigned to its own cluster. A distance matrix, based on some metric, quantitates the distance between each object. Circles represent sequences. II. The taxa with closest distance (1 and 2) identified and connected. This allows to name an internal node. The distance matrix is reconstructed counting taxa 1 and 2 as a group. Identify the next closest sequences. Gurumayum Suraj Sharma III. Next closest sequences combined into cluster, and matrix is again redrawn. In the tree taxa 4 and 5 are now connected by a new node, 7. Further identify next smallest distance corresponding to the union of taxon 3 to cluster. IV. The newly formed group (cluster 4,5 joined with sequence 3) is represented on the emerging tree with new node 8. V. Finally, all sequences are connected in a rooted tree. Gurumayum Suraj Sharma INPUT/ INITIAL SETTING Start with clusters of individual points and a distance/proximity matrix p1 p2 p3 p4 p5 . p1 p2 p3 p4 p5 . Distance/Proximity. Matrix Gurumayum Suraj Sharma INTERMEDIATE STATE After some merging steps, we have some clusters C1 C2 C3 C4 C5 C1 C2 C3 C3 C4 C4 C5 C1 Distance/Proximity Matrix C2 C5 Gurumayum Suraj Sharma INTERMEDIATE STATE Merge the two closest clusters (C2 and C5) and update the distance matrix. C1 C2 C3 C4 C5 C1 C3 C2 C3 C4 C4 C5 C1 Distance/Proximity Matrix C2 C5 Gurumayum Suraj Sharma STEP 1 STEP 2 STEP 3 STEP 4 Critical Assumption of UPGMA - Rate of nucleotide or amino acid substitution is constant for all branches in tree, i.e., The Molecular Clock applies to all evolutionary lineages. If this assumption is true, branch lengths can be used to estimate the dates of divergence ,& sequence-based tree mimics a species tree. UPGMA tree is rooted because of its assumption of a molecular clock. If violated & there are unequal substitution rates along different branches of tree, the method can produce an incorrect tree. Other methods (including neighbour-joining) do not automatically produce a root, but a root can be placed by choosing an outgroup or by applying midpoint rooting. Gurumayum Suraj Sharma UPGMA Method - Commonly used distance method in variety of applications. Microarray data analysis. In phylogenetic analyses using molecular sequence data its simplifying assumptions tend to make it significantly less accurate than other distance-based methods such as neighbor-joining. Gurumayum Suraj Sharma DISTANCE-BASED METHODS NEIGHBOUR JOINING [SAITOU AND NEI, 1987 ] Neighbor-joining Method is used for building trees by Distance Methods . Produces both Topology & Branch lengths . Example: A neighbour is a pair of OTUs connected through a single interior node X in an unrooted, bifurcating tree Method related to the cluster method Does not require that all lineages have diverged by equal amounts. Especially suited for datasets comprising lineages with largely varying rates of evolution . Can be used in combination with methods that allow correction for superimposed substitutions. Gurumayum Suraj Sharma Neighbor-joining method - A special case of Star Decomposition Method . Keeps track of nodes on tree rather than taxa or clusters of taxa. Raw data provided as distance matrix & initial tree is a STAR TREE . Modified distance matrix is constructed in which separation between each pair of nodes is adjusted on basis of their average divergence from all other nodes. The tree is constructed by linking the least-distant pair of nodes in this modified matrix. When two nodes are linked, their common ancestral node is added & terminal nodes with their respective branches are removed. The process converts the newly added common ancestor into a terminal node on a tree of reduced size. At each stage two terminal nodes are replaced by one new node The process is complete when two nodes remain, separated by a single branch. Gurumayum Suraj Sharma The process of starting with a star-like tree and finding and joining neighbours is continued until the topology of the tree is completed. Neighbour-joining, algorithm minimizes the sum of branch lengths at each stage of clustering OTUs although the final tree is not necessarily the one with the shortest overall branch lengths. Results may differ from minimum evolution strategies or maximum parsimony. Neighbour joining produces an unrooted tree topology Because it does not assume a constant rate of evolution, unless an outgroup is specified or midpoint rooting is applied. Gurumayum Suraj Sharma NJ method distance-based algorithm: I. OTUs are first clustered in a Starlike Tree . “Neighbours ” are defined as OTUs that are connected by a single, interior node in an unrooted, bifurcating tree. II. Two closest OTUs are identified. These neighbours are connected to other OTUs via internal branch XY . The OTUs [neighbours] that are selected are chosen as ones that yield smallest sum of branch lengths. The process is repeated until the entire tree is generated Gurumayum Suraj Sharma Gurumayum Suraj Sharma ADVANTAGES & DISADVANTAGES ADVANTAGES o Fast and thus suited for large datasets and for bootstrap analysis o Permits lineages with largely different branch lengths o Permits correction for multiple substitutions DISADVANTAGES o Sequence information reduced o Gives only one possible tree o Strongly dependent on model of evolution used. Gurumayum Suraj Sharma MINIMUM EVOLUTION MAIN IDEA- Based on the assumption that the tree with the smallest sum of branch length estimates is most likely to be the true one. Length computed from pair-wise distance between the sequences . Slightly similar to Parsimony Method. Tree obtained for ME and parsimony methods nearly identical in topology and branch length. Available in PHYLIP & ClustalW package Gurumayum Suraj Sharma ADVANTAGES & DISADVANTAGES ADVANTAGES o Easy to perform & quick calculation o Fit for sequences having high similarity scores DISADVANTAGES o Loss of Information since sequences are not considered as such o All sites equally treated [differences in substitution rates not considered] o Not applicable in distantly related divergent sequences. Gurumayum Suraj Sharma Gurumayum Suraj Sharma PHYLOGENETIC INFERENCE MAXIMUM PARSIMONY Parsimony: Latin- Parcere meaning “ to spare ” Refers to simplicity of assumptions in a logical formulation MAIN IDEA- Best tree is that with the shortest branch lengths possible. Hennig (1966), and Eck & Dayhoff (1966) Used parsimony-based approach in generating phylogenetic trees based on morphological characters Gurumayum Suraj Sharma Dayhoff et al.
Recommended publications
  • Lecture Notes: the Mathematics of Phylogenetics
    Lecture Notes: The Mathematics of Phylogenetics Elizabeth S. Allman, John A. Rhodes IAS/Park City Mathematics Institute June-July, 2005 University of Alaska Fairbanks Spring 2009, 2012, 2016 c 2005, Elizabeth S. Allman and John A. Rhodes ii Contents 1 Sequences and Molecular Evolution 3 1.1 DNA structure . .4 1.2 Mutations . .5 1.3 Aligned Orthologous Sequences . .7 2 Combinatorics of Trees I 9 2.1 Graphs and Trees . .9 2.2 Counting Binary Trees . 14 2.3 Metric Trees . 15 2.4 Ultrametric Trees and Molecular Clocks . 17 2.5 Rooting Trees with Outgroups . 18 2.6 Newick Notation . 19 2.7 Exercises . 20 3 Parsimony 25 3.1 The Parsimony Criterion . 25 3.2 The Fitch-Hartigan Algorithm . 28 3.3 Informative Characters . 33 3.4 Complexity . 35 3.5 Weighted Parsimony . 36 3.6 Recovering Minimal Extensions . 38 3.7 Further Issues . 39 3.8 Exercises . 40 4 Combinatorics of Trees II 45 4.1 Splits and Clades . 45 4.2 Refinements and Consensus Trees . 49 4.3 Quartets . 52 4.4 Supertrees . 53 4.5 Final Comments . 54 4.6 Exercises . 55 iii iv CONTENTS 5 Distance Methods 57 5.1 Dissimilarity Measures . 57 5.2 An Algorithmic Construction: UPGMA . 60 5.3 Unequal Branch Lengths . 62 5.4 The Four-point Condition . 66 5.5 The Neighbor Joining Algorithm . 70 5.6 Additional Comments . 72 5.7 Exercises . 73 6 Probabilistic Models of DNA Mutation 81 6.1 A first example . 81 6.2 Markov Models on Trees . 87 6.3 Jukes-Cantor and Kimura Models .
    [Show full text]
  • Investgating Determinants of Phylogeneic Accuracy
    IMPACT OF MOLECULAR EVOLUTIONARY FOOTPRINTS ON PHYLOGENETIC ACCURACY – A SIMULATION STUDY Dissertation Submitted to The College of Arts and Sciences of the UNIVERSITY OF DAYTON In Partial Fulfillment of the Requirements for The Degree Doctor of Philosophy in Biology by Bhakti Dwivedi UNIVERSITY OF DAYTON August, 2009 i APPROVED BY: _________________________ Gadagkar, R. Sudhindra Ph.D. Major Advisor _________________________ Robinson, Jayne Ph.D. Committee Member Chair Department of Biology _________________________ Nielsen, R. Mark Ph.D. Committee Member _________________________ Rowe, J. John Ph.D. Committee Member _________________________ Goldman, Dan Ph.D. Committee Member ii ABSTRACT IMPACT OF MOLECULAR EVOLUTIONARY FOOTPRINTS ON PHYLOGENETIC ACCURACY – A SIMULATION STUDY Dwivedi Bhakti University of Dayton Advisor: Dr. Sudhindra R. Gadagkar An accurately inferred phylogeny is important to the study of molecular evolution. Factors impacting the accuracy of a phylogenetic tree can be traced to several consecutive steps leading to the inference of the phylogeny. In this simulation-based study our focus is on the impact of the certain evolutionary features of the nucleotide sequences themselves in the alignment rather than any source of error during the process of sequence alignment or due to the choice of the method of phylogenetic inference. Nucleotide sequences can be characterized by summary statistics such as sequence length and base composition. When two or more such sequences need to be compared to each other (as in an alignment prior to phylogenetic analysis) additional evolutionary features come into play, such as the overall rate of nucleotide substitution, the ratio of two specific instantaneous, rates of substitution (rate at which transitions and transversions occur), and the shape parameter, of the gamma distribution (that quantifies the extent of iii heterogeneity in substitution rate among sites in an alignment).
    [Show full text]
  • Phylogeny Inference Based on Parsimony and Other Methods Using Paup*
    8 Phylogeny inference based on parsimony and other methods using Paup* THEORY David L. Swofford and Jack Sullivan 8.1 Introduction Methods for inferring evolutionary trees can be divided into two broad categories: thosethatoperateonamatrixofdiscretecharactersthatassignsoneormore attributes or character states to each taxon (i.e. sequence or gene-family member); and those that operate on a matrix of pairwise distances between taxa, with each distance representing an estimate of the amount of divergence between two taxa since they last shared a common ancestor (see Chapter 1). The most commonly employed discrete-character methods used in molecular phylogenetics are parsi- mony and maximum likelihood methods. For molecular data, the character-state matrix is typically an aligned set of DNA or protein sequences, in which the states are the nucleotides A, C, G, and T (i.e. DNA sequences) or symbols representing the 20 common amino acids (i.e. protein sequences); however, other forms of discrete data such as restriction-site presence/absence and gene-order information also may be used. Parsimony, maximum likelihood, and some distance methods are examples of a broader class of phylogenetic methods that rely on the use of optimality criteria. Methods in this class all operate by explicitly defining an objective function that returns a score for any input tree topology. This tree score thus allows any two or more trees to be ranked according to the chosen optimality criterion. Ordinarily, phylogenetic inference under criterion-based methods couples the selection of The Phylogenetic Handbook: a Practical Approach to Phylogenetic Analysis and Hypothesis Testing, Philippe Lemey, Marco Salemi, and Anne-Mieke Vandamme (eds.).
    [Show full text]
  • An Introduction to Phylogenetic Analysis
    This article reprinted from: Kosinski, R.J. 2006. An introduction to phylogenetic analysis. Pages 57-106, in Tested Studies for Laboratory Teaching, Volume 27 (M.A. O'Donnell, Editor). Proceedings of the 27th Workshop/Conference of the Association for Biology Laboratory Education (ABLE), 383 pages. Compilation copyright © 2006 by the Association for Biology Laboratory Education (ABLE) ISBN 1-890444-09-X All rights reserved. No part of this publication may be reproduced, stored in a retrieval system, or transmitted, in any form or by any means, electronic, mechanical, photocopying, recording, or otherwise, without the prior written permission of the copyright owner. Use solely at one’s own institution with no intent for profit is excluded from the preceding copyright restriction, unless otherwise noted on the copyright notice of the individual chapter in this volume. Proper credit to this publication must be included in your laboratory outline for each use; a sample citation is given above. Upon obtaining permission or with the “sole use at one’s own institution” exclusion, ABLE strongly encourages individuals to use the exercises in this proceedings volume in their teaching program. Although the laboratory exercises in this proceedings volume have been tested and due consideration has been given to safety, individuals performing these exercises must assume all responsibilities for risk. The Association for Biology Laboratory Education (ABLE) disclaims any liability with regards to safety in connection with the use of the exercises in this volume. The focus of ABLE is to improve the undergraduate biology laboratory experience by promoting the development and dissemination of interesting, innovative, and reliable laboratory exercises.
    [Show full text]
  • Phylogeny Codon Models • Last Lecture: Poor Man’S Way of Calculating Dn/Ds (Ka/Ks) • Tabulate Synonymous/Non-Synonymous Substitutions • Normalize by the Possibilities
    Phylogeny Codon models • Last lecture: poor man’s way of calculating dN/dS (Ka/Ks) • Tabulate synonymous/non-synonymous substitutions • Normalize by the possibilities • Transform to genetic distance KJC or Kk2p • In reality we use codon model • Amino acid substitution rates meet nucleotide models • Codon(nucleotide triplet) Codon model parameterization Stop codons are not allowed, reducing the matrix from 64x64 to 61x61 The entire codon matrix can be parameterized using: κ kappa, the transition/transversionratio ω omega, the dN/dS ratio – optimizing this parameter gives the an estimate of selection force πj the equilibrium codon frequency of codon j (Goldman and Yang. MBE 1994) Empirical codon substitution matrix Observations: Instantaneous rates of double nucleotide changes seem to be non-zero There should be a mechanism for mutating 2 adjacent nucleotides at once! (Kosiol and Goldman) • • Phylogeny • • Last lecture: Inferring distance from Phylogenetic trees given an alignment How to infer trees and distance distance How do we infer trees given an alignment • • Branch length Topology d 6-p E 6'B o F P Edo 3 vvi"oH!.- !fi*+nYolF r66HiH- .) Od-:oXP m a^--'*A ]9; E F: i ts X o Q I E itl Fl xo_-+,<Po r! UoaQrj*l.AP-^PA NJ o - +p-5 H .lXei:i'tH 'i,x+<ox;+x"'o 4 + = '" I = 9o FF^' ^X i! .poxHo dF*x€;. lqEgrE x< f <QrDGYa u5l =.ID * c 3 < 6+6_ y+ltl+5<->-^Hry ni F.O+O* E 3E E-f e= FaFO;o E rH y hl o < H ! E Y P /-)^\-B 91 X-6p-a' 6J.
    [Show full text]
  • EVOLUTIONARY INFERENCE: Some Basics of Phylogenetic Analyses
    EVOLUTIONARY INFERENCE: Some basics of phylogenetic analyses. Ana Rojas Mendoza CNIO-Madrid-Spain. Alfonso Valencia’s lab. Aims of this talk: • 1.To introduce relevant concepts of evolution to practice phylogenetic inference from molecular data. • 2.To introduce some of the most useful methods and computer programmes to practice phylogenetic inference. • • 3.To show some examples I’ve worked in. SOME BASICS 11--ConceptsConcepts ofof MolecularMolecular EvolutionEvolution • Homology vs Analogy. • Homology vs similarity. • Ortologous vs Paralogous genes. • Species tree vs genes tree. • Molecular clock. • Allele mutation vs allele substitution. • Rates of allele substitution. • Neutral theory of evolution. SOME BASICS Owen’s definition of homology Richard Owen, 1843 • Homologue: the same organ under every variety of form and function (true or essential correspondence). •Analogy: superficial or misleading similarity. SOME BASICS 1.Concepts1.Concepts ofof MolecularMolecular EvolutionEvolution • Homology vs Analogy. • Homology vs similarity. • Ortologous vs Paralogous genes. • Species tree vs genes tree. • Molecular clock. • Allele mutation vs allele substitution. • Rates of allele substitution. • Neutral theory of evolution. SOME BASICS Similarity ≠ Homology • Similarity: mathematical concept . Homology: biological concept Common Ancestry!!! SOME BASICS 1.Concepts1.Concepts ofof MolecularMolecular EvolutionEvolution • Homology vs Analogy. • Homology vs similarity. • Ortologous vs Paralogous genes. • Species tree vs genes tree. • Molecular clock.
    [Show full text]
  • Family Classification
    1.0 GENERAL INTRODUCTION 1.1 Henckelia sect. Loxocarpus Loxocarpus R.Br., a taxon characterised by flowers with two stamens and plagiocarpic (held at an angle of 90–135° with pedicel) capsular fruit that splits dorsally has been treated as a section within Henckelia Spreng. (Weber & Burtt, 1998 [1997]). Loxocarpus as a genus was established based on L. incanus (Brown, 1839). It is principally recognised by its conical, short capsule with a broader base often with a hump-like swelling at the upper side (Banka & Kiew, 2009). It was reduced to sectional level within the genus Didymocarpus (Bentham, 1876; Clarke, 1883; Ridley, 1896) but again raised to generic level several times by different authors (Ridley, 1905; Burtt, 1958). In 1998, Weber & Burtt (1998 ['1997']) re-modelled Didymocarpus. Didymocarpus s.s. was redefined to a natural group, while most of the rest Malesian Didymocarpus s.l. and a few others morphologically close genera including Loxocarpus were transferred to Henckelia within which it was recognised as a section within. See Section 4.1 for its full taxonomic history. Molecular data now suggests that Henckelia sect. Loxocarpus is nested within ‗Twisted-fruited Asian and Malesian genera‘ group and distinct from other didymocarpoid genera (Möller et al. 2009; 2011). 1.2 State of knowledge and problem statements Henckelia sect. Loxocarpus includes 10 species in Peninsular Malaysia (with one species extending into Peninsular Thailand), 12 in Borneo, two in Sumatra and one in Lingga (Banka & Kiew, 2009). The genus Loxocarpus has never been monographed. Peninsular Malaysian taxa are well studied (Ridley, 1923; Banka, 1996; Banka & Kiew, 2009) but the Bornean and Sumatran taxa are poorly known.
    [Show full text]
  • The Probability of Monophyly of a Sample of Gene Lineages on a Species Tree
    PAPER The probability of monophyly of a sample of gene COLLOQUIUM lineages on a species tree Rohan S. Mehtaa,1, David Bryantb, and Noah A. Rosenberga aDepartment of Biology, Stanford University, Stanford, CA 94305; and bDepartment of Mathematics and Statistics, University of Otago, Dunedin 9054, New Zealand Edited by John C. Avise, University of California, Irvine, CA, and approved April 18, 2016 (received for review February 5, 2016) Monophyletic groups—groups that consist of all of the descendants loci that are reciprocally monophyletic is informative about the of a most recent common ancestor—arise naturally as a conse- time since species divergence and can assist in representing the quence of descent processes that result in meaningful distinctions level of differentiation between groups (4, 18). between organisms. Aspects of monophyly are therefore central to Many empirical investigations of genealogical phenomena have fields that examine and use genealogical descent. In particular, stud- made use of conceptual and statistical properties of monophyly ies in conservation genetics, phylogeography, population genetics, (19). Comparisons of observed monophyly levels to model pre- species delimitation, and systematics can all make use of mathemat- dictions have been used to provide information about species di- ical predictions under evolutionary models about features of mono- vergence times (20, 21). Model-based monophyly computations phyly. One important calculation, the probability that a set of gene have been used alongside DNA sequence differences between and lineages is monophyletic under a two-species neutral coalescent within proposed clades to argue for the existence of the clades model, has been used in many studies. Here, we extend this calcu- (22), and tests involving reciprocal monophyly have been used to lation for a species tree model that contains arbitrarily many species.
    [Show full text]
  • A Comparative Phenetic and Cladistic Analysis of the Genus Holcaspis Chaudoir (Coleoptera: .Carabidae)
    Lincoln University Digital Thesis Copyright Statement The digital copy of this thesis is protected by the Copyright Act 1994 (New Zealand). This thesis may be consulted by you, provided you comply with the provisions of the Act and the following conditions of use: you will use the copy only for the purposes of research or private study you will recognise the author's right to be identified as the author of the thesis and due acknowledgement will be made to the author where appropriate you will obtain the author's permission before publishing any material from the thesis. A COMPARATIVE PHENETIC AND CLADISTIC ANALYSIS OF THE GENUS HOLCASPIS CHAUDOIR (COLEOPTERA: CARABIDAE) ********* A thesis submitted in partial fulfilment of the requirements for the degree of Doctor of Philosophy at Lincoln University by Yupa Hanboonsong ********* Lincoln University 1994 Abstract of a thesis submitted in partial fulfilment of the requirements for the degree of Ph.D. A comparative phenetic and cladistic analysis of the genus Holcaspis Chaudoir (Coleoptera: .Carabidae) by Yupa Hanboonsong The systematics of the endemic New Zealand carabid genus Holcaspis are investigated, using phenetic and cladistic methods, to construct phenetic and phylogenetic relationships. Three different character data sets: morphological, allozyme and random amplified polymorphic DNA (RAPD) based on the polymerase chain reaction (PCR), are used to estimate the relationships. Cladistic and morphometric analyses are undertaken on adult morphological characters. Twenty six external morphological characters, including male and female genitalia, are used for cladistic analysis. The results from the cladistic analysis are strongly congruent with previous publications. The morphometric analysis uses multivariate discriminant functions, with 18 morphometric variables, to derive a phenogram by clustering from Mahalanobis distances (D2) of the discrimination analysis using the unweighted pair-group method with arithmetical averages (UPGMA).
    [Show full text]
  • Math/C SC 5610 Computational Biology Lecture 12: Phylogenetics
    Math/C SC 5610 Computational Biology Lecture 12: Phylogenetics Stephen Billups University of Colorado at Denver Math/C SC 5610Computational Biology – p.1/25 Announcements Project Guidelines and Ideas are posted. (proposal due March 8) CCB Seminar, Friday (Mar. 4) Speaker: Jack Horner, SAIC Title: Phylogenetic Methods for Characterizing the Signature of Stage I Ovarian Cancer in Serum Protein Mas Time: 11-12 (Followed by lunch) Place: Media Center, AU008 Math/C SC 5610Computational Biology – p.2/25 Outline Distance based methods for phylogenetics UPGMA WPGMA Neighbor-Joining Character based methods Maximum Likelihood Maximum Parsimony Math/C SC 5610Computational Biology – p.3/25 Review: Distance Based Clustering Methods Main Idea: Requires a distance matrix D, (defining distances between each pair of elements). Repeatedly group together closest elements. Different algorithms differ by how they treat distances between groups. UPGMA (unweighted pair group method with arithmetic mean). WPGMA (weighted pair group method with arithmetic mean). Math/C SC 5610Computational Biology – p.4/25 UPGMA 1. Initialize C to the n singleton clusters f1g; : : : ; fng. 2. Initialize dist(c; d) on C by defining dist(fig; fjg) = D(i; j): 3. Repeat n ¡ 1 times: (a) determine pair c; d of clusters in C such that dist(c; d) is minimal; define dmin = dist(c; d). (b) define new cluster e = c S d; update C = C ¡ fc; dg Sfeg. (c) define a node with label e and daughters c; d, where e has distance dmin=2 to its leaves. (d) define for all f 2 C with f 6= e, dist(c; f) + dist(d; f) dist(e; f) = dist(f; e) = : (avg.
    [Show full text]
  • Solution Sheet
    Solution sheet Sequence Alignments and Phylogeny Bioinformatics Leipzig WS 13/14 Solution sheet 1 Biological Background 1.1 Which of the following are pyrimidines? Cytosine and Thymine are pyrimidines (number 2) 1.2 Which of the following contain phosphorus atoms? DNA and RNA contain phosphorus atoms (number 2). 1.3 Which of the following contain sulfur atoms? Methionine contains sulfur atoms (number 3). 1.4 Which of the following is not a valid amino acid sequence? There is no amino acid with the one letter code 'O', such that there is no valid amino acid sequence 'WATSON' (number 4). 1.5 Which of the following 'one-letter' amino acid sequence corresponds to the se- quence Tyr-Phe-Lys-Thr-Glu-Gly? The amino acid sequence corresponds to the one letter code sequence YFKTEG (number 1). 1.6 Consider the following DNA oligomers. Which to are complementary to one an- other? All are written in the 5' to 3' direction (i.TTAGGC ii.CGGATT iii.AATCCG iv.CCGAAT) CGGATT (ii) and AATCCG (iii) are complementary (number 2). 2 Pairwise Alignments 2.1 Needleman-Wunsch Algorithm Given the alphabet B = fA; C; G; T g, the sequences s = ACGCA and p = ACCG and the following scoring matrix D: A C T G - A 3 -1 -1 -1 -2 C -1 3 -1 -1 -2 T -1 -1 3 -1 -2 G -1 -1 -1 3 -2 - -2 -2 -2 -2 0 1. What kind of scoring function is given by the matrix D, similarity or distance score? 2. Use the Needleman-Wunsch algorithm to compute the pairwise alignment of s and p.
    [Show full text]
  • Clustering and Phylogenetic Approaches to Classification: Illustration on Stellar Tracks Didier Fraix-Burnet, Marc Thuillard
    Clustering and Phylogenetic Approaches to Classification: Illustration on Stellar Tracks Didier Fraix-Burnet, Marc Thuillard To cite this version: Didier Fraix-Burnet, Marc Thuillard. Clustering and Phylogenetic Approaches to Classification: Il- lustration on Stellar Tracks. 2014. hal-01703341 HAL Id: hal-01703341 https://hal.archives-ouvertes.fr/hal-01703341 Preprint submitted on 7 Feb 2018 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. Clustering and Phylogenetic Approaches to Classification: Illustration on Stellar Tracks D. Fraix-Burnet1, M. Thuillard2 1 Univ. Grenoble Alpes, CNRS, IPAG, 38000 Grenoble, France email: [email protected] 2 La Colline, 2072 St-Blaise, Switzerland February 7, 2018 This pedagogicalarticle was written in 2014 and is yet unpublished. Partofit canbefoundin Fraix-Burnet (2015). Abstract Classifying objects into groups is a natural activity which is most often a prerequisite before any physical analysis of the data. Clustering and phylogenetic approaches are two different and comple- mentary ways in this purpose: the first one relies on similarities and the second one on relationships. In this paper, we describe very simply these approaches and show how phylogenetic techniques can be used in astrophysics by using a toy example based on a sample of stars obtained from models of stellar evolution.
    [Show full text]