Lecture 3 Sequence Alignment Heuristics Substitution Matrices

Total Page:16

File Type:pdf, Size:1020Kb

Lecture 3 Sequence Alignment Heuristics Substitution Matrices Sequence Alignment Heuristics Some slides from: • Iosif Vaisman, GMU mason.gmu.edu/~mmasso/binf630alignment.ppt • Serafim Batzoglu, Stanford http://ai.stanford.edu/~serafim/ • Geoffrey J. Barton, Oxford “Protein Sequence Alignment and Database Scanning” http://www.compbio.dundee.ac.uk/ftp/preprints/review93/review93.pdf © CG 2015 Why Heuristics ? • Motivation: – Dynamic programming guarantees an optimal solution & is efficient, but – Not fast enough when searching a database of size ~1012, with a query of length 200-500bp © CG 2015 GenBank Growth © CG 2015 http://www.ncbi.nlm.nih.gov/Genbank/genbankstats.html Possible Solutions • Solutions: – Implement on hardware. (COMPUGEN) – Parallel hardware. (MASSPAR) – Ad-hoc implementations using specific hardware. – Use faster heuristic algorithms. • Limit the number of allowed indels. • Look for “long” matching subsequences. • Use indexing/hashing. • Common Heuristics: FASTA, BLAST CG © Ron Shamir, 09 Key observations • Even O(m+n) time would be problematic when db size is huge • Substitutions are much more likely than indels • Homologous sequences contain many matches • Numerous queries are run on the same db Preprocessing of the db is desirable © CG 2015 Indexing-based local alignment Dictionary: …… All words of length k (~10) query Alignment initiated between words of alignment score T …… Alignment: Ungapped extensions until score scan below statistical threshold DB Output: All local alignments with score > statistical threshold query CS262 Lecture 3, Win06, Batzoglou Detour: Banded Alignment Assume we know that x and y are very similar Assumption: # gaps(x, y) < k(N) ( say N>M ) xi Then, | implies | i – j | < k(N) yj We can align x and y more efficiently: Time, Space: O(N k(N)) << O(N2) CS262 Lecture 2, Win06, Batzoglou Banded Alignment Initialization: x1 ………………………… xM F(i,0), F(0,j) undefined for i, j > k 1 Iteration: For i = 1…M For j = max(1, i – k)…min(N, i+k) F(i – 1, j – 1)+ s(xi, yj) F(i, j) = max F(i, j – 1) – d, if j > i – k(N) ………………………… y F(i – 1, j) – d, if j < i + k(N) N y k(N) Termination: same Easy to extend to the affine gap case CS262 Lecture 2, Win06, Batzoglou Alignment Dot-Plot Matrix a a g t c c c g t g a * * g * * * g * * t * * c * * * c * * * g * * * t * * t * * © CG 2015 c * * * Dot plots Example 1: close protein homologs (man and mouse) © CG 2015 www.bioinfo.rpi.edu/~zukerm/Bio-5495/ Example 2: remote protein homologs (man and bacilus) © CG 2015 Example 1: dot for 4+ matches in window of 5 © CG 2015 Example 2: dot for 4+ matches in window of 5 © CG 2015 FASTA : A Heuristic Method for Sequence Comparison • History: Lipman and Pearson in 1985, 1988 • Key idea: Good local alignment must have exact matching subsequences. • Algorithm Evaluation: – Resulting alignment scores well compared to the optimal alignment (shown experimentally) – Much faster than dynamic programming. © CG 2015 Disclaimer • Highly popular software tools get numerous updates, revisions, versions, variants etc. • Implementation details differ considerably among versions. • It is hard to single out one ultimate version. • We present the basic ideas and details may vary. © CG 2015 a a g t c c t g a t t t g c c c a g g t * * * * * g * * * g * * * t * * * * “hot* spots” c * * * * * a * * * * * * a * * * * * * g * * * * a * * * * * * t * * * * * t * * * * * c * * * * * c * * * * * a * * * * * * t * * * * * c * * * * * a * * * * * * g * * * g * * * * © CG 2015 FASTA overview ktup = required min length of perfect match 1. Find hot spots = matches of length ktup 2. Find 10 best diagonal runs = almost consecutive hot spots on same diagonal. Best soln = init1 2.1 Find an optimal sub-alignment in each diagonal 3. Combine close sub-alignments. best soln = initn 4. Compute best DP solution in a band around initn. result = opt © CG 2015 FASTA – Step 1 Sequence B Find hot spots: (runs of matches of length ktup) Sequence A Sequence © CG 2015 FASTA – Step 2 Sequence B 2 Rescoring using a subs. matrix high score low score Sequence A Sequence The score of the highest scoring initial region is saved as the init1 score. © CG 2015 FASTA – Step 3 Sequence B 3 Joining threshold - eliminates disjointed segments Non-overlapping regions are joined. The score equals sum Sequence A Sequence of the scores of the regions minus a gap penalty. The score of the highest scoring region, at the end of this step, is saved as the initn score. © CG 2015 FASTA Algorithm (2) 2. Find 10 best diagonal runs and init1 3. Allowing indels – combine close diagonal runs: Construct an alignment graph: •nodes =sub-alignments (SAs) • weight – alignment score (from 1) •Edges btw SAs that can fit together, •weight - negative, depends on the size of the corresponding gap Find a maximum weight path in it, initn Alignment graph © CG 2015 FASTA – Step 4 Sequence B 4 Alignment optimization using dynamic programming Sequence A Sequence The score for this alignment is the opt score. © CG 2015 FASTA Output • The information on each hit includes: – General information and statistics – SW score, %identity and length of overlap © CG 2015 Statistical significance • Key question: how significant is the score x that was obtained? • Scores are not normally distributed • Solution 1: view the scores distribution over all database entries, see how far out x is. © CG 2015 Output of Fasta 2 © CG 2015 -------------------------------------------------------------------------------- Distribution of initial scores with ktup=2. | v initn init1 < 2 2 2:= 4 0 0: 6 4 4:== 8 18 18:========= 10 73 73:===================================== 12 326 326:================================================== 14 370 370:================================================== 16 1248 1248:================================================== 18 1354 1354:================================================== 20 2746 2746:================================================== 22 3151 3151:================================================== 24 6401 6401:================================================== 26 5110 5110:================================================== 28 5724 5763:================================================== 30 3887 4303:================================================== 32 2238 2682:================================================== 34 1401 1735:================================================== 36 863 1144:================================================== 38 533 690:================================================== 40 346 411:================================================== 42 481 250:================================================== 44 419 166:================================================== 46 346 110:================================================== 48 295 84:------------------------------------------++++++++ 50 203 47:------------------------++++++++++++++++++++++++++ 52 184 46:-----------------------+++++++++++++++++++++++++++ 54 110 39:--------------------++++++++++++++++++++++++++++++ 56 82 9:-----++++++++++++++++++++++++++++++++++++ 58 69 8:----+++++++++++++++++++++++++++++++ 60 71 3:--++++++++++++++++++++++++++++++++++ 62 75 1:-+++++++++++++++++++++++++++++++++++++ 64 36 1:-+++++++++++++++++ 66 31 0:++++++++++++++++ 68 17 2:-++++++++ 70 12 0:++++++ 72 12 0:++++++ 74 6 0:+++ 76 10 1:-++++ 78 28 0:++++++++++++++ 80 2 0:+ > 80 19 5:---+++++++ 13464008 residues in 38303 sequences statistics exclude scores greater than 73 http://bimas.dcrt.nih.gov/fastainfo/fastaexample.html mean initn score: 26.8 (7.79) mean init1 score: 26.0 (6.05) 5349 scores better than 33 saved, ktup: 2, variable pamfact joining threshold: 28 scan time: 0:00:30 ©-------------------------------------------------------------------------------- CG 2015 The best scores are: initn init1 opt sp|P33013|YEEC_ECOLI HYPOTHETICAL 38.9 KD PROTEIN IN S 1422 1422 1422 Statistical significance (2) • Key question: how significant is the score x that was obtained? • Solution 2: - average score of random sequence; - standard dev. • Z-score: z = (x- ) / • Rule of thumb: z > 3 possibly significant, z>6 probably significant, z>10 significant • Issues: sensitivity vs selectivity. • Pertinence to biology is the bottom line © CG 2015 August 1997: NCBI Director David Lipman (far left) coaches Vice President Gore (seated) as he searches PubMed. NIH Director Harold Varmus (center) and NLM Director Donald Lindberg look on. © CG 2015 Bill Pearson Bill Pearson received his Ph.D. in Biochemistry in 1977 from the California Institute of Technology. He then did a post- doctoral fellowships at the Caltech Marine Station in Corona del Mar, CA and at the Department of Molecular Biology and Genetics at Johns Hopkins. In 1983 he joined the Department of Biochemistry at the University of Virginia. © CG 2015 BLAST Basic Local Alignment Search Tool Altschul, Gish, Miller, Myers and Lipman 1990. • Motivation: Need to increase the speed of FASTA by finding fewer and better spots during the algorithm. • The Core of the Algorithm: Finding fewer and better hot spots, but not insisting on perfect matches in them. • Some statistical results on the significance of the results • Different versions for protein, DNA, … © CG 2015 © CG 2015 BLAST – outline • Compile a list of high scoring words with the query • Scan the database for hits • Extend hits © CG 2015 BLAST Algorithm 1 Query sequence of length L Maximum of L-w+1 words (typically w = 3 for proteins) For each word from the query sequence find the list of words with high score using a substitution matrix Word list BLAST Algorithm 2 Database sequences Word list Exact matches of words
Recommended publications
  • Lecture 5: Sequence Alignment – Global Alignment
    Sequence Alignment COSC 348: Computing for Bioinformatics • Sequence alignment is a way of arranging two or more sequences of characters to identify regions of similarity – b/c similarities may be a consequence of functional or Lecture 5: evolutionary relationships between these sequences. Sequence Alignment – Global Alignment • Another definition: Procedure for comparing two or more sequences by searching for a series of individual characters that Lubica Benuskova, Ph.D. are in the same order in those sequences – Pair-wise alignment: compare two sequences – Multiple sequence alignment: compare > 2 sequences http://www.cs.otago.ac.nz/cosc348/ 1 2 Similarity versus identity Sequence alignment: example • In the process of evolution, from one generation to the next, and from one species to the next, the amino acid sequences of • Task: align abcdef with somehow similar abdgf an organism's proteins are gradually altered through the action of DNA mutations. For example, the sequence: • Write second sequence below the first one – ALEIRYLRD • could mutate into the sequence: ALEINYLRD abcdef abdgf • in one generation and possibly into AQEINYQRD • Move sequences to give maximum match between them. • over a longer period of evolutionary time. – Note: a hydrophobic amino acid is more likely to stay • Show characters that match using vertical bar. hydrophobic than not, since replacing it with a hydrophilic residue could affect the folding and/or activity of the protein. 3 4 Sequence alignment: example Quantitative global alignments abcdef • We are looking for an alignment, which || – maximizes the number of base-to-base matches; abdgf – if necessary to achieve this goal, inserts gaps in either sequence (a gap means a base-to-nothing match); • In order to maximise the alignment, we insert gap between – the order of bases in each sequence must remain and in lower sequence to allow and to align b d d f preserved and abcdef – gap-to-gap matches are not allowed.
    [Show full text]
  • Novel Bioinformatics Applications for Protein Allergology
    AND ! "#$% &'()* +% + ,-.,-/,0 + 121,..0-10- ! 3 4 33!!3 ,,,1/ !"# $% # $# &'()$ $*+,'-./ $ "Por la ciencia, como por el arte, se va al mismo sitio: a la verdad" Gregorio Marañón Madrid, 19-05-1887 - Madrid, 27-03-1960 List of Papers This thesis is based on the following papers, which are referred to in the text by their Roman numerals. I Martínez Barrio, Á., Soeria-Atmadja, D., Nister, A., Gustafsson, M.G., Hammerling, U., Bongcam-Rudloff, E. (2007) EVALLER: a web server for in silico assessment of potential protein allergenicity. Nucleic Acids Research, 35(Web Server issue):W694-700. II Martínez Barrio, Á.∗, Lagercrantz, E.∗, Sperber, G.O., Blomberg, J., Bongcam-Rudloff, E. (2009) Annotation and visualization of endogenous retroviral sequences using the Distributed Annotation System (DAS) and eBioX. BMC Bioinformatics, 10(Suppl 6):S18. III Martínez Barrio, Á., Xu, F., Lagercrantz, E., Bongcam-Rudloff, E. (2009) GeneFinder: In silico positional cloning of trait genes. Manuscript. IV Martínez Barrio, Á., Ekerljung, M., Jern, P., Benachenhou, F., Sperber,
    [Show full text]
  • Information-Theoretic Bounds of Evolutionary Processes Modeled As a Protein Communication System
    INFORMATION-THEORETIC BOUNDS OF EVOLUTIONARY PROCESSES MODELED AS A PROTEIN COMMUNICATION SYSTEM Liuling Gong, Nidhal Bouaynaya∗ and Dan Schonfeld University of Illinois at Chicago, Dept. of Electrical and Computer Engineering, ABSTRACT can be investigated in the context of engineering communica- In this paper, we investigate the information theoretic bounds tion codes. In particular, it is legitimate to ask at what rate of the channel of evolution introduced in [1]. The channel of can the genomic information be transmitted. And what is the evolution is modeled as the iteration of protein communica- average distortion between the transmitted message and the tion channels over time, where the transmitted messages are received message at this rate? Shannon’s channel capacity protein sequences and the encoded message is the DNA. We theorem states that, by properly encoding the source, a com- compute the capacity and the rate-distortion functions of the munication system can transmit information at a rate that is protein communication system for the three domains of life: as close to the channel capacity as one desires with an arbi- Achaea, Prokaryotes and Eukaryotes. We analyze the trade- trarily small transmission error. Conversely, it is not possi- off between the transmission rate and the distortion in noisy ble to reliably transmit at a rate greater than the channel ca- protein communication channels. As expected, comparison pacity. The theorem, however, is not constructive and does of the optimal transmission rate with the channel capacity in- not provide any help in designing such codes. In the case dicates that the biological fidelity does not reach the Shan- of biological communication systems, however, evolution has non optimal distortion.
    [Show full text]
  • Testing the Independence Hypothesis of Accepted Mutations for Pairs Of
    University of Nebraska - Lincoln DigitalCommons@University of Nebraska - Lincoln Computer Science and Engineering: Theses, Computer Science and Engineering, Department of Dissertations, and Student Research 12-2016 TESTING THE INDEPENDENCE HYPOTHESIS OF ACCEPTED MUTATIONS FOR PAIRS OF ADJACENT AMINO ACIDS IN PROTEIN SEQUENCES Jyotsna Ramanan University of Nebraska-Lincoln, [email protected] Follow this and additional works at: http://digitalcommons.unl.edu/computerscidiss Part of the Bioinformatics Commons, and the Computer Engineering Commons Ramanan, Jyotsna, "TESTING THE INDEPENDENCE HYPOTHESIS OF ACCEPTED MUTATIONS FOR PAIRS OF ADJACENT AMINO ACIDS IN PROTEIN SEQUENCES" (2016). Computer Science and Engineering: Theses, Dissertations, and Student Research. 118. http://digitalcommons.unl.edu/computerscidiss/118 This Article is brought to you for free and open access by the Computer Science and Engineering, Department of at DigitalCommons@University of Nebraska - Lincoln. It has been accepted for inclusion in Computer Science and Engineering: Theses, Dissertations, and Student Research by an authorized administrator of DigitalCommons@University of Nebraska - Lincoln. TESTING THE INDEPENDENCE HYPOTHESIS OF ACCEPTED MUTATIONS FOR PAIRS OF ADJACENT AMINO ACIDS IN PROTEIN SEQUENCES by Jyotsna Ramanan A THESIS Presented to the Faculty of The Graduate College at the University of Nebraska In Partial Fulfilment of Requirements For the Degree of Master of Science Major: Computer Science Under the Supervision of Peter Z. Revesz Lincoln, Nebraska December, 2016 TESTING THE INDEPENDENCE HYPOTHESIS OF ACCEPTED MUTATIONS FOR PAIRS OF ADJACENT AMINO ACIDS IN PROTEIN SEQUENCES Jyotsna Ramanan, MS University of Nebraska, 2016 Adviser: Peter Z. Revesz Evolutionary studies usually assume that the genetic mutations are independent of each other. However, that does not imply that the observed mutations are indepen- dent of each other because it is possible that when a nucleotide is mutated, then it may be biologically beneficial if an adjacent nucleotide mutates too.
    [Show full text]
  • A Thesis Entitled Homology-Based Structural Prediction of the Binding
    A Thesis entitled Homology-based Structural Prediction of the Binding Interface Between the Tick-Borne Encephalitis Virus Restriction Factor TRIM79 and the Flavivirus Non-structural 5 Protein. by Heather Piehl Brown Submitted to the Graduate Faculty as partial fulfillment of the requirements for the Master of Science Degree in Biomedical Science _________________________________________ R. Travis Taylor, PhD, Committee Chair _________________________________________ Xiche Hu, PhD, Committee Member _________________________________________ Robert M. Blumenthal, PhD, Committee Member _________________________________________ Amanda Bryant-Friedrich, PhD, Dean College of Graduate Studies The University of Toledo December 2016 Copyright 2016, Heather Piehl Brown This document is copyrighted material. Under copyright law, no parts of this document may be reproduced without the expressed permission of the author. An Abstract of Homology-based Structural Prediction of the Binding Interface Between the Tick-Borne Encephalitis Virus Restriction Factor TRIM79 and the Flavivirus Non-structural 5 Protein. by Heather P. Brown Submitted to the Graduate Faculty as partial fulfillment of the requirements for the Master of Science Degree in Biomedical Sciences The University of Toledo December 2016 The innate immune system of the host is vital for determining the outcome of virulent virus infections. Successful immune responses depend on detecting the specific virus, through interactions of the proteins or genomic material of the virus and host factors. We previously identified a host antiviral protein of the tripartite motif (TRIM) family, TRIM79, which plays a critical role in the antiviral response to flaviviruses. The Flavivirus genus includes many arboviruses that are significant human pathogens, such as tick-borne encephalitis virus (TBEV) and West Nile virus (WNV).
    [Show full text]
  • Bioinformatics Scoring Matrices
    Bioinformatics Scoring Matrices David Gilbert Bioinformatics Research Centre www.brc.dcs.gla.ac.uk Department of Computing Science, University of Glasgow Scoring Matrices • Learning Objectives – To explain the requirement for a scoring system reflecting possible biological relationships – To describe the development of PAM scoring matrices – To describe the development of BLOSUM scoring matrices (c) David Gilbert 2008 Scoring matrices 2 Scoring Matrices • Database search to identify homologous sequences based on similarity scores • Ignore position of symbols when scoring • Similarity scores are additive over positions on each sequence to enable DP • Scores for each possible pairing, e.g. proteins composed of 20 amino acids, 20 x 20 scoring matrix (c) David Gilbert 2008 Scoring matrices 3 Scoring Matrices • Scoring matrix should reflect – Degree of biological relationship between the amino-acids or nucleotides – The probability that two AA’s occur in homologous positions in sequences that share a common ancestor • Or that one sequence is the ancestor of the other • Scoring schemes based on physico-chemical properties also proposed (c) David Gilbert 2008 Scoring matrices 4 Scoring Matrices • Use of Identity – Unequal AA’s score zero, equal AA’s score 1. Overall score can then be normalised by length of sequences to provide percentage identity • Use of Genetic Code – How many mutations required in NA’s to transform one AA to another • Phe (Codes UUU & UUC) to Asn (AAU, AAC) • Use of AA Classification – Similarity based on properties such
    [Show full text]
  • Oxidising Bacteria (SAOB)
    Computational and Comparative Investigations of Syntrophic Acetate- oxidising Bacteria (SAOB) Genome-guided analysis of metabolic capacities and energy conserving systems Shahid Manzoor Faculty of Veterinary Medicine and Animal Science Department of Animal Breeding and Genetics Uppsala Doctoral Thesis Swedish University of Agricultural Sciences Uppsala 2014 Acta Universitatis agriculturae Sueciae 2014:56 Cover: Bioinformatics helping the constructed biogas reactors to run efficiently. (photo: (Shahid Manzoor) ISSN 1652-6880 ISBN (print version) 978-91-576-8060-0 ISBN (electronic version) 978-91-576-8061-7 © 2014 Shahid Manzoor, Uppsala Print: SLU Service/Repro, Uppsala 2014 Computational and Comparative Investigations of Syntrophic Acetate-oxidising Bacteria (SAOB) – Genome-guided analysis of metabolic capacities and energy conserving systems. Abstract Today’s main energy sources are the fossil fuels petroleum, coal and natural gas, which are depleting rapidly and are major contributors to global warming. Methane is produced during anaerobic biodegradation of wastes and residues and can serve as an alternative energy source with reduced greenhouse gas emissions. In the anaerobic biodegradation process acetate is a major precursor and degradation can occur through two different pathways: aceticlastic methanogenesis and syntrophic acetate oxidation combined with hydrogenotrophic methanogenesis. Bioinformatics is critical for modern biological research, because different bioinformatics approaches, such as genome sequencing, de novo assembly
    [Show full text]
  • Lecture 10: Local Alignment and Substitution Matrices 10.1
    CPS260/BGT204.1 Algorithms in Computational Biology September 30, 2003 Lecture 10: Local Alignment and Substitution Matrices Lecturer: Pankaj K. Agarwal Scribe: Madhuwanti Vaidya So far we have seen global alignment, where entire sequences are matched. There are two other variations of global alignment. 10.1 Semiglobal alignment In semiglobal alignment we do not pay penalty for end gaps. These are gaps that appear before the first letter of the sequence or after the last letter of the sequence. They are also called leading and trailing gaps, respectively. If one of the sequences is significantly shorter than the other, then semiglobal alignment is preferrable. Example Consider two sequences - C A G C A C T T G G A T T C T C G G and C A G C G T G G. They can be aligned in many ways: C A G C A − C T T G G A T T C T C G G C A G C A C T T G G A T T C T C G G − − − C A G C G T G G − − − − − − − C A G C − − − − − G − T − − − − G G Alignment 1 Alignment 2 Figure 10.1: Semi-global alignment We want to choose the Alignment1 over Alignment2 as Alignment2 fragments the second sequence, which is not what we are looking for. Giving Alignment1 a better score as compared to Alignment2 is done by not paying a penalty for the trailing and leading gaps. ¢¡¤£¦¥¨§ © ©¥ ¡£§© © Trailing Gaps Suppose we have two sequences , and and is the shorter ¥§©¥ © ©¥"! of the 2 sequences.
    [Show full text]
  • 2-PAM Matrices
    3/28/20 Bioinformatics II: PAM matrices Dr Manaf A Guma University of Anbar- college of applied science-Heet. Department of chemistry 1 Before we start, what is the difference between point mutation and frameshift mutation? • Point mutation is an alteration of a single nucleotide in a gene whereas frameshift mutation involves one or more nucleotide changes of a particular gene. • Point mutations are mainly nucleotide substitutions, which lead to silent, missense or nonsense mutations. Frameshift mutations occur by insertion or deletion of nucleotides. 2 1 3/28/20 Define? • Nonsense Mutations: the alteration of a nucleotide in a particular codon may introduce a stop codon to the gene. This stops the translation of the protein at halfway of the complete protein. • Silent mutations, a single base pair has changed in a particular codon, the same amino acid is coded by the altered codon as well. • Missense mutations, once the alteration occurs in a particular codon by a nucleotide substitution, the codon is altered in such a way to code a different amino acid. 3 Point accepted mutation 4 2 3/28/20 PAM matrices: Background and concepts • How the PAM work? 1. Only mutations are allowed. 2. Sites evolve independently. 3. Evolution at each site occurs according to a Markov equation. • It follows Markov process.? How? 5 5 What is Markov concept? • Markov process: • (The substitution is independent from their past history!). • Meaning: • Next mutation depends only on current state and is independent of previous mutations. • It is derived from global alignment. do you remember? 6 3 3/28/20 What are PAM matrices ? • Point accepted mutation matrix known as a PAM.
    [Show full text]
  • Pairwise Alignment
    Chap. 2 Pairwise alignment • The most basic sequence analysis question: if two sequences are related? • Key Issues: 1. What alignment should be considered? 2. What score system to rank alignments? 3. What algorithm to find optimal (or good) scoring alignments? 4. What statistical method to evaluate the significance? 2.1 Introduction 1 Introduction 2 2.1 Introduction 3 The scoring model • Evolutionary force that can shape molecular (protein, DNA) sequences: mutation (substitution, insertion/deletion or indel), selection (positive, negative, neutral). • If total log-likelihood score (measuring relatedness) of an alignment is a sum of terms for each aligned pair of residues (plus terms for each gap), intuitively, we expect identities and conservative substitutions to be more likely in real alignments than we expect by chance (positive score); and vice versa. 2.2 The Scoring model 4 Substitution matrices (for un-gapped global alignment) • For unrelated or random model R, odds ratio of “match model” M and unrelated or random model R, : p ∏ xi yi p(x, y | M ) px y = i = ∏ i i p(x, y | R) q q q q ∏ xi ∏ y j i xi yi i j • For log-odds ratio score S(x, y) = ∑ s(xi , yi ) i pab where s(a,b) = log qaqb 2.2 The scoring model 5 Chemical Properties of Amino Acids Match +3 and mismatch = -1 may be good enough for DNA, but not for proteins: e.g. leucine is much more likely to be replaced by an isoleucine than by a glutamate. Introduction 6 Introduction Taylor W.R. (1986) Bioinformatics7 Introduction 8 Gap penalties • Linear penalty score for a gap of length g γ (g) = −gd • Or affine score γ (g) = −d − (g −1)e where d is the gap-open penalty and e is the gap extension penalty.
    [Show full text]
  • PHAT: a Transmembrane-Specific Substitution Matrix
    Vol. 16 no. 9 2000 BIOINFORMATICS Pages 760–766 PHAT: a transmembrane-specific substitution matrix Pauline C. Ng 1, Jorja G. Henikoff 2 and Steven Henikoff 2,∗ 1Department of Bioengineering, University of Washington, Seattle, WA 98195, USA and 2Fred Hutchinson Cancer Research Center, 1100 Fairview Ave. N, Seattle, WA 98109-1024, USA Received on February 23, 2000; revised on April 14, 2000; accepted on April 18, 2000 −1 Abstract sij = λ ln(qij/(pi p j )) where λ is a scaling factor, qij’s Motivation: Database searching algorithms for proteins are target or observed frequencies of amino acid pairs use scoring matrices based on average protein properties, taken from alignments and pi ’s are the background fre- and thus are dominated by globular proteins. However, quencies (Altschul, 1991). The widespread use of database since transmembrane regions of a protein are in a searching and other protein alignment tools in modern distinctly different environment than globular proteins, biology underscores the importance of using substitution one would expect generalized substitution matrices to be matrices that most accurately resemble biological reality. inappropriate for transmembrane regions. The point accepted mutation (PAM) and blocks sub- Results: We present the PHAT (predicted hydrophobic stitution matrices (BLOSUM) are the two most popular and transmembrane) matrix, which significantly outper- matrix series (Dayhoff, 1978; Henikoff and Henikoff, forms generalized matrices and a previously published 1992). The PAM matrix is computed by counting muta- transmembrane matrix in searches with transmembrane tions between closely related sequences and an inferred queries. We conclude that a better matrix can be con- common ancestral sequence to obtain PAM 1 target structed by using background frequencies characteristic frequencies.
    [Show full text]
  • Substitution Matrices E S V U
    C E N Introduction to bioinformatics T R E 2007 F B O I R O I I N N Lecture 8 T F E O G R R M A A T T I I V C Substitution Matrices E S V U C E N T R E 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 [1] Substitution matrices – Sequence analysis 2006 Sequence Analysis Finding relationships between genes and gene products of different species, including those at large evolutionary distances C E N T R E 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 [2] Substitution matrices – Sequence analysis 2006 Archaea Domain Archaea is mostly composed of cells that live in extreme environments. While they are able to live elsewhere, they are usually not found there because outside of extreme environments they are competitively excluded by other organisms. Species of the domain Archaea are •not inhibited by antibiotics, •lack peptidoglycan in their cell wall (unlike bacteria, which have this sugar/polypeptide compound), •and can have branched carbon chains in their membrane lipids of the phospholipid bilayer. C E N T R E 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 [3] Substitution matrices – Sequence analysis 2006 Archaea (Cnt.) • It is believed that Archaea are very similar to prokaryotes (e.g.
    [Show full text]