Multiple Alignment Anders Gorm Pedersen / Henrik Nielsen

Slides:



Advertisements
Similar presentations
Multiple Alignment Anders Gorm Pedersen Molecular Evolution Group
Advertisements

Gapped Blast and PSI BLAST Basic Local Alignment Search Tool ~Sean Boyle Basic Local Alignment Search Tool ~Sean Boyle.
COFFEE: an objective function for multiple sequence alignments
CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS Multiple Alignment Anders Gorm Pedersen Molecular Evolution Group Center for Biological Sequence Analysis
1 “INTRODUCTION TO BIOINFORMATICS” “SPRING 2005” “Dr. N AYDIN” Lecture 4 Multiple Sequence Alignment Doç. Dr. Nizamettin AYDIN
CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS Multiple Alignment Anders Gorm Pedersen Molecular Evolution Group Center for Biological Sequence Analysis
Heuristic alignment algorithms and cost matrices
Sequence alignment SEQ1: VLSPADKTNVKAAWGKVGAHAGEYGAEALERMFLSFPTTKTYFPHFDLSHGSAQVKGHGKK VADALTNAVAHVDDPNALSALSDLHAHKLRVDPVNFKLLSHCLLVTLAAHLPAEFTPAVHA SLDKFLASVSTVLTSKYR.
Biological Sequence Analysis Chapter 3. Protein Families Organism 1 Organism 2 Enzym e 1 Enzym e 2 Closely relatedSame Function MSEKKQPVDLGLLEEDDEFEEFPAEDWAGLDEDEDAHVWEDNWDDDNVEDDFSNQLRAELEKHGYKMETS.
Multiple Sequence Alignment Algorithms in Computational Biology Spring 2006 Most of the slides were created by Dan Geiger and Ydo Wexler and edited by.
Multiple alignment June 29, 2007 Learning objectives- Review sequence alignment answer and answer questions you may have. Understand how the E value may.
Biological Sequence Analysis Chapter 3 Claus Lundegaard.
Expected accuracy sequence alignment
What you should know by now Concepts: Pairwise alignment Global, semi-global and local alignment Dynamic programming Sequence similarity (Sum-of-Pairs)
Lecture 9 Hidden Markov Models BioE 480 Sept 21, 2004.
Sequence similarity.
Pairwise Alignment Global & local alignment Anders Gorm Pedersen Molecular Evolution Group Center for Biological Sequence Analysis.
Similar Sequence Similar Function Charles Yan Spring 2006.
Bioinformatics Unit 1: Data Bases and Alignments Lecture 3: “Homology” Searches and Sequence Alignments (cont.) The Mechanics of Alignments.
Sequence Alignments Revisited
Multiple Sequence Alignments
CECS Introduction to Bioinformatics University of Louisville Spring 2003 Dr. Eric Rouchka Lecture 3: Multiple Sequence Alignment Eric C. Rouchka,
CISC667, F05, Lec8, Liao CISC 667 Intro to Bioinformatics (Fall 2005) Multiple Sequence Alignment Scoring Dynamic Programming algorithms Heuristic algorithms.
Introduction to Bioinformatics From Pairwise to Multiple Alignment.
Sequence comparison: Score matrices Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas
Chapter 5 Multiple Sequence Alignment.
Multiple Sequence Alignment CSC391/691 Bioinformatics Spring 2004 Fetrow/Burg/Miller (Slides by J. Burg)
Multiple sequence alignment
Pair-wise Sequence Alignment What happened to the sequences of similar genes? random mutation deletion, insertion Seq. 1: 515 EVIRMQDNNPFSFQSDVYSYG EVI.
Multiple Sequence Alignment May 12, 2009 Announcements Quiz #2 return (average 30) Hand in homework #7 Learning objectives-Understand ClustalW Homework#8-Due.
Protein Sequence Alignment and Database Searching.
Evolution and Scoring Rules Example Score = 5 x (# matches) + (-4) x (# mismatches) + + (-7) x (total length of all gaps) Example Score = 5 x (# matches)
ZORRO : A masking program for incorporating Alignment Accuracy in Phylogenetic Inference Sourav Chatterji Martin Wu.
Pairwise Sequence Alignment. The most important class of bioinformatics tools – pairwise alignment of DNA and protein seqs. alignment 1alignment 2 Seq.
Sequence Analysis CSC 487/687 Introduction to computing for Bioinformatics.
Construction of Substitution Matrices
Using Traveling Salesman Problem Algorithms to Determine Multiple Sequence Alignment Orders Weiwei Zhong.
Bioinformatics Multiple Alignment. Overview Introduction Multiple Alignments Global multiple alignment –Introduction –Scoring –Algorithms.
Multiple alignment: Feng- Doolittle algorithm. Why multiple alignments? Alignment of more than two sequences Usually gives better information about conserved.
Sequence Alignment Csc 487/687 Computing for bioinformatics.
Multiple Sequence Alignment by Iterative Tree-Neighbor Alignments Susan Bibeault June 9, 2000.
Sequence Alignment Only things that are homologous should be compared in a phylogenetic analysis Homologous – sharing a common ancestor This is true for.
Chapter 3 Computational Molecular Biology Michael Smith
Multiple Alignment and Phylogenetic Trees Csc 487/687 Computing for Bioinformatics.
BLAST: Basic Local Alignment Search Tool Altschul et al. J. Mol Bio CS 466 Saurabh Sinha.
COT 6930 HPC and Bioinformatics Multiple Sequence Alignment Xingquan Zhu Dept. of Computer Science and Engineering.
Pairwise sequence alignment Lecture 02. Overview  Sequence comparison lies at the heart of bioinformatics analysis.  It is the first step towards structural.
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
Step 3: Tools Database Searching
©CMBI 2005 Database Searching BLAST Database Searching Sequence Alignment Scoring Matrices Significance of an alignment BLAST, algorithm BLAST, parameters.
1 Multiple Sequence Alignment(MSA). 2 Multiple Alignment Number of sequences >2 Global alignment Seek an alignment that maximizes score.
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.
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.
Techniques for Protein Sequence Alignment and Database Searching G P S Raghava Scientist & Head Bioinformatics Centre, Institute of Microbial Technology,
BIOINFORMATICS Ayesha M. Khan Spring Lec-6.
Substitution Matrices and Alignment Statistics BMI/CS 776 Mark Craven February 2002.
Pairwise Sequence Alignment and Database Searching
Learning to Align: a Statistical Approach
Sequence similarity, BLAST alignments & multiple sequence alignments
Multiple sequence alignment (msa)
The ideal approach is simultaneous alignment and tree estimation.
Center for Biological Sequence Analysis
In Bioinformatics use a computational method - Dynamic Programming.
Pairwise Alignment Global & local alignment
Sequence Alignment Algorithms Morten Nielsen BioSys, DTU
MULTIPLE SEQUENCE ALIGNMENT
Sequence alignment, E-value & Extreme value distribution
Presentation transcript:

Multiple Alignment Anders Gorm Pedersen / Henrik Nielsen Molecular Evolution Group Center for Biological Sequence Analysis gorm@cbs.dtu.dk / hnielsen@cbs.dtu.dk CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Outline Refresher: pairwise alignments Multiple alignments: what use are they? Multiple alignment by dynamic programming Why it is not done Multiple alignment by progressive cluster and profile alignment How it is done Multiple alignment programs, features and comparisons Take-home messages CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Refresher: pairwise alignments 43.2% identity; Global alignment score: 374 10 20 30 40 50 alpha V-LSPADKTNVKAAWGKVGAHAGEYGAEALERMFLSFPTTKTYFPHF-DLS-----HGSA : :.: .:. : : :::: .. : :.::: :... .: :. .: : ::: :. beta VHLTPEEKSAVTALWGKV--NVDEVGGEALGRLLVVYPWTQRFFESFGDLSTPDAVMGNP 10 20 30 40 50 60 70 80 90 100 110 alpha QVKGHGKKVADALTNAVAHVDDMPNALSALSDLHAHKLRVDPVNFKLLSHCLLVTLAAHL .::.::::: :.....::.:.. .....::.:: ::.::: ::.::.. :. .:: :. beta KVKAHGKKVLGAFSDGLAHLDNLKGTFATLSELHCDKLHVDPENFRLLGNVLVCVLAHHF 120 130 140 alpha PAEFTPAVHASLDKFLASVSTVLTSKYR :::: :.:. .: .:.:...:. ::. beta GKEFTPPVQAAYQKVVAGVANALAHKYH CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Refresher: pairwise alignments Alignment score is calculated from substitution matrix Identities on diagonal have high scores Similar amino acids have high scores Dissimilar amino acids have low (negative) scores Gaps penalized by gap-opening + gap elongation A 5 R -2 7 N -1 -1 7 D -2 -2 2 8 C -1 -4 -2 -4 13 Q -1 1 0 0 -3 7 E -1 0 0 2 -3 2 6 G 0 -3 0 -1 -3 -2 -3 8 . A R N D C Q E G ... CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS K L A A S V I L S D A L K L A A - - - - S D A L -10 + 3 x (-1)=-13

Refresher: pairwise alignments The number of possible pairwise alignments increases explosively with the length of the sequences: Two protein sequences of length 100 amino acids can be aligned in approximately 1060 different ways 1060 bottles of beer would fill up our entire galaxy CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Refresher: pairwise alignments Solution: dynamic programming Essentially: the best path through any grid point in the alignment matrix must originate from one of three previous points Far fewer computations Optimal alignment guaranteed to be found T C G C A T C A CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS x

Refresher: pairwise alignments Most used substitution matrices are themselves derived empirically from simple multiple alignments A/A 2.15% A/C 0.03% A/D 0.07% ... CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS Multiple alignment Calculate substitution frequencies Convert to scores Freq(A/C),observed Freq(A/C),expected Score(A/C) = log

Refresher: pairwise alignments “Optimal alignment” means “having the highest possible score, given substitution matrix and set of gap penalties”. This is NOT necessarily the biologically most meaningful alignment. Specifically, the underlying assumptions are often wrong: substitutions are not equally frequent at all positions, affine gap penalties do not model insertion/deletion well, etc. Pairwise alignment programs always produce an alignment - even when it does not make sense to align sequences. CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Database searching Using pairwise alignments to search databases for similar sequences CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS Query sequence Database

Multiple alignment CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Multiple alignments: what use are they? Starting point for studies of molecular evolution CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Multiple alignments: what use are they? Characterization of protein families: Identification of conserved (functionally important) sequence regions Construction of profiles for further database searching Prediction of structural features (disulfide bonds, amphipathic alpha-helices, surface loops, etc.) CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Scoring a multiple alignment: the “sum of pairs” score AA: 4, AS: 1, AT:0 AS: 1, AT: 0 ST: 1 SP-score: 4+1+0+1+0+1 = 7 CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS One column from alignment Weighted sum of pairs: each SP-score is multiplied by a weight reflecting the evolutionary distance (avoids undue influence on score by sets of very similar sequences) => In theory, it is possible to define an alignment score for multiple alignments (there are several alternative scoring systems)

Multiple alignment: dynamic programming is only feasible for very small data sets In theory, optimal multiple alignment can be found by dynamic programming using a matrix with more dimensions (one dimension per sequence) BUT even with dynamic programming finding the optimal alignment very quickly becomes impossible due to the astronomical number of computations Full dynamic programming only possible for up to about 4-5 protein sequences of average length Even with heuristics, not feasible for more than 7-8 protein sequences Never used in practice CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS Dynamic programming matrix for 3 sequences For 3 sequences, optimal path must come from one of 7 previous points

Multiple alignment: an approximate solution Progressive alignment: Perform all pairwise alignments; keep track of sequence similarities between all pairs of sequences (construct “distance matrix”) Align the most similar pair of sequences Progressively add sequences to the (constantly growing) multiple alignment in order of decreasing similarity. CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Progressive alignment: details Perform all pairwise alignments, note pairwise distances (construct “distance matrix”) 2) Construct pseudo-phylogenetic tree from pairwise distances S1 S2 S3 S4 S1 S2 3 S3 1 3 S4 3 2 3 S1 S2 S3 CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS 6 pairwise alignments S4 S1 S2 S3 S4 S1 S2 3 S3 1 3 S4 3 2 3 S1 S3 S4 S2 “Guide tree”

Progressive alignment: details Use tree as guide for multiple alignment: Align most similar pair of sequences using dynamic programming Align next most similar pair Align alignments using dynamic programming - preserve gaps S1 S3 S1 S3 S4 S2 CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS S2 S4 S1 S3 S2 S4 New gap to optimize alignment of (S2,S4) with (S1,S3)

Scoring profile alignments The naïve way: Compare each residue in one profile to all residues in second profile. Score is average of all comparisons. ...A... ...S... CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS AS: 1, AT:0 SS: 4, ST:1 Score: 1+0+4+1 = 1.5 + ...S... ...T... 4 One column from alignment

Scoring profile alignments In practice: Use each profile as an estimate of a position-specific scoring matrix. This is combined with the original scoring matrix. More details to follow in session about “weight matrices”. Profile-to-sequence or profile-to-profile alignments are potentially more biologically relevant than sequence-to-sequence alignments, because position-specific patterns of substitution can be taken into account. CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Additional heuristics for quality Sequence weighting (most programs): scores from similar groups of sequences are down-weighted Variable substitution matrices (ClustalW/X): during alignment ClustalW/X uses different substitution matrices depending on how similar the sequences/profiles are Context-dependent gap penalties (ClustalW/X) e.g. higher gap penalties in hydrophobic stretches Reiterate alignment (MUSCLE, MAFFT) calculate a new guide tree based on first multiple alignment, and use that for the next round of alignment Consistency (T-Coffee, ProbCons) use all the pairwise alignments to compute the match/mismatch scores in the multiple alignment (slow) CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Additional heuristics for speed Use fast comparison instead of full dynamic programming when calculating the guide tree (ClustalW/X, MUSCLE, MAFFT, …) Reduce dynamic programming time in profile alignments by identifying regions of high similarity with a Fast Fourier Transform (MAFFT) Build an approximate guide tree without making all pairwise comparisons (ClustalΩ) CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Global methods (e.g., ClustalX) get into trouble when data is not globally related!!! CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Global methods (e.g., ClustalX) get into trouble when data is not globally related!!! CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS ClustalX What you want

Global methods (e.g., ClustalX) get into trouble when data is not globally related!!! CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS ClustalX What you want What you might get Possible solutions: Cut out conserved regions of interest and THEN align them Use method that deals with local similarity (e.g., Dialign)

Other multiple alignment programs pileup multalign multal saga hmmt MUSCLE ProbCons DIALIGN SBpima MLpima T-Coffee mafft poa prank ... CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Quantifying the Performance of Protein Sequence Multiple Alignment Programs Compare to alignment that is known (or strongly believed) to be correct Quantify by counting e.g. fraction of correctly paired residues Option 1: Compare performance to benchmark data sets for which 3D structures and structural alignments are available (BALiBASE, PREfab, SABmark, SMART). Advantage: real, biological data with real characteristics Problem: we only have good benchmark data for core regions, no good knowledge of how gappy regions really look Option 2: Construct synthetic alignments by letting a computer simulate evolution of a sequence along a phylogenetic tree Advantage: we know the real alignment including where the gaps are Problem: Simulated data may miss important aspects of real biological data CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Performance on BALiBASE benchmark Dialign T-Coffee CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS ClustalW Poa

Performance on simulated data, few gaps CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Performance on simulated data, many gaps CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

So which method should I choose? Performance depends on way of measuring and on nature of data set No single method performs best under all conditions Slower is not necessarily better Clustal Ω looks quite good with very large alignments To be on the safe side, you ought to check that results are robust to alignment uncertainty (try a number of methods, check conclusions on each alignment). T-Coffee can run several methods for you and report degree of agreement CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Special purpose alignment program CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS RevTrans: alignment of coding DNA based on information at protein level Codon-codon boundaries maintained

Special purpose alignment programs CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS MaxAlign: remove subset of sequences to get fewer gapped columns Detect non-homologous or mis- aligned sequences

Future perspectives Alignment inferred along with rest of analysis (e.g. phylogeny) Bayesian techniques, conclusions based on probability distribution over possible alignments. CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS

Take-home messages Unlike pairwise alignment, the multiple alignment problem cannot be solved exactly Nevertheless, multiple alignments are often more biologically correct than pairwise alignments No single program performs best under all conditions, but MAFFT seems like a good compromise in most situations Although ClustalW/X is the best known program, it is not among the best or fastest. CENTER FOR BIOLOGICAL SEQUENCE ANALYSIS