Neutral mutations Neither advantageous nor disadvantageous Invisible to selection (no selection) Frequency subject to ‘drift’ in the population Mutation.

Slides:



Advertisements
Similar presentations
Quick Lesson on dN/dS Neutral Selection Codon Degeneracy Synonymous vs. Non-synonymous dN/dS ratios Why Selection? The Problem.
Advertisements

Blast outputoutput. How to measure the similarity between two sequences Q: which one is a better match to the query ? Query: M A T W L Seq_A: M A T P.
MCB 5472 Blast, Psi BLAST, Perl: Arrays, Loops J. Peter Gogarten Office: BPB 404 phone: ,
BLAST, PSI-BLAST and position- specific scoring matrices Prof. William Stafford Noble Department of Genome Sciences Department of Computer Science and.
ATPase dataset -> nj in figtree. ATPase dataset -> muscle -> phyml (with ASRV)– re-rooted.
Random Genetic Drift Selection Allele frequency advantageous disadvantageous Modified from from
Bioinformatics Finding signals and motifs in DNA and proteins Expectation Maximization Algorithm MEME The Gibbs sampler Lecture 10.
Molecular Evolution Revised 29/12/06
MCB 5472 Psi BLAST, Perl: Arrays, Loops J. Peter Gogarten Office: BPB 404 phone: ,
Heuristic alignment algorithms and cost matrices
The gradualist point of view Evolution occurs within populations where the fittest organisms have a selective advantage. Over time the advantages genes.
The gradualist point of view Evolution occurs within populations where the fittest organisms have a selective advantage. Over time the advantages genes.
PSI (position-specific iterated) BLAST The NCBI page described PSI blast as follows: “Position-Specific Iterated BLAST (PSI-BLAST) provides an automated,
Molecular Evolution with an emphasis on substitution rates Gavin JD Smith State Key Laboratory of Emerging Infectious Diseases & Department of Microbiology.
The gradualist point of view Evolution occurs within populations where the fittest organisms have a selective advantage. Over time the advantages genes.
Branches, splits, bipartitions In a rooted tree: clades (for urooted trees sometimes the term clann is used) Mono-, Para-, polyphyletic groups, cladists.
Positive selection A new allele (mutant) confers some increase in the fitness of the organism Selection acts to favour this allele Also called adaptive.
Example of bipartition analysis for five genomes of photosynthetic bacteria (188 gene families) total 10 bipartitions R: Rhodobacter capsulatus, H: Heliobacillus.
Similar Sequence Similar Function Charles Yan Spring 2006.
Cenancestor (aka LUCA or MRCA) can be placed using the echo remaining from the early expansion of the genetic code. reflects only a single cellular component.
Psi-Blast: Detecting structural homologs Psi-Blast was designed to detect homology for highly divergent amino acid sequences Psi = position-specific iterated.
MCB 372 PSI BLAST, scalars J. Peter Gogarten Office: BPB 404 phone: ,
Whole genome alignments Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas
TGCAAACTCAAACTCTTTTGTTGTTCTTACTGTATCATTGCCCAGAATAT TCTGCCTGTCTTTAGAGGCTAATACATTGATTAGTGAATTCCAATGGGCA GAATCGTGATGCATTAAAGAGATGCTAATATTTTCACTGCTCCTCAATTT.
Pairwise Alignment How do we tell whether two sequences are similar? BIO520 BioinformaticsJim Lund Assigned reading: Ch , Ch 5.1, get what you can.
Multiple testing correction
MCB5472 Computer methods in molecular evolution Lecture 4/14/2014.
An Introduction to Bioinformatics
Basic Introduction of BLAST Jundi Wang School of Computing CSC691 09/08/2013.
MCB 5472 Psi BLAST, Perl: Arrays, Loops, Hashes J. Peter Gogarten Office: BPB 404 phone: ,
Neutral theory: The vast majority of observed sequence differences between members of a population are neutral (or close to neutral). These differences.
In the deterministic model, the time till fixation depends on the selective advantage, but fixation is guaranteed.
Molecular basis of evolution. Goal – to reconstruct the evolutionary history of all organisms in the form of phylogenetic trees. Classical approach: phylogenetic.
Selection versus drift The larger the population the longer it takes for an allele to become fixed. Note: Even though an allele conveys a strong selective.
ATPase dataset -> nj in figtree. ATPase dataset -> muscle -> phyml (with ASRV)– re-rooted.
Bioinformatics 2011 Molecular Evolution Revised 29/12/06.
Eric C. Rouchka, University of Louisville Sequence Database Searching Eric Rouchka, D.Sc. Bioinformatics Journal Club October.
Searching Molecular Databases with BLAST. Basic Local Alignment Search Tool How BLAST works Interpreting search results The NCBI Web BLAST interface Demonstration.
CISC667, F05, Lec9, Liao CISC 667 Intro to Bioinformatics (Fall 2005) Sequence Database search Heuristic algorithms –FASTA –BLAST –PSI-BLAST.
1 P6a Extra Discussion Slides Part 1. 2 Section A.
Comp. Genomics Recitation 3 The statistics of database searching.
Bioinformatics Ayesha M. Khan 9 th April, What’s in a secondary database?  It should be noted that within multiple alignments can be found conserved.
BLAST Slides adapted & edited from a set by Cheryl A. Kerfeld (UC Berkeley/JGI) & Kathleen M. Scott (U South Florida) Kerfeld CA, Scott KM (2011) Using.
Basic Local Alignment Search Tool BLAST Why Use BLAST?
Database search. Overview : 1. FastA : is suitable for protein sequence searching 2. BLAST : is suitable for DNA, RNA, protein sequence searching.
N=50 s=0.150 replicates s>0 Time till fixation on average: t av = (2/s) ln (2N) generations (also true for mutations with negative “s” ! discuss among.
©CMBI 2005 Database Searching BLAST Database Searching Sequence Alignment Scoring Matrices Significance of an alignment BLAST, algorithm BLAST, parameters.
LBA phyml Gamma = 1 no alignment – true homologous positions with muscle alignment log 10 (x)
Bayes’ Theorem Reverend Thomas Bayes ( ) Posterior Probability represents the degree to which we believe a given model accurately describes the.
Blast 2.0 Details The Filter Option: –process of hiding regions of (nucleic acid or amino acid) sequence having characteristics.
Step 3: Tools Database Searching
Bootstrap ? See herehere. Maximum Likelihood and Model Choice The maximum Likelihood Ratio Test (LRT) allows to compare two nested models given a dataset.Likelihood.
©CMBI 2005 Database Searching BLAST Database Searching Sequence Alignment Scoring Matrices Significance of an alignment BLAST, algorithm BLAST, parameters.
MCB 3421 class 25. student evaluations Please go to husky CT and complete student evaluations !
Codon based alignments in Seaview Load nucleotide sequences (no gaps in sequences, sequence starts with nucleotide corresponding to 1 st codon position)
The gradualist point of view Evolution occurs within populations where the fittest organisms have a selective advantage. Over time the advantages genes.
Substitution Matrices and Alignment Statistics BMI/CS 776 Mark Craven February 2002.
LBA ProtPars. LBA Prot Dist no Gamma and no alignment.
The Coral of Life (Darwin)
Basics of BLAST Basic BLAST Search - What is BLAST?
Distances.
Codon based alignments in Seaview
BLAST.
PSI (position-specific iterated) BLAST
Basic Local Alignment Search Tool
Variant arose about years ago
Blast, Psi BLAST, Perl: Arrays, Loops
DN/dS.
Basic Local Alignment Search Tool
BLAST, unix, Perl continued
Presentation transcript:

Neutral mutations Neither advantageous nor disadvantageous Invisible to selection (no selection) Frequency subject to ‘drift’ in the population Mutation rate = Substitution rate (independent of population size) In small populations, slightly deleterious or advantagous mutations behave as if neutral. (N eff *s<<1)

Degeneracy of 1 st vs 2 nd vs 3 rd position sites results in 25.5% synonymous changes and 74.5% non synonymous changes (Yang&Nielsen,1998). Genetic Code

Measuring Selection on Genes Null hypothesis = neutral evolution Under neutral evolution, synonymous changes should accumulate at a rate equal to mutation rate Under neutral evolution, amino acid substitutions should also accumulate at a rate equal to the mutation rate From: mentor.lscf.ucsb.edu/course/spring/eemb102/lecture/Lecture7.ppt

Testing for selection using dN/dS ratio dN/dS ratio ( aka Ka/Ks or ω (omega) ratio) where dN = number of non-synonymous substitutions / number of possible non-synonymous substitutions dS =number of synonymous substitutions / number of possible non- synonymous substitutions dN/dS >1 positive, Darwinian selection dN/dS =1 neutral evolution dN/dS <1 negative, purifying selection

dambe Three programs worked well for me to align nucleotide sequences based on the amino acid alignment, One is DAMBE (works well for windows). This is a handy program for a lot of things, including reading a lot of different formats, calculating phylogenies, it even runs codeml (from PAML) for you.DAMBE The procedure is not straight forward, but is well described on the help pages. After installing DAMBE go to HELP -> general HELP -> sequences -> align nucleotide sequences based on …-> If you follow the instructions to the letter, it works fine. DAMBE also calculates Ka and Ks distances from codon based aligned sequences. Alternatives are tranalign from the EMBOSS package, andtranalignEMBOSS Seaview (see below)

dambe (cont)

Codon based alignments in Seaview Load nucleotide sequences (no gaps in sequences, sequence starts with nucleotide corresponding to 1 st codon position) Select view as proteins

Codon based alignments in Seaview With the protein sequences displayed, align sequences Select view as nucleotides

PAML (codeml) the basic model

sites versus branches You can determine omega for the whole dataset; however, usually not all sites in a sequence are under selection all the time. PAML (and other programs) allow to either determine omega for each site over the whole tree,, or determine omega for each branch for the whole sequence,. It would be great to do both, i.e., conclude codon 176 in the vacuolar ATPases was under positive selection during the evolution of modern humans – alas, a single site does not provide much statistics ….

Sites model(s) work great have been shown to work great in few instances. The most celebrated case is the influenza virus HA gene. A talk by Walter Fitch (slides and sound) on the evolution of this molecule is here.here This article by Yang et al, 2000 gives more background on ml aproaches to measure omega. The dataset used by Yang et al is here: flu_data.paup. article by Yang et al, 2000 flu_data.paup

sites model in MrBayes begin mrbayes; set autoclose=yes; lset nst=2 rates=gamma nucmodel=codon omegavar=Ny98; mcmcp samplefreq=500 printfreq=500; mcmc ngen=500000; sump burnin=50; sumt burnin=50; end; The MrBayes block in a nexus file might look something like this:

plot LogL to determine which samples to ignore the same after rescaling the y-axis

for each codon calculate the the average probability enter formula copy paste formula plot row

To determine credibility interval for a parameter (here omega<1): Select values for the parameter, sampled after the burning. Copy paste to a new spreadsheet,

Sort values according to size, Discard top and bottom 2.5% Remainder gives 95% credibility interval.

Purifying selection in GTA genes dN/dS <1 for GTA genes has been used to infer selection for function GTA genes Lang AS, Zhaxybayeva O, Beatty JT. Nat Rev Microbiol Jun 11;10(7): Lang, A.S. & Beatty, J.T. Trends in Microbiology, Vol.15, No.2, 2006

Purifying selection in E.coli ORFans dN-dS < 0 for some ORFan E. coli clusters seems to suggest they are functional genes. Adapted after Yu, G. and Stoltzfus, A. Genome Biol Evol (2012) Vol Gene groupsNumberdN-dS>0dN-dS<0dN-dS=0 E. coli ORFan clusters (25%)1953 (52%)876 (23%) Clusters of E.coli sequences found in Salmonella sp., Citrobacter sp (17%)423(69%)83 (14%) Clusters of E.coli sequences found in some Enterobacteriaceae only 3738 (2%)365 (98%)0 (0%)

Vertically Inherited Genes Not Expressed for Function

Counting Algorithm Calculate number of different nucleotides/amino acids per MSA column (X) Calculate number of nucleotides/amino acids substitutions (X-1) Calculate number of synonymous changes S=(N-1)nc-N assuming N=(N-1)aa 1 non-synonymous change X=2 1 nucleotide substitution X=2 1 amino acid substitution

Simulation Algorithm Calculate MSA nucleotide frequencies (%A,%T,%G,%C) Introduce a given number of random substitutions ( at any position) based on inferred base frequencies Compare translated mutated codon with the initial translated codon and count synonymous and non-synonymous substitutions

Evolution of Coding DNA Sequences Under a Neutral Model E. coli Prophage Genes Probability distribution Count distribution Non-synonymous Synonymous n= 90 k= 24 p=0.763 P(≤24)=3.63E-23 Observed=24 P(≤24) < n= 90 k= 66 p= P(≥66)=3.22E-23 Observed=66 P(≥66) < n=90

Probability distribution Count distribution Synonymous n= 723 k= 498 p=0.232 P(≥498)=6.41E-149 n= 375 k= 243 p=0.237 P(≥243)=7.92E-64 Observed=498 P(≥498) < Observed=243 P(≥243) < n=723 n=375 Evolution of Coding DNA Sequences Under a Neutral Model E. coli Prophage Genes

Values well below the p=0.01 threshold suggest that we can reject the null hypothesis of neutral evolution of prophage sequences. Evolution of Coding DNA Sequences Under a Neutral Model E. coli Prophage Genes OBSERVEDSIMULATEDDnaparsSimulatedCodeml Gene Alignment Length (bp)Substitutions Synonymous changes*Substitutions p-value synonymous (given *) Minimum number of substitutionsdN/dS Major capsid E Minor capsid C E Large terminase subunit E Small terminase subunit E Portal E-21* Protease E Minor tail H E Minor tail L E Host specificity J E-149* Tail fiber K E Tail assembly I E Tail tape measure protein E

Evolution of Coding DNA Sequences Under a Neutral Model B. pseudomallei Cryptic Malleilactone Operon Genes and E. coli transposase sequences OBSERVEDSIMULATED Gene Alignment Length (bp)Substitutions Synonymous changes*Substitutions p-value synonymous (given *) Aldehyde dehydrogenase E-04 AMP- binding protein E-02 Adenosylmethionine-8- amino-7-oxononanoate aminotransferase E-04 Fatty-acid CoA ligase E-01 Diaminopimelate decarboxylase E-01 Malonyl CoA-acyl transacylase E-01 FkbH domain protein E-02 Hypothethical protein E-01 Ketol-acid reductoisomerase E+00 Peptide synthase regulatory protein E-02 Polyketide-peptide synthase E-27 OBSERVEDSIMULATED Gene Alignment Length (bp)Substitutions Synonymous changes*Substitutions p-value synonymous (given *) Putative transposase E-29

Trunk-of-my-car analogy: Hardly anything in there is the is the result of providing a selective advantage. Some items are removed quickly (purifying selection), some are useful under some conditions, but most things do not alter the fitness. Could some of the inferred purifying selection be due to the acquisition of novel detrimental characteristics (e.g., protein toxicity, HOPELESS MONSTERS)?

Other ways to detect positive selection Selective sweeps -> fewer alleles present in population (see contributions from archaic Humans for example) Repeated episodes of positive selection -> high dN

Variant arose about 5800 years ago

The age of haplogroup D was found to be ~37,000 years

Adam and Eve never met  Albrecht Dürer, The Fall of Man, 1504 Mitochondrial Eve Y chromosome Adam Lived approximately 40,000 years ago Lived 166, ,000 years ago Thomson, R. et al. (2000) Proc Natl Acad Sci U S A 97, Underhill, P.A. et al. (2000) Nat Genet 26, Mendez et al. (2013) American Journal of Human Genetics 92 (3): 454. Cann, R.L. et al. (1987) Nature 325, 31-6 Vigilant, L. et al. (1991) Science 253, The same is true for ancestral rRNAs, EF, ATPases!

From: speeding-research-into-human-origins.html?_r=1http:// speeding-research-into-human-origins.html?_r=1

The multiregional hypothesis From

Ancient migrations. The proportions of Denisovan DNA in modern human populations are shown as red in pie charts, relative to New Guinea and Australian Aborigines (3). Wallace's Line (8) is formed by the powerful Indonesian flow-through current (blue arrows) and marks the limit of the Sunda shelf and Eurasian placental mammals. Did the Denisovans Cross Wallace's Line? Science 18 October 2013: vol. 342 no

From: Archaic human admixture with modern Homo sapiens

For more discussion on archaic and early humans see: speeding-research-into-human-origins.html html

PSI (position-specific iterated) BLAST The NCBI page described PSI blast as follows: “Position-Specific Iterated BLAST (PSI-BLAST) provides an automated, easy-to-use version of a "profile" search, which is a sensitive way to look for sequence homologues. The program first performs a gapped BLAST database search. The PSI-BLAST program uses the information from any significant alignments returned to construct a position-specific score matrix, which replaces the query sequence for the next round of database searching. PSI-BLAST may be iterated until no new significant alignments are found. At this time PSI-BLAST may be used only for comparing protein queries with protein databases.”

The Psi-Blast Approach 1. Use results of BlastP query to construct a multiple sequence alignment 2. Construct a position-specific scoring matrix from the alignment 3. Search database with alignment instead of query sequence 4. Add matches to alignment and repeat Psi-Blast can use existing multiple alignment, or use RPS-Blast to search a database of PSSMs

PSI BLAST scheme

Position-specific Matrix M Gribskov, A D McLachlan, and D Eisenberg (1987) Profile analysis: detection of distantly related proteins. PNAS 84: by Bob Friedman

Psi-Blast Psi-Blast Results Query: (intein) link to sequence here, check BLink here

Psi-Blast is for finding matches among divergent sequences (position- specific information) WARNING: For the nth iteration of a PSI BLAST search, the E-value gives the number of matches to the profile NOT to the initial query sequence! The danger is that the profile was corrupted in an earlier iteration. PSI BLAST and E-values!

Often you want to run a PSIBLAST search with two different databanks - one to create the PSSM, the other to get sequences: To create the PSSM: blastpgp -d nr -i subI -j 5 -C subI.ckp -a 2 -o subI.out -h F f blastpgp -d swissprot -i gamma -j 5 -C gamma.ckp -a 2 -o gamma.out -h F f Runs 4 iterations of a PSIblast the -h option tells the program to use matches with E <10^-5 for the next iteration, (the default is ) -C creates a checkpoint (called subI.ckp), -o writes the output to subI.out, -i option specifies input as using subI as input (a fasta formated aa sequence). The nr databank used is stored in /common/data/ -a 2 use two processors -h e-value threshold for inclusion in multipass model [Real] default = THIS IS A RATHER HIGH NUMBER!!! (It might help to use the node with more memory (017) (command is ssh node017) PSI Blast from the command line

To use the PSSM: blastpgp -d /Users/jpgogarten/genomes/msb8.faa -i subI -a 2 -R subI.ckp -o subI.out3 -F f blastpgp -d /Users/jpgogarten/genomes/msb8.faa -i gamma -a 2 -R gamma.ckp -o gamma.out3 -F f Runs another iteration of the same blast search, but uses the databank /Users/jpgogarten/genomes/msb8.faa -R tells the program where to resume -d specifies a different databank -i input file - same sequence as before -o output_filename -a 2 use two processors -h e-value threshold for inclusion in multipass model [Real] default = This is a rather high number, but might be ok for the last iteration.

PSI Blast and finding gene families within genomes 2nd step: use PSSM to search genome: A)Use protein sequences encoded in genome as target: blastpgp -d target_genome.faa -i query.name -a 2 -R query.ckp -o query.out3 -F f B) Use nucleotide sequence and tblastn. This is an advantage if you are also interested in pseudogenes, and/or if you don’t trust the genome annotation: blastall -i query.name -d target_genome_nucl.ffn -p psitblastn -R query.ckp

Psi-Blast finds homologs among divergent sequences (position-specific information) WARNING: For the nth iteration of a PSI BLAST search, the E-value gives the number of matches to the profile NOT to the initial query sequence! The danger is that the profile was corrupted in an earlier iteration.