Pairwise sequence alignments. Vassilios Ioannidis (From Volker Flegel )

Similar documents
Pairwise sequence alignments

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment

Biochemistry 324 Bioinformatics. Pairwise sequence alignment

Bioinformatics. Scoring Matrices. David Gilbert Bioinformatics Research Centre

CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I)

Sara C. Madeira. Universidade da Beira Interior. (Thanks to Ana Teresa Freitas, IST for useful resources on this subject)

3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT

Sequence Alignments. Dynamic programming approaches, scoring, and significance. Lucy Skrabanek ICB, WMC January 31, 2013

Sequence Alignment: A General Overview. COMP Fall 2010 Luay Nakhleh, Rice University

Practical considerations of working with sequencing data

Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment

Quantifying sequence similarity

Algorithms in Bioinformatics

CONCEPT OF SEQUENCE COMPARISON. Natapol Pornputtapong 18 January 2018

Pairwise sequence alignment

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

Large-Scale Genomic Surveys

Collected Works of Charles Dickens

CSE 549: Computational Biology. Substitution Matrices

Pairwise & Multiple sequence alignments

Sequence analysis and comparison

Sequence comparison: Score matrices. Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas

In-Depth Assessment of Local Sequence Alignment

Sequence comparison: Score matrices. Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas

Sequence analysis and Genomics

Substitution matrices

Sequence Alignment: Scoring Schemes. COMP 571 Luay Nakhleh, Rice University

Sequence comparison: Score matrices

Local Alignment Statistics

Module: Sequence Alignment Theory and Applications Session: Introduction to Searching and Sequence Alignment

Bioinformatics for Computer Scientists (Part 2 Sequence Alignment) Sepp Hochreiter

5. MULTIPLE SEQUENCE ALIGNMENT BIOINFORMATICS COURSE MTAT

Single alignment: Substitution Matrix. 16 march 2017

Introduction to sequence alignment. Local alignment the Smith-Waterman algorithm

Pairwise Alignment. Guan-Shieng Huang. Dept. of CSIE, NCNU. Pairwise Alignment p.1/55

Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM)

Similarity or Identity? When are molecules similar?

Pairwise Sequence Alignment

Bioinformatics for Biologists

Sequence Alignment (chapter 6)

Computational Biology

Sequence Analysis 17: lecture 5. Substitution matrices Multiple sequence alignment

SEQUENCE ALIGNMENT BACKGROUND: BIOINFORMATICS. Prokaryotes and Eukaryotes. DNA and RNA

Tools and Algorithms in Bioinformatics

Lecture 1, 31/10/2001: Introduction to sequence alignment. The Needleman-Wunsch algorithm for global sequence alignment: description and properties

Lecture 2, 5/12/2001: Local alignment the Smith-Waterman algorithm. Alignment scoring schemes and theory: substitution matrices and gap models

Scoring Matrices. Shifra Ben-Dor Irit Orr

Lecture 5,6 Local sequence alignment

Advanced topics in bioinformatics

First generation sequencing and pairwise alignment (High-tech, not high throughput) Analysis of Biological Sequences

BIO 285/CSCI 285/MATH 285 Bioinformatics Programming Lecture 8 Pairwise Sequence Alignment 2 And Python Function Instructor: Lei Qian Fisk University

Alignment & BLAST. By: Hadi Mozafari KUMS

Sequence Alignment Techniques and Their Uses

Week 10: Homology Modelling (II) - HHpred

... and searches for related sequences probably make up the vast bulk of bioinformatics activities.

C E N T R. Introduction to bioinformatics 2007 E B I O I N F O R M A T I C S V U F O R I N T. Lecture 5 G R A T I V. Pair-wise Sequence Alignment

20 Grundlagen der Bioinformatik, SS 08, D. Huson, May 27, Global and local alignment of two sequences using dynamic programming

Motivating the need for optimal sequence alignments...

8 Grundlagen der Bioinformatik, SS 09, D. Huson, April 28, 2009

8 Grundlagen der Bioinformatik, SoSe 11, D. Huson, April 18, 2011

Local Alignment: Smith-Waterman algorithm

Moreover, the circular logic

InDel 3-5. InDel 8-9. InDel 3-5. InDel 8-9. InDel InDel 8-9

Global alignments - review

Introduction to Comparative Protein Modeling. Chapter 4 Part I

Lecture 4: Evolutionary models and substitution matrices (PAM and BLOSUM).

Pairwise alignment. 2.1 Introduction GSAQVKGHGKKVADALTNAVAHVDDMPNALSALSD----LHAHKL

Homology Modeling. Roberto Lins EPFL - summer semester 2005

An Introduction to Sequence Similarity ( Homology ) Searching

Homology Modeling (Comparative Structure Modeling) GBCB 5874: Problem Solving in GBCB

Protein Bioinformatics. Rickard Sandberg Dept. of Cell and Molecular Biology Karolinska Institutet sandberg.cmb.ki.

Introduction to Bioinformatics

Bioinformatics and BLAST

Sequence Comparison. mouse human

Background: comparative genomics. Sequence similarity. Homologs. Similarity vs homology (2) Similarity vs homology. Sequence Alignment (chapter 6)

Tools and Algorithms in Bioinformatics

Copyright 2000 N. AYDIN. All rights reserved. 1

Basic Local Alignment Search Tool

Sequence Analysis and Databases 2: Sequences and Multiple Alignments

An Introduction to Bioinformatics Algorithms Hidden Markov Models

Lecture Notes: Markov chains

Bioinformatics. Molecular Biophysics & Biochemistry 447b3 / 747b3. Class 3, 1/19/98. Mark Gerstein. Yale University

BLAST: Target frequencies and information content Dannie Durand

Introduction to Computation & Pairwise Alignment

Overview Multiple Sequence Alignment

Bio nformatics. Lecture 3. Saad Mneimneh

Multiple Sequence Alignment, Gunnar Klau, December 9, 2005, 17:

Similarity searching summary (2)

Hidden Markov Models

Sequence Analysis '17 -- lecture 7

Protein Sequence Alignment and Database Scanning

Practical Bioinformatics

Administration. ndrew Torda April /04/2008 [ 1 ]

Christian Sigrist. November 14 Protein Bioinformatics: Sequence-Structure-Function 2018 Basel

1.5 Sequence alignment

BINF 730. DNA Sequence Alignment Why?

Massachusetts Institute of Technology Computational Evolutionary Biology, Fall, 2005 Notes for November 7: Molecular evolution

Molecular Modeling Lecture 7. Homology modeling insertions/deletions manual realignment

Statistical Distributions of Optimal Global Alignment Scores of Random Protein Sequences

Analysis and Design of Algorithms Dynamic Programming

Transcription:

Pairwise sequence alignments Vassilios Ioannidis (From Volker Flegel )

Outline Introduction Definitions Biological context of pairwise alignments Computing of pairwise alignments Some programs

Importance of pairwise alignments Sequence analysis tools depending on pairwise comparison Multiple alignments Profile and HMM making (used to search for protein families and domains) 3D protein structure prediction Phylogenetic analysis Construction of certain substitution matrices Similarity searches in a database

Goal Sequence comparison through pairwise alignments Goal of pairwise comparison is to find conserved regions (if any) between two sequences Extrapolate information about our sequence using the known characteristics of the other sequence THIO_EMENI GFVVVDCFATWCGPCKAIAPTVEKFAQTY G ++VD +A WCGPCK IAP +++ A Y??? GAILVDFWAEWCGPCKMIAPILDEIADEY Extrapolate??? THIO_EMENI SwissProt

Do alignments make sense? Evolution of sequences Sequences evolve through mutation and selection Selective pressure is different for each residue position in a protein (i.e. conservation of active site, structure, charge, etc.) Modular nature of proteins Nature keeps re-using domains Alignments try to tell the evolutionnary story of the proteins Relationships Same Sequence Same Origin Same Function Same 3D Fold

Example: An alignment - textual view Two similar regions of the Drosophila melanogaster Slit and Notch proteins 970 970 980 980 990 990 1000 1000 1010 1010 1020 1020 SLIT_DROME SLIT_DROME FSCQCAPGYTGARCETNIDDCLGEIKCQNNATCIDGVESYKCECQPGFSGEFCDTKIQFC FSCQCAPGYTGARCETNIDDCLGEIKCQNNATCIDGVESYKCECQPGFSGEFCDTKIQFC..:.:..:.: :. :. :.: :.:...:.:...:.:.... : : :.. :.. : : ::.. ::.... :.: :.: ::..:. ::..:. :. :. :. :. : : NOTC_DROME NOTC_DROME YKCECPRGFYDAHCLSDVDECASN-PCVNEGRCEDGINEFICHCPPGYTGKRCELDIDEC YKCECPRGFYDAHCLSDVDECASN-PCVNEGRCEDGINEFICHCPPGYTGKRCELDIDEC 740 740 750 750 760 760 770 770 780 780 790 790 :.

Example: An alignment - graphical view Comparing the tissue-type and urokinase type plasminogen activators. Displayed using a diagonal plot or Dotplot. Tissue-Type plasminogen Activator Urokinase-Type plasminogen Activator URL: www.isrec.isb-sib.ch/java/dotlet/dotlet.html

Some definitions Identity Proportion of pairs of identical residues between two aligned sequences. Generally expressed as a percentage. This value strongly depends on how the two sequences are aligned. Similarity Proportion of pairs of similar residues between two aligned sequences. If two residues are similar is determined by a substitution matrix. This value also depends strongly on how the two sequences are aligned, as well as on the substitution matrix used. Homology Two sequences are homologous if and only if they have a common ancestor. There is no such thing as a level of homology! (It's either yes or no) Homologous sequences do not necessarily serve the same function...... Nor are they always highly similar: structure may be conserved while sequence is not.

Definition example The set of all globins and a test to identify them Consider: a set S (say, globins: G) a test t that tries to detect members of S (for example, through a pairwise comparison with another globin). Globins G G G True positives True negatives False positives False negatives G X Matches G G G X G X X X

More definitions Consider a set S (say, globins) and a test t that tries to detect members of S (for example, through a pairwise comparison with another globin). True positive A protein is a true positive if it belongs to S and is detected by t. True negative A protein is a true negative if it does not belong to S and is not detected by t. False positive A protein is a false positive if it does not belong to S and is (incorrectly) detected by t. False negative A protein is a false negative if it belongs to S and is not detected by t (but should be).

Even more definitions Sensitivity Ability of a method to detect positives, irrespective of how many false positives are reported. Selectivity Ability of a method to reject negatives, irrespective of how many false negatives are rejected. Greater sensitivity Less selectivity True positives True negatives False positives Less sensitivity Greater selectivity False negatives

Pairwise sequence alignment Concept of a sequence alignment Pairwise Alignment: Explicit mapping between the residues of 2 sequences deletion Seq A GARFIELDTHELASTFA-TCAT Seq B GARFIELDTHEVERYFASTCAT errors / mismatches insertion Tolerant to errors (mismatches, insertion / deletions or indels) Evaluation of the alignment in a biological concept (significance)

Pairwise sequence alignement Number of alignments There are many ways to align two sequences Consider the sequence fragments below: a simple alignment shows some conserved portions but also: CGATGCAGACGTCA CGATGCAAGACGTCA CGATGCAGACGTCA CGATGCAAGACGTCA Number of possible alignments for 2 sequences of length 1000 residues: more than 10 600 gapped alignments (Avogadro 10 24, estimated number of atoms in the universe 10 80 )

Alignement evaluation What is a good alignment? We need a way to evaluate the biological meaning of a given alignment Intuitively we "know" that the following alignment: is better than: CGAGGCACAACGTCA CGATGCAAGACGTCA ATTGGACAGCAATCAGG ACGATGCAAGACGTCAG We can express this notion more rigorously, by using a scoring system

Scoring system Simple alignment scores A simple way (but not the best) to score an alignment is to count 1 for each match and 0 for each mismatch. Score: 12 Score: 5 CGAGGCACAACGTCA CGATGCAAGACGTCA ATTGGACAGCAATCAGG ACGATGCAAGACGTCAG

Introducing biological information Importance of the scoring system discrimination of significant biological alignments Based on physico-chemical properties of amino-acids Hydrophobicity, acid / base, sterical properties,... Scoring system scales are arbitrary Based on biological sequence information Substitutions observed in structural or evolutionary alignments of well studied protein families Scoring systems have a probabilistic foundation Substitution matrices In proteins some mismatches are more acceptable than others Substitution matrices give a score for each substitution of one amino-acid by another

Substitution matrices (log-odds matrices) Example matrix (Leu, Ile): 2 (Leu, Cys): -6... For a set of well known proteins: Align the sequences Count the mutations at each position For each substitution set the score to the log-odd ratio log observed expected by chance Positive score: the amino acids are similar, mutations from one into the other occur more often then expected by chance during evolution Negative score: the amino acids are dissimilar, the mutation from one into the other occurs less often then expected by chance during evolution PAM250 From: A. D. Baxevanis, "Bioinformatics"

Matrix choice Different kind of matrices PAM series (Dayhoff M., 1968, 1972, 1978) Percent Accepted Mutation. A unit introduced by Dayhoff et al. to quantify the amount of evolutionary change in a protein sequence. 1.0 PAM unit, is the amount of evolution which will change, on average, 1% of amino acids in a protein sequence. A PAM(x) substitution matrix is a look-up table in which scores for each amino acid substitution have been calculated based on the frequency of that substitution in closely related proteins that have experienced a certain amount (x) of evolutionary divergence. Based on 1572 protein sequences from 71 families Old standard matrix: PAM250

Matrix choice Different kind of matrices BLOSUM series (Henikoff S. & Henikoff JG., PNAS, 1992) Blocks Substitution Matrix. A substitution matrix in which scores for each position are derived from observations of the frequencies of substitutions in blocks of local alignments in related proteins. Each matrix is tailored to a particular evolutionary distance. In the BLOSUM62 matrix, for example, the alignment from which scores were derived was created using sequences sharing no more than 62% identity. Sequences more identical than 62% are represented by a single sequence in the alignment so as to avoid over-weighting closely related family members. Based on alignments in the BLOCKS database Standard matrix:blosum62

Matrix choice Limitations Substitution matrices do not take into account long range interactions between residues. They assume that identical residues are equal ( whereas in reallife a residue at the active site has other evolutionary constraints than the same residue outside of the active site) They assume evolution rate to be constant.

Alignment score Amino acid substitution matrices Example: PAM250 Most used: Blosum62 Raw score of an alignment TPEA _ _ APGA Score = 1 + 6 + 0 + 2 = 9

Gaps Insertions or deletions Proteins often contain regions where residues have been inserted or deleted during evolution There are constraints on where these insertions and deletions can happen (between structural or functional elements like: alpha helices, active site, etc.) Gaps in alignments GCATGCATGCAACTGCAT GCATGCATGGGCAACTGCAT can be improved by inserting a gap GCATGCATG--CAACTGCAT GCATGCATGGGCAACTGCAT

Gap opening and extension penalties Costs of gaps in alignments We want to simulate as closely as possible the evolutionary mechanisms involved in gap occurence. Example Two alignments with identical number of gaps but very different gap distribution. We may prefer one large gap to several small ones (e.g. poorly conserved loops between well-conserved helices) CGATGCAGCAGCAGCATCG CGATGC------AGCATCG gap opening Gap opening penalty gap extension CGATGCAGCAGCAGCATCG CG-TG-AGCA-CA--AT-G Counted each time a gap is opened in an alignment (some programs include the first extension into this penalty) Gap extension penalty Counted for each extension of a gap in an alignment

Gap opening and extension penalties Example With a match score of 1 and a mismatch score of 0 With an opening penalty of 10 and extension penalty of 1, we have the following score: CGATGCAGCAGCAGCATCG CGATGC------AGCATCG gap opening gap extension CGATGCAGCAGCAGCATCG CG-TG-AGCA-CA--AT-G 13 x 1-10 - 6 x 1 = -3 13 x 1-5 x 10-6 x 1 = -43

Statistical evaluation of results Alignments are evaluated according to their score Raw score It's the sum of the amino acid substitution scores and gap penalties (gap opening and gap extension) Depends on the scoring system (substitution matrix, etc.) Different alignments should not be compared based only on the raw score It is possible that a "bad" long alignment gets a better raw score than a very good short alignment. We need a normalised score to compare alignments! We need to evaluate the biological meaning of the score (p-value, e-value). Normalised score Is independent of the scoring system Allows the comparison of different alignments Units: expressed in bits

Statistical evaluation of results Distribution of alignment scores - Extreme Value Distribution Random sequences and alignment scores Sequence alignment scores between random sequences are distributed following an extreme value distribution (EVD). Random sequences Pairwise alignments Score distribution Ala Val... Trp low score low score low score low score high score high score due to "luck" obs score...

Statistical evaluation of results Distribution of alignment scores - Extreme Value Distribution High scoring random alignments have a low probability. The EVD allows us to compute the probability with which our biological alignment could be due to randomness (to chance). Caveat: finding the threshold of significant alignments. Threshold significant alignment score x: our alignment has a great probability of being the result of random sequence similarity score y: our alignment is very improbable to obtain with random sequences score

Statistical evaluation of results 100% 0% Statistics derived from the scores p-value Probability that an alignment with this score occurs by chance in a database of this size The closer the p-value is towards 0, the better the alignment N 0 e-value Number of matches with this score one can expect to find by chance in a database of this size The closer the e-value is towards 0, the better the alignment Relationship between e-value and p-value: In a database containing N sequences e = p x N

Diagonal plots or Dotplot Concept of a Dotplot Produces a graphical representation of similarity regions. The horizontal and vertical dimensions correspond to the compared sequences. A region of similarity stands out as a diagonal. Tissue-Type plasminogen Activator Urokinase-Type plasminogen Activator

Dotplot construction Simple example A dot is placed at each position where two residues match. The colour of the dot can be chosen according to the substitution value in the substitution matrix T Note THEFA-TCAT THEFASTCAT This method produces dotplots with too much noise to be useful The noise can be reduced by calculating a score using a window of residues The score is compared to a threshold or stringency

Dotplot construction Window example Each window of the first sequence is aligned (without gaps) to each window of the 2nd sequence A colour is set into a rectangular array according to the score of the aligned windows HEF THE CAT THE HEF Score: 23-5 -4

Dotplot limitations It's a visual aid. The human eye can rapidly identify similar regions in sequences. It's a good way to explore sequence organisation. It does not provide an alignment. Tissue-Type plasminogen Activator Urokinase-Type plasminogen Activator

Creating an alignment Relationship between alignment and dotplot An alignment can be seen as a path through the dotplot diagramm. Seq Seq BB B Seq Seq AA A A-CA-CA ACA--CA A-CA-CA ACA--CA ACCAAC- A-CCAAC ACCAAC- A-CCAAC

Finding an alignment Alignment algorithms An alignment program tries to find the best alignment between two sequences given the scoring system. This can be seen as trying to find a path through the dotplot diagram including all (or the most visible) diagonals. Alignement types Global Local Alignment between the complete sequence A and the complete sequence B Alignment between a sub-sequence of A an a subsequence of B Computer implementation (Algorithms) Dynamic programing Global Needleman-Wunsch Local Smith-Waterman

Global alignment (Needleman-Wunsch) Example Global alignments are very sensitive to gap penalties Global alignments do not take into account the modular nature of proteins Tissue-Type plasminogen Activator Urokinase-Type plasminogen Activator Global alignment:

Local alignment (Smith-Waterman) Example Local alignments are more sensitive to the modular nature of proteins They can be used to search databases Tissue-Type plasminogen Activator Urokinase-Type plasminogen Activator Local alignments:

Optimal alignment extension How to extend optimaly an optimal alignment An optimal alignment up to positions i and j can be extended in 3 ways. Keeping the best of the 3 guarantees an extended optimal alignment. Seq A a 1 a 2 a 3... a i-1 a i Seq B b 1 b 2 b 3... b j-1 b j Seq A a 1 a 2 a 3... a i-1 a i a i+1 Seq B b 1 b 2 b 3... b j-1 b j b j+1 Score = Score ij + Subst ij Seq A Seq B a 1 a 2 a 3... a i-1 a i b 1 b 2 b 3... b j-1 b j a i+1 - Score = Score ij - gap Seq A a 1 a 2 a 3... a i-1 a i - Seq B b 1 b 2 b 3... b j-1 b j b j+1 Score = Score ij - gap We have the optimal alignment extended from i and j by one residue.

Exact algorithms Simple example (Needleman-Wunsch) Scoring system: Match score: 2 Mismatch score: -1 Gap penalty: -2 F(i,j): score at position i, j s(x GATTA00 0-2-4-6-8-10 G -220-2-4-6 20-4 A -40420-2 i,y j ): match or mismatch score (or substitution matrix TA -8 value) -6-22312 T -10 for C -12 residues T -8-40453 x T -10-6-2264 C -12-8-4045 i and y j d: gap penalty (positive value) 2 + 2 0-2 F (i-1,j- 1) s (xi,yj) F (i- 1,j) -d F (i,j- 1) -d F (i,j) Note 0-2 GA-TTA GAATTC We have to keep track of the origin of the score for each element in the matrix. This allows to build the alignment by traceback when the matrix has been completely filled out. Computation time is proportional to the size of sequences (n x m).

Algorithms for pairwise alignments Web resources LALIGN - pairwise sequence alignment: www.ch.embnet.org/software/lalign_form.html PRSS - alignment score evaluation: www.ch.embnet.org/software/prss_form.html Concluding remarks Substitution matrices and gap penalties introduce biological information into the alignment algorithms. It is not because two sequences can be aligned that they share a common biological history. The relevance of the alignment must be assessed with a statistical score. There are many ways to align two sequences. Do not blindly trust your alignment to be the only truth. Especially gapped regions may be quite variable. Sequences sharing less than 20% similarity are difficult to align: You enter the Twilight Zone (Doolittle, 1986) Alignments may appear plausible to the eye but are no longer statistically significant. Other methods are needed to explore these sequences (i.e: profiles)