BNFO 602, Lecture 2 Usman Roshan Some of the slides are based upon material by David Wishart of University.

Slides:



Advertisements
Similar presentations
Fa07CSE 182 CSE182-L4: Database filtering. Fa07CSE 182 Summary (through lecture 3) A2 is online We considered the basics of sequence alignment –Opt score.
Advertisements

Molecular Evolution Revised 29/12/06
BNFO 602 Multiple sequence alignment Usman Roshan.
CIS786, Lecture 7 Usman Roshan Some of the slides are based upon material by Dennis Livesay and David.
Lecture 1 BNFO 601 Usman Roshan. Course overview Perl progamming language (and some Unix basics) –Unix basics –Intro Perl exercises –Dynamic programming.
Heuristic alignment algorithms and cost matrices
BNFO 602 Phylogenetics Usman Roshan.
Lecture 1 BNFO 135 Usman Roshan. Course overview Perl progamming language (and some Unix basics) –Unix basics –Intro Perl exercises –Programs for comparing.
Expected accuracy sequence alignment
Lecture 1 BNFO 240 Usman Roshan. Course overview Perl progamming language (and some Unix basics) Sequence alignment problem –Algorithm for exact pairwise.
BNFO 602 Lecture 2 Usman Roshan. Sequence Alignment Widely used in bioinformatics Proteins and genes are of different lengths due to error in sequencing.
BNFO 240 Usman Roshan. Last time Traceback for alignment How to select the gap penalties? Benchmark alignments –Structural superimposition –BAliBASE.
BNFO 602, Lecture 3 Usman Roshan Some of the slides are based upon material by David Wishart of University.
Lecture 1 BNFO 601 Usman Roshan. Course overview Perl progamming language (and some Unix basics) –Unix basics –Intro Perl exercises –Sequence alignment.
Similar Sequence Similar Function Charles Yan Spring 2006.
Lecture 4 BNFO 235 Usman Roshan. IUPAC Nucleic Acid symbols.
Sequence Alignment III CIS 667 February 10, 2004.
BNFO 602 Lecture 2 Usman Roshan. Bioinformatics problems Sequence alignment: oldest and still actively studied Genome-wide association studies: new problem,
BNFO 602 Multiple sequence alignment Usman Roshan.
BNFO 235 Lecture 5 Usman Roshan. What we have done to date Basic Perl –Data types: numbers, strings, arrays, and hashes –Control structures: If-else,
BNFO 602 Phylogenetics Usman Roshan. Summary of last time Models of evolution Distance based tree reconstruction –Neighbor joining –UPGMA.
Protein Multiple Sequence Alignment Sarah Aerni CS374 December 7, 2006.
CIS786, Lecture 6 Usman Roshan Some of the slides are based upon material by David Wishart of University.
Alignment III PAM Matrices. 2 PAM250 scoring matrix.
Multiple Sequence Alignments
Lecture 1 BNFO 136 Usman Roshan. Course overview Pre-req: BNFO 135 or approval of instructor Python progamming language and Perl for continuing students.
Introduction to Bioinformatics From Pairwise to Multiple Alignment.
CIS786, Lecture 8 Usman Roshan Some of the slides are based upon material by Dennis Livesay and David.
Chapter 5 Multiple Sequence Alignment.
Alignment Statistics and Substitution Matrices BMI/CS 576 Colin Dewey Fall 2010.
Multiple Sequence Alignment CSC391/691 Bioinformatics Spring 2004 Fetrow/Burg/Miller (Slides by J. Burg)
Multiple sequence alignment
Multiple Sequence Alignment
Multiple Sequence Alignments and Phylogeny.  Within a protein sequence, some regions will be more conserved than others. As more conserved,
Practical multiple sequence algorithms Sushmita Roy BMI/CS 576 Sushmita Roy Sep 24th, 2013.
Amino Acid Scoring Matrices Jason Davis. Overview Protein synthesis/evolution Protein synthesis/evolution Computational sequence alignment Computational.
Pairwise Sequence Alignment. The most important class of bioinformatics tools – pairwise alignment of DNA and protein seqs. alignment 1alignment 2 Seq.
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.
Pairwise alignment of DNA/protein sequences I519 Introduction to Bioinformatics, Fall 2012.
Comp. Genomics Recitation 3 The statistics of database searching.
Construction of Substitution Matrices
Calculating branch lengths from distances. ABC A B C----- a b c.
Bioinformatics Multiple Alignment. Overview Introduction Multiple Alignments Global multiple alignment –Introduction –Scoring –Algorithms.
Function preserves sequences Christophe Roos - MediCel ltd Similarity is a tool in understanding the information in a sequence.
Sequence Alignment Only things that are homologous should be compared in a phylogenetic analysis Homologous – sharing a common ancestor This is true for.
More statistical stuff CS 394C Feb 6, Today Review of material from Jan 31 Calculating pattern probabilities Why maximum parsimony and UPGMA are.
MUSCLE An Attractive MSA Application. Overview Some background on the MUSCLE software. The innovations and improvements of MUSCLE. The MUSCLE algorithm.
BLAST: Basic Local Alignment Search Tool Altschul et al. J. Mol Bio CS 466 Saurabh Sinha.
Doug Raiford Lesson 5.  Dynamic programming methods  Needleman-Wunsch (global alignment)  Smith-Waterman (local alignment)  BLAST Fixed: best Linear:
Sequence Alignment.
Burkhard Morgenstern Institut für Mikrobiologie und Genetik Molekulare Evolution und Rekonstruktion von phylogenetischen Bäumen WS 2006/2007.
Construction of Substitution matrices
Sequence Alignment Abhishek Niroula Department of Experimental Medical Science Lund University
Step 3: Tools Database Searching
The statistics of pairwise alignment BMI/CS 576 Colin Dewey Fall 2015.
Expected accuracy sequence alignment Usman Roshan.
V diagonal lines give equivalent residues ILS TRIVHVNSILPSTN V I L S T R I V I L P E F S T Sequence A Sequence B Dot Plots, Path Matrices, Score Matrices.
Sequence alignment CS 394C: Fall 2009 Tandy Warnow September 24, 2009.
Lecture 1 BNFO 601 Usman Roshan. Course overview Perl progamming language (and some Unix basics) –Unix basics –Intro Perl exercises –Dynamic programming.
Techniques for Protein Sequence Alignment and Database Searching G P S Raghava Scientist & Head Bioinformatics Centre, Institute of Microbial Technology,
Substitution Matrices and Alignment Statistics BMI/CS 776 Mark Craven February 2002.
Pairwise Sequence Alignment and Database Searching
Distance based phylogenetics
Multiple sequence alignment (msa)
BNFO 602 Lecture 2 Usman Roshan.
BNFO 602 Phylogenetics Usman Roshan.
BNFO 602 Phylogenetics – maximum parsimony
BNFO 602 Lecture 2 Usman Roshan.
CS 394C: Computational Biology Algorithms
Presentation transcript:

BNFO 602, Lecture 2 Usman Roshan Some of the slides are based upon material by David Wishart of University of Alberta and Ron Shamir of Tel Aviv University

Previously… Model of DNA sequence evolution –Poisson model under two state characters –Derivation of expected number of changes on a single edge of a tree –Jukes-Cantor for four state model (DNA) –Estimating expected number of changes of two DNA sequences using maximum likelihood

Previously… Distance based phylogeny reconstruction methods –UPGMA --- not additive –Neighbor Joining --- additive –Both are fast --- polynomial time –Easy to implement

Previously Simulation –Method for simulating evolution of DNA sequences on a fixed tree –Comparing two different phylogenies for computing the error rate –Effect of accuracy on real methods as a function of sequence length, number of sequences, and other factors

Sequence Alignment Widely used in bioinformatics Proteins and genes are of different lengths due to error in sequencing and genetic variation across species Involves identifying evolutionary events: insertions, deletions, and substitutions Goal is to “align” sequences such that number of mutations is minimized

Sequencing Successes T7 bacteriophage completed in ,937 bp, 59 coded proteins Escherichia coli completed in ,639,221 bp, 4293 ORFs Sacchoromyces cerevisae completed in ,069,252 bp, 5800 genes

Sequencing Successes Caenorhabditis elegans completed in ,078,296 bp, 19,099 genes Drosophila melanogaster completed in ,117,226 bp, 13,601 genes Homo sapiens completed in ,201,762,515 bp, 31,780 genes

Genomes to Date 8 vertebrates (human, mouse, rat, fugu, zebrafish) 3 plants (arabadopsis, rice, poplar) 2 insects (fruit fly, mosquito) 2 nematodes (C. elegans, C. briggsae) 1 sea squirt 4 parasites (plasmodium, guillardia) 4 fungi (S. cerevisae, S. pombe) 200+ bacteria and archebacteria viruses

So what do we do with all this sequence data?

Comparative bioinformatics

DNA Sequence Evolution AAGACTT -3 mil yrs -2 mil yrs -1 mil yrs today AAGACTT T_GACTTAAGGCTT _GGGCTTTAGACCTTA_CACTT ACCTT (Cat) ACACTTC (Lion) TAGCCCTTA (Monkey) TAGGCCTT (Human) GGCTT (Mouse) T_GACTTAAGGCTT AAGACTT _GGGCTTTAGACCTTA_CACTT AAGGCTTT_GACTT AAGACTT TAGGCCTT (Human) TAGCCCTTA (Monkey) A_C_CTT (Cat) A_CACTTC (Lion) _G_GCTT (Mouse) _GGGCTTTAGACCTTA_CACTT AAGGCTTT_GACTT AAGACTT

Sequence alignments They tell us about Function or activity of a new gene/protein Structure or shape of a new protein Location or preferred location of a protein Stability of a gene or protein Origin of a gene or protein Origin or phylogeny of an organelle Origin or phylogeny of an organism And more…

Pairwise alignment How to align two sequences?

Pairwise alignment

Dynamic programming Define V(i,j) to be the optimal pairwise alignment score between S 1..i and T 1..j (|S|=m, |T|=n)

Dynamic programming Time and space complexity is O(mn) Define V(i,j) to be the optimal pairwise alignment score between S 1..i and T 1..j (|S|=m, |T|=n)

Tabular computation of scores

Traceback to get alignment

Local alignment Finding optimally aligned local regions

Local alignment

Database searching Suppose we have a set of 1,000,000 sequences You have a query sequence q and want to find the m closest ones in the database--- that means 1,000,000 pairwise alignments! How to speed up pairwise alignments?

FASTA FASTA was the first software for quick searching of a database Introduced the idea of searching for k-mers Can be done quickly by preprocessing database

FASTA: combine high scoring hits into diagonal runs

BLAST Key idea: search for k-mers (short matchig substrings) quickly by preprocessing the database.

BLAST This key idea can also be used for speeding up pairwise alignments when doing multiple sequence alignments

Biologically realistic scoring matrices PAM and BLOSUM are most popular PAM was developed by Margaret Dayhoff and co-workers in 1978 by examining 1572 mutations between 71 families of closely related proteins BLOSUM is more recent and computed from blocks of sequences with sufficient similarity

PAM We need to compute the probability transition matrix M which defines the probability of amino acid i converting to j Examine a set of closely related sequences which are easy to align---for PAM 1572 mutations between 71 families Compute probabilities of change and background probabilities by simple counting

PAM In this model the unit of evolution is the amount of evolution that will change 1 in 100 amino acids on the average The scoring matrix S ab is the ratio of M ab to p b

PAM M ij matrix (x10000)

Multiple sequence alignment “Two sequences whisper, multiple sequences shout out loud”---Arthur Lesk Computationally very hard---NP-hard

Formally…

Multiple sequence alignment Unaligned sequences GGCTT TAGGCCTT TAGCCCTTA ACACTTC ACTT Aligned sequences _G_ _ GCTT_ TAGGCCTT_ TAGCCCTTA A_ _CACTTC A_ _C_ CTT_ Conserved regions help us to identify functionality

Sum of pairs score

What is the sum of pairs score of this alignment?

Tree alignment score

Tree Alignment TAGGCCTT (Human) TAGCCCTTA (Monkey) ACCTT (Cat) ACACTTC (Lion) GGCTT (Mouse)

Tree Alignment TAGGCCTT_ (Human) TAGCCCTTA (Monkey) A__C_CTT_ (Cat) A__CACTTC (Lion) _G__GCTT_ (Mouse) TAGGCCTT_A__CACTT_ TGGGGCTT_ AGGGACTT_ Tree alignment score = 14

Tree Alignment---depends on tree TAGGCCTT_ (Human) TAGCCCTTA (Monkey) A__C_CTT_ (Cat) A__CACTTC (Lion) _G__GCTT_ (Mouse) TA_CCCTT_ TA_CCCTTA TA_CCCTT_ TA_CCCTTA Tree alignment score = 15 Switch monkey and cat

Profiles Before we see how to construct multiple alignments, how do we align two alignments? Idea: summarize an alignment using its profile and align the two profiles

Profile alignment

Iterative alignment (heuristic for sum-of-pairs) Pick a random sequence from input set S Do (n-1) pairwise alignments and align to closest one t in S Remove t from S and compute profile of alignment While sequences remaining in S –Do |S| pairwise alignments and align to closest one t –Remove t from S

Iterative alignment Once alignment is computed randomly divide it into two parts Compute profile of each sub-alignment and realign the profiles If sum-of-pairs of the new alignment is better than the previous then keep, otherwise continue with a different division until specified iteration limit

Progressive alignment Idea: perform profile alignments in the order dictated by a tree Given a guide-tree do a post-order search and align sequences in that order Widely used heuristic Can be used for solving tree alignment

Simultaneous alignment and phylogeny reconstruction Given unaligned sequences produce both alignment and phylogeny Known as the generalized tree alignment problem---MAX-SNP hard Iterative improvement heuristic: –Take starting tree –Modify it using say NNI, SPR, or TBR –Compute tree alignment score –If better then select tree otherwise continue until reached a local minimum

Median alignment Idea: iterate over the phylogeny and align every triplet of sequences---takes o(m 3 ) (in general for n sequences it takes O(2 n m n ) time Same profiles can be used as in progressive alignment Produces better tree alignment scores (as observed in experiments) Iteration continues for a specified limit

Popular alignment programs ClustalW: most popular, progressive alignment MUSCLE: fast and accurate, progressive and iterative combination T-COFFEE: slow but accurate, consistency based alignment (align sequences in multiple alignment to be close to the optimal pairwise alignment) PROBCONS: slow but highly accurate, probabilistic consistency progressive based scheme DIALIGN: very good for local alignments

MUSCLE

Profile sum-of-pairs score Log expectation score used by MUSCLE

Evaluation of multiple sequence alignments Compare to benchmark “true” alignments Use simulation Measure conservation of an alignment Measure accuracy of phylogenetic trees How well does it align motifs? More…

BAliBASE Most popular benchmark of alignments Alignments are based upon structure BAliBASE currently consists of 142 reference alignments, containing over 1000 sequences. Of the 200,000 residues in the database, 58% are defined within the core blocks. The remaining 42% are in ambiguous regions that cannot be reliably aligned. The alignments are divided into four hierarchical reference sets, reference 1 providing the basis for construction of the following sets. Each of the main sets may be further sub-divided into smaller groups, according to sequence length and percent similarity.

BAliBASE The sequences included in the database are selected from alignments in either the FSSP or HOMSTRAD structural databases, or from manually constructed structural alignments taken from the literature. When sufficient structures are not available, additional sequences are included from the HSSP database (Schneider et al., 1997). The VAST Web server (Madej, 1995) is used to confirm that the sequences in each alignment are structural neighbours and can be structurally superimposed. Functional sites are identified using the PDBsum database (Laskowski et al., 1997) and the alignments are manually verified and adjusted, in order to ensure that conserved residues are aligned as well as the secondary structure elements.FSSP HOMSTRADHSSP VAST PDBsum

BAliBASE Reference 1 contains alignments of (less than 6) equi- distant sequences, ie. the percent identity between two sequences is within a specified range. All the sequences are of similar length, with no large insertions or extensions. Reference 2 aligns up to three "orphan" sequences (less than 25% identical) from reference 1 with a family of at least 15 closely related sequences. Reference 3 consists of up to 4 sub-groups, with less than 25% residue identity between sequences from different groups. The alignments are constructed by adding homologous family members to the more distantly related sequences in reference 1. Reference 4 is divided into two sub-categories containing alignments of up to 20 sequences including N/C-terminal extensions (up to 400 residues), and insertions (up to 100 residues).

Comparison of alignments on BAliBASE

Parsimonious aligner (PAl) 1.Construct progressive alignment A 2.Construct MP tree T on A 3.Construct progressive alignment A’ on guide-tree T 4.Set A=A’ and go to 3 5.Output alignment and tree with best MP score

PAl Faster than iterative improvement Speed and accuracy both depend upon progressive alignment and MP heuristic In practice MUSCLE and TNT are used for constructing alignments and MP trees How does PAl compare against traditional methods? PAl not designed for aligning structural regions but focuses on evolutionary conserved regions Let’s look at performance under simulation

Evaluating alignments under simulation We first need a way to evolve sequences with insertions and deletions NOTE: evolutionary models we have encountered so far do not account for insertions and deletions Not known exactly how to model insertions and deletions

ROSE Evolve sequences under an i.i.d. Markov Model Root sequence: probabilities given by a probability vector (for proteins default is Dayhoff et. al. values) Substitutions –Edge length are integers –Probability matrix M is given as input (default is PAM1*) –For edge of length b probabilty of x  y is given by M b xy Insertion and deletions: –Insertions and deletions follow the same probabilistic model –For each edge probability to insert is i ins. –Length of insertion is given by discrete probability distribution (normally exponential) –For edge of length b this is repeated b times. Model tree can be specified as input

Evaluation of alignments Let’s simulate alignments and phylogenies and compare them under simulation!!

Parameters for simulation study Model trees: uniform random distribution and uniformly selected random edge lengths Model of evolution: PAM with insertions and deletions probabilities selected from a gamma distribution (see ROSE software package) Replicate settings: Settings of 50, 100, and 400 taxa, mean sequence lengths of 200 and 500 and avg branch lengths of 10, 25, and 50 were selected. For each setting 10 datasets were produced

Phylogeny accuracy

Alignment accuracy

Running time

Conclusions DIALIGN seems to perform best followed by PAl, MUSCLE, and PROBCONS DIALIGN, however, is slower than PAl Does this mean DIALIGN is the best alignment program?

Conclusions DIALIGN seems to perform best followed by PAl, MUSCLE, and PROBCONS DIALIGN, however, is slower than PAl Does this mean DIALIGN is the best alignment program? Not necessarily: experiments were performed under uniform random trees with uniform random edge lengths. Not clear if this emulates the real deal.

Conclusions

Sum-of-pairs vs MP score

Conclusions Optimizing MP scores under this simulation model leads to better phylogenies and alignments

Conclusions Optimizing MP scores under this simulation model leads to better phylogenies and alignments What other models can we try?

Conclusions Optimizing MP scores under this simulation model leads to better phylogenies and alignments What other models can we try? Real data phylogenies as model trees Birth-death model trees Other distributions for model trees… Branch lengths: similar issues… Evolutionary model parameters estimated from real data