Alignment methods and database searching April 14, 2005 Quiz#1 today Learning objectives- Finish Dotter Program analysis. Understand how to use the program.

Slides:



Advertisements
Similar presentations
Scoring Matrices.
Advertisements

Global Sequence Alignment by Dynamic Programming.
Blast to Psi-Blast Blast makes use of Scoring Matrix derived from large number of proteins. What if you want to find homologs based upon a specific gene.
Alignment methods Introduction to global and local sequence alignment methods Global : Needleman-Wunch Local : Smith-Waterman Database Search BLAST FASTA.
Measuring the degree of similarity: PAM and blosum Matrix
DNA sequences alignment measurement
Lecture 8 Alignment of pairs of sequence Local and global alignment
C E N T R F O R I N T E G R A T I V E B I O I N F O R M A T I C S V U E Alignments 1 Sequence Analysis.
Heuristic alignment algorithms and cost matrices
Introduction to Bioinformatics Algorithms Sequence Alignment.
Developing Pairwise Sequence Alignment Algorithms
Scoring Matrices June 19, 2008 Learning objectives- Understand how scoring matrices are constructed. Workshop-Use different BLOSUM matrices in the Dotter.
Scoring Matrices June 22, 2006 Learning objectives- Understand how scoring matrices are constructed. Workshop-Use different BLOSUM matrices in the Dotter.
Introduction to bioinformatics
Sequence similarity.
Alignment methods June 26, 2007 Learning objectives- Understand how Global alignment program works. Understand how Local alignment program works.
Pairwise Alignment Global & local alignment Anders Gorm Pedersen Molecular Evolution Group Center for Biological Sequence Analysis.
Sequence Alignment III CIS 667 February 10, 2004.
Algorithms Dr. Nancy Warter-Perez June 19, May 20, 2003 Developing Pairwise Sequence Alignment Algorithms2 Outline Programming workshop 2 solutions.
Introduction to Bioinformatics Algorithms Sequence Alignment.
1-month Practical Course Genome Analysis Lecture 3: Residue exchange matrices Centre for Integrative Bioinformatics VU (IBIVU) Vrije Universiteit Amsterdam.
Bioinformatics Unit 1: Data Bases and Alignments Lecture 3: “Homology” Searches and Sequence Alignments (cont.) The Mechanics of Alignments.
Alignment IV BLOSUM Matrices. 2 BLOSUM matrices Blocks Substitution Matrix. Scores for each position are obtained frequencies of substitutions in blocks.
Alignment III PAM Matrices. 2 PAM250 scoring matrix.
Multiple Sequence Alignments
Multiple sequence alignment methods 1 Corné Hoogendoorn Denis Miretskiy.
Developing Pairwise Sequence Alignment Algorithms Dr. Nancy Warter-Perez May 10, 2005.
1 Lesson 3 Aligning sequences and searching databases.
Alignment methods II April 24, 2007 Learning objectives- 1) Understand how Global alignment program works using the longest common subsequence method.
Sequence comparison: Score matrices Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas
Information theoretic interpretation of PAM matrices Sorin Istrail and Derek Aguiar.
Sequence Alignment.
Sequence Alignment Algorithms Morten Nielsen Department of systems biology, DTU.
Bioinformatics in Biosophy
Pairwise & Multiple sequence alignments
An Introduction to Bioinformatics
. Sequence Alignment and Database Searching 2 Biological Motivation u Inference of Homology  Two genes are homologous if they share a common evolutionary.
CISC667, S07, Lec5, Liao CISC 667 Intro to Bioinformatics (Spring 2007) Pairwise sequence alignment Needleman-Wunsch (global alignment)
Evolution and Scoring Rules Example Score = 5 x (# matches) + (-4) x (# mismatches) + + (-7) x (total length of all gaps) Example Score = 5 x (# matches)
Sequence Alignment Goal: line up two or more sequences An alignment of two amino acid sequences: …. Seq1: HKIYHLQSKVPTFVRMLAPEGALNIHEKAWNAYPYCRTVITN-EYMKEDFLIKIETWHKP.
Amino Acid Scoring Matrices Jason Davis. Overview Protein synthesis/evolution Protein synthesis/evolution Computational sequence alignment Computational.
Alignment methods April 26, 2011 Return Quiz 1 today Return homework #4 today. Next homework due Tues, May 3 Learning objectives- Understand the Smith-Waterman.
Pairwise Sequence Alignment. The most important class of bioinformatics tools – pairwise alignment of DNA and protein seqs. alignment 1alignment 2 Seq.
Pairwise Sequence Alignment (II) (Lecture for CS498-CXZ Algorithms in Bioinformatics) Sept. 27, 2005 ChengXiang Zhai Department of Computer Science University.
Pairwise alignment of DNA/protein sequences I519 Introduction to Bioinformatics, Fall 2012.
Sequence Analysis CSC 487/687 Introduction to computing for Bioinformatics.
Scoring Matrices April 23, 2009 Learning objectives- 1) Last word on Global Alignment 2) Understand how the Smith-Waterman algorithm can be applied to.
Construction of Substitution Matrices
Sequence Alignment Csc 487/687 Computing for bioinformatics.
Function preserves sequences Christophe Roos - MediCel ltd Similarity is a tool in understanding the information in a sequence.
Chapter 3 Computational Molecular Biology Michael Smith
Pairwise Sequence Analysis-III
A Table-Driven, Full-Sensitivity Similarity Search Algorithm Gene Myers and Richard Durbin Presented by Wang, Jia-Nan and Huang, Yu- Feng.
Intro to Alignment Algorithms: Global and Local Intro to Alignment Algorithms: Global and Local Algorithmic Functions of Computational Biology Professor.
Alignment methods April 21, 2009 Quiz 1-April 23 (JAM lectures through today) Writing assignment topic due Tues, April 23 Hand in homework #3 Why has HbS.
Sequence Alignments with Indels Evolution produces insertions and deletions (indels) – In addition to substitutions Good example: MHHNALQRRTVWVNAY MHHALQRRTVWVNAY-
Pairwise sequence alignment Lecture 02. Overview  Sequence comparison lies at the heart of bioinformatics analysis.  It is the first step towards structural.
Sequence Alignment.
Construction of Substitution matrices
Sequence Alignment Abhishek Niroula Department of Experimental Medical Science Lund University
Step 3: Tools Database Searching
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.
9/6/07BCB 444/544 F07 ISU Dobbs - Lab 3 - BLAST1 BCB 444/544 Lab 3 BLAST Scoring Matrices & Alignment Statistics Sept6.
Tutorial 3 – Protein Scoring Matrices PAM & BLOSUM
Intro to Alignment Algorithms: Global and Local
BCB 444/544 Lecture 7 #7_Sept5 Global vs Local Alignment
Pairwise Alignment Global & local alignment
Alignment IV BLOSUM Matrices
Basic Local Alignment Search Tool (BLAST)
Presentation transcript:

Alignment methods and database searching April 14, 2005 Quiz#1 today Learning objectives- Finish Dotter Program analysis. Understand how to use the program to assess regions of similarity between sequences. Understand how to use the PAM matrices. Understand the theory behind the design of BLOSUM matrices. Database searching algorithms. Understand how the Needleman-Wunsch method of optimal sequence alignment works. Homework due on Tuesday, April 19.

Assumptions in the PAM model 1. Replacement at any site depends only on the amino acid at that site and the probability given by the table (Markov model). 2. Sequences compared have should have “average” amino acid composition as derived from Dayhoff’s protein families.

Practical aspects to PAMs Good choice for sequences that are closely related (85% or greater). First substitution matrix created

Sources of error in PAM model 1. Many sequences depart from average aa composition. 2. Rare replacements were observed too infrequently to determine probabilities accurately. For 36 aa pairs (out of 400 aa pairs) no replacements were observed! 3. The idea that each amino acid is acting independently is an imperfect representation of evolution. Actually, distantly related sequences usually have islands (blocks) of conserved residues implying that replacement is not equally probable over entire sequence.

Where distance is the percent of “non-identity. PAM value is the PAM Matrix number. Note that PAM250 equates to point mutations that result in 80% distance.

BLOSUM Matrices (Blocks Substitution Matrix) BLOSUM matrices are built from distantly related sequences whereas PAM is built from closely related sequences The conserved blocks of aligned protein segments were extracted from the BLOCKS database. The BLOCKS database is a secondary database derived from the PROSITE Family database.

BLOSUM Matrices (cont.1) Version 8.0 of the Blocks Database consists of 2884 blocks based on 770 protein families documented in PROSITE. Hypothetical entry in red box in BLOCK record: AABCDA...BBCDA DABCDA.A.BBCBB BBBCDABA.BCCAA AAACDAC.DCBCDB CCBADAB.DBBDCC AAACAA...BBCCC Used for creation of BLOSUM matrix } This block is part of a motif

Building BLOSUM Matrices 1. To build the BLOSUM 62 matrix one must replace sequences that are identical in more than 62% of their amino acid sequences by a single representative sequence. 2. Next, the probability for a pair of amino acids to be in the same column is calculated. In the previous page this would be the probability of replacement of A with A, A with B, A with C, and B with C. This gives the value q ij. 3. Next, one calculates the probability that a certain amino acid frequency exists, f i. 4. Finally, we calculate the log odds ratio s i,j = log 2 (q ij /f i ). This value is entered into the scoring matrix.

Building BLOSUM Matrices (cont.) Which BLOSUM to use? BLOSUM Identity (up to) 80 80% 62 62% (usually default value) 35 35% If you are comparing sequences that are very similar, use BLOSUM 80. Sequences that are more divergent (dissimilar) than 20% are given very low scores in this matrix.

Which Scoring Matrix to use? PAM-1 BLOSUM-100 Small evolutionary distance High identity within short sequences PAM-250 BLOSUM-20 Large evolutionary distance Low identity within long sequences

Database Searching Learning objectives-Understand the principles behind the Needleman-Wunsch method of alignment. Understand how software operates to optimally align two sequences Homework-Use of N-W method for the optimal alignment of two sequences.

Needleman-Wunsch Method (1970) Output: An alignment of two sequences is represented by three lines The first line shows the first sequence. The second line has a row of symbols. The third line shows the second sequence. The symbol is a vertical bar wherever characters in the two sequences match, and a space where ever they do not. Dots may be inserted in either sequence to represent gaps.

Needleman-Wunsch Method (cont. 1) For example, the two hypothetical sequences abcdefghajklm abbdhijk could be aligned like this abcdefghajklm || | | || abbd...hijk As shown, there are 6 matches, 2 mismatches, and one gap of length 3.

Needleman-Wunsch Method (cont. 2) The alignment is scored according to a payoff matrix $payoff = { match => $match, mismatch => $mismatch, gap_open => $gap_open, gap_extend => $gap_extend }; For correct operation in this simplified version, match must be positive, and the other entries must be negative.

Needleman-Wunsch Method (cont. 3) Example Given the payoff matrix $payoff = { match => 4, mismatch => -3, gap_open => -2, gap_extend => -1 };

Needleman-Wunsch Method (cont. 4) The sequences abcdefghajklm abbdhijk are aligned and scored like this a b c d e f g h a j k l m | | | | | | a b b d... h i j k match mismatch gap_open -2 gap_extend for a total score of = 13.

Needleman-Wunsch Method (cont. 5) The algorithm guarantees that no other alignment of these two sequences has a higher score under this payoff matrix.

Needleman-Wunsch Method (cont. 6) Dynamic Programming Potential difficulty. How does one come up with the optimal alignment in the first place? We now introduce the concept of dynamic programming (DP). DP can be applied to a large search space that can be structured into a succession of stages such that: 1) the initial stage contains trivial solutions to sub-problems 2) each partial solution in a later stage can be calculated by recurring on only a fixed number of partial solutions in an earlier stage. 3) the final stage contains the overall solution.

Three steps in Dynamic Programming 1. Initialization 2 Matrix fill or scoring 3. Traceback and alignment

Two sequences will be aligned. ABCNJRQCLCRPM (sequence #1) AJCJNRCKCRBP (sequence #2) A simple scoring scheme will be used S i,j = 1 if the residue at position i of sequence #1 is the same as the residue at position j of the sequence #2 (called match score) S i,j = 0 for mismatch score w = gap penalty

Initialization step: Create Matrix with M columns and N rows. Fill in matches with 1 AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n)

Matrix fill step: Place 0’s in last row and last column AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n)

Move one row up and add value of cell plus maximum value in diagonal cell and to right from lower row AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n)

AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n)

AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n) Fill in rest of matrix

Traceback step: Position at high scoring cell and find path down and to right with highest numbers. AJCJNRCKCRBPAJCJNRCKCRBP A B C N J R Q C L C R P M Seq 1 (length m) Seq 2 (length n) ABCNJ-RQCLCR-PM AJC-JNR-CKCRBP- ABC-NJRQCLCR-PM AJCJN-R-CKCRBP- Upper path Lower path

Needleman-Wunsch Method Dynamic Programming The problem with Needleman-Wunsch is the amount of processor memory resources it requires. Because of this it is not favored for practical use, despite the guarantee of an optimal alignment. The other difficulty is that the concept of global alignment is not used in pairwise sequence comparison searches.

Needleman-Wunsch Method Typical output file Global: HBA_HUMAN vs HBB_HUMAN Score: HBA_HUMAN 1 VLSPADKTNVKAAWGKVGAHAGEYGAEALERMFLSFPTTKTYFP 44 |:| :|: | | |||| : | | ||| |: : :| |: :| HBB_HUMAN 1 VHLTPEEKSAVTALWGKV..NVDEVGGEALGRLLVVYPWTQRFFE 43 HBA_HUMAN 45 HF.DLS.....HGSAQVKGHGKKVADALTNAVAHVDDMPNALSAL 83 | ||| |: :|| ||||| | :: :||:|:: : | HBB_HUMAN 44 SFGDLSTPDAVMGNPKVKAHGKKVLGAFSDGLAHLDNLKGTFATL 88 HBA_HUMAN 84 SDLHAHKLRVDPVNFKLLSHCLLVTLAAHLPAEFTPAVHASLDKF 128 |:|| || ||| ||:|| : |: || | |||| | |: | HBB_HUMAN 89 SELHCDKLHVDPENFRLLGNVLVCVLAHHFGKEFTPPVQAAYQKV 133 HBA_HUMAN 129 LASVSTVLTSKYR 141 :| |: | || HBB_HUMAN 134 VAGVANALAHKYH 146 %id = %similarity = Overall %id = 43.15; Overall %similarity = 60.27