Similarity or Identity? When are molecules similar?

Size: px
Start display at page:

Download "Similarity or Identity? When are molecules similar?"

Transcription

1 Similarity or Identity? When are molecules similar? Mapping Identity A -> A T -> T G -> G C -> C or Leu -> Leu Pro -> Pro Arg -> Arg Phe -> Phe etc If we map similarity using identity, how similar are these sequences CTTCCGCGC : : : : : : CTACCTCGA 66%? Convert sequences to polypeptides Now how similar are the same sequences Leu Pro Arg : : : Leu Pro Arg 100%?

2 When is similarity relevant: How similar must two things be? Redundancy in the genetic code 2nd pos 1st pos U C A G 3rd pos U Phe Ser Tyr Cys U Phe Ser Tyr Cys C Leu Ser Stop Stop A Leu Ser Stop Trp G C Leu Pro His Arg U Leu Pro His Arg C Leu Pro Gln Arg A Leu Pro Gln Arg G A Ile Thr Asn Ser U Ile Thr Asn Ser C Ile Thr Lys Arg A Met Thr Lys Arg G G Val Ala Asp Gly U Val Ala Asp Gly C Val Ala Glu Gly A Val Ala Glu Gly G

3 When is similarity relevant: How similar must two things be? Structural and chemical similarity Aliphatic/hydrophobic amino acids Acidic amino acids Aspartate Valine Leucine Isoleucine Glutamate amino acids with similar chemical properties may be substituted in semiconserved regions without any discernable effect on function

4 Similarity When are two sequences similar? Complexity? We have sequenced from person x = AAAAAA & sequenced from person y = AAAAAA Does x = y? Superficially AAAAAA AAAAAA However given several possible scenarios: If x and y come from unrelated genes containing only A s - x is not the same as y! If x and y come from regions of unrelated genes containing a region of only A s with low complexity in this case x is also not the same as y!! Conclusion: similarity can mean different things and the context of the comparison needs to be taken into account!

5 How can we account for context? Probability of match sequences using two models Related Model :match is not a chance event and a match is always obtained ie p(match) = 1. P(A,A)= p(t,t) = p(g,g) = p(c,c) = 1 P(any other combination) = 0 Now p(match occurring by chance) : p(x,y related) = p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)=1 Random Model (also known as the background model): match is a chance or random event and the likelihood of a match is the product of their base frequency - lets assume: p(nucleotide n)= p(frequency of n) : p(a) = p(t) =0.2, p(g) = p(c) = 0.3 And p(aa)=0.2*0.2= Now p(match occurring by chance): p(x,y random) = p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)= 4e -9

6 So which model do we use? Both: the ratio of probability in the two models provides a measure of likelihood that the sequences match by chance Likelihood Ratio L = p(x,y related) p(x,y random) If P(A,A)= p(t,t) = p(g,g) = p(c,c) = 1, P(any other combination) = 0 p(x,y related) = p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)=1 and p(nucleotide n)= p(frequency of n): p(a) = p(t) =0.2, p(g) = p(c) = 0.3 p(x,y random) = p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)= 4e -9 L=1/ highly significant However if :p(nucleotide n)= p(frequency of n) : p(a) = 1 & p(t) =p(g) = p(c) = 0 p(x,y random) = p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)* p(a,a)= 1 L=1/1 nonsignificant

7 How is a related model derived? One related model available which is used in the BLOSUM matrix is derived from the frequency of all possible matches which are found in alignments of related sequences eg. ALIGNMENT OF RELATED SEQUENCES AVGI LKGM AVGI LRGM AVGLLRGM G IGLLKGM GVGLLRGM P(transition m,n) = freq of m,n transitions no of all possible transitions f(a,a)=3, f(a,g)=6, f(g,g)=21.. F(all pos trans)=80 P(A,A related)=3/80, p(a,g related)=6/80, p(g,g related)=21/80.

8 How is a random model derived? One random model available which is used in the BLOSUM matrix and is usually referred to as the background model is determined by the frequency of nucleotides in transition pairs of sequences derived from the same alignment ALIGNMENT OF RELATED SEQUENCES AVGI LKGM AVGI LRGM AVGLLRGM G IGLLKGM GVGLLRGM p(m) = freq m as a pair total no of pairs f(a in pair) = 3 (AA) +6 (AG), f(g in pair)= Total no of pairs = 80 P(A) = 9/80, p(g) = 27/80.

9 Likelihood Ratio and Matrices For reasons of numerical stability ie addition is faster and more computationally stable than multiplication, the Log 2 of a given likelihood ratio for any transition (m,n) is used and rounded to the nearest integer. Since a*b=log(a)+log(b) LogL Ratio= Log (p(m,n related)/p(m,n background) For each transition possible the LogL ratio is available in a lookup table and has been constructed from an alignment in the BLOCKS database where the conserved sequences aligned have a minimum given identity. Such a set of matrices is referred to as BlosumXX. Where Blosum62 was constructed from an alignment with 62% or more identity. Another is referred to as the PAM matrices where the value of PAM1 is the equivalent evolutionary distance of 1 mutation in 100

10 Likelihood Ratio and Matrices BlosumXX Part of the Blosum45 matrix A R N D C Q E G H I A R N D C Q E G H I Part of the Blosum62 matrix A R N D C Q E G H I A R N D C Q E G H I Therefore the LogL Ratio for a given alignment is the sum of the scores for each transition. LogL Ratio= Log p(x 1,y 1 r) + Log p(x 1,y 1 r) + Log p(x 1,y 1 r) +. p(x 1,y 1 b) p(x 1,y 1 b) p(x 1,y 1 b) Since low value BlosumXX matrices are constructed from more distantly related sequences they are better at identifying distant relationships

11 Additional Scoring Parameters The most common changes which are observed when evolutionary related sequences are compared are multiple base insertions or deletions not single base substitutions An insertion might in reality be a deletion in the corresponding sequence such insertion/deletion events are termed indel events We need to decide if we account for this type of event and if so not just the occurrence of an indel but its size To do this we use additional scoring parameters Gapped Or Ungapped: allow gaps deletion/insertion into the alignment Y R - V L D N M V I Y R V L D V I Y R Y V L D - - V I L M D T S L D L M T S D L M S T S F D

12 Additional Scoring Parameters Gap Penalty: what penalty score is associated with introducing a gap V L D N T I V L D I V L D - V I Gap extension Penalty: if a gap is extended what score is paid Y R K V L D K N M T I P Y + V L D I P Y K Y V Y S V L D D - - V I P

13 Gap Extention Penalty The effect of allowing of gaps means that pairings of bases/amino acids may be spread throughout the alignment HSTQHEAGYEARSIGVVLAWHEAE H ----EAG --AW--G -----HE -E Intuitively we would expect conservation to be grouped into domains and not spread throughout the alignment, since the most common rearrangements of gene sequence are insertions and deletion HSTQHEAGYEARSIGVVLAWHEAE ----HEAG AWGHEE This effect is achieved by introducing a gap extension penalty such that not only is a penalty applied for starting a gap but also adding to an existing gap

14 Gap Extention Penalty If gap penalty = -8, EE = 5, HH = 8, GG = 6, RW = -3, AA = 4 Best alignment with no gap extension penalty HSTQHEAGYEARSIGVVLAWHEAE H ----EAG --AW--G -----HE E No gap extension penalty = 4 gap extension penalty = -2 now has a score of = -14 Using an alternative alignment If gap penalty = -8, gap extension penalty = -2, WW = 11, HG= -2, HE = 0, AE = -1 With a gap extension Now the best alignment is -16-(2x13) = -2 HSTQHEAGYEARSIGVVLAWHEAE ----HEAG AWGHEE

15 How do we find the best GLOBAL alignment? Needleman-Wunsch or dynnamic global alignment algorithm Two sequences each of 200 bases, gaps allowed how many possible alignments? 2 2n =7.28x πn I P E E I L G K I I P E D I L G E I These are most simply represented in a m x n matrix. The diagonal represents the alignments without insertions or deletions in either sequence. The horizontal and vertical represents insertions or deletions in one of the two sequences. The alignment starts in the upper left row/col and extends the whole length of the diagonal The combination of these movements within the matrix, therefore represent all possible alignments

16 Calculating the score for any given GLOBAL alignment The Dynamic Global alignment Algorithm Y R K V L D K N M I P V P I L G R I A number of choices need to be made at the start Gapped or ungapped? Gapped What gap penalty do we set if any? 8 What gap extention penalty if any? 0 What Matrix is to be used for scoring? Blosum45 I P V P I L G R I Y -8 R -16 K -24 V -32 L -40 D -48 K -56 N -64 M-72 Step 1 1. Fill in the initial gap penalties

17 Calculating the score for any given GLOBAL alignment The Dynamic Global alignment Algorithm Add score for match (row i, col j ) to upper left diagonal (row i-1,col j-1 ) Step 2. filling in each cell 3. Or Add cost of gap (-8) to score in cell above (row j-1, Col j ) 2. I P Y R -16 I P Y R Or Add cost of gap (-8) to score in cell to the left (row i, Col j-1 ) 4. Enter highest score for (row i, Col j ) out of these values, noting which this cell value came from 3. I P Y R Note direction from which Max comes I P Y -8 0 R -16

18 Calculating the score for any given GLOBAL alignment The Dynamic Global alignment Algorithm 3 Step 3. Fill out remaining scores noting source of max - I P V P I L G R I Y R K V L D K N M Step 4. Trace the back the path from the bottom right hand cell and extract the alignment from the path I PV P I LG R I - Y - RKV LDKNM

19 Local vs Global alignments The Needleman-Wunsch algorithm aligns two sequences over their entire length, however, this has distinct disadvantages. 1. when trying to identify common functional domains of distantly related sequences such as orthologues 2. Comparing partial or overlapping sequences where only part of the common sequences may be present such as comparing ESTs In such cases it is desirable to do local alignments ie find regions of sequence similarity amongst regions of disimilarity. This is achieved by the Smith-Waterman algorithm

20 How do we find the best Local alignment? Smith-Waterman or dynnamic local alignment algorithm I P E D I L G E I Just as before local alignments are most simply represented in a m x n matrix I P E E I L G K I Again the diagonal represents the alignments without insertions or deletions in either sequence. The horizontal and vertical represents insertions or deletions in one of the two sequences. The combination of these movements within the matrix therefore represent all possible alignments The local alignments may start anywhere within the matrix and need not cover the entire diagonal

21 Again Additional Scoring Parameters Gapped Or Ungapped: allow gaps deletion/insertion into the alignment Y R - V L D N M V I Y R V L D V I Y R Y V L D - - V I Gap Penalty: what penalty score is associated with introducing a gap V L D N T I V L D I V L D - V I L M D T S L D L M T S D L M S T S F D Gap extension Penalty: if a gap is extended what score is paid Y R K V L D K N M T I P Y + V L D I P Y K Y V Y S V L D D - - V I P

22 Calculating the score for any given Local alignment The Dynamic Local alignment Algorithm Y R K V L D K N M I P V P I L G R I Just as before number of choices need to be made at the start Gapped or ungapped? Gapped What gap penalty do we set if any? 8 What gap extention penalty if any? 0 What Matrix is to be used for scoring? Blosum45 I P V P I L G R I Y 0 R 0 K 0 V 0 L 0 D 0 K 0 N 0 M 0 Step 1 1. Fill in the initial gap penalties although the gap penalty is 8 any negative value is substituted for 0

23 Calculating the score for any given LOCAL alignment The Dynamic Local alignment Algorithm Add score for match row i,col j ) to upper left diagonal (row i-1, col j-1 ) Step 2. filling in each cell 3. Or Add cost of gap (-8) to score in cell above (row i-1, col j ) 2. I P Y R 0 I P Y R 0 2. Or Add cost of gap (-8) to score in cell to the left (row i, col j-1 ) 4. Enter score for (row i, col j ) as the largest of these values, unless max < 0 if so enter 0 noting which this cell the value came from 3. I P Y R 0 4. Note direction from which Max comes I P Y 0 0 R 0

24 Calculating the score for any given LOCAL alignment The Dynamic Local alignment Algorithm 3 Step 3. Fill out remaining scores noting source of max I P V P I L G R I Y R K V L D K N M Step 4. Trace the back the path from the highest scoring cells and extract the alignment(s) from the path(s) I LG R V LDK

25 Blast and FastA tools Two sequence comparison search tools are commonly used to compare sequences within sequence databases Blast and FastA The basic algorithms used are the similar, however, each uses initial filter to approximate the results to a full Smith-Waterman search algorithm (something refered to as heuristics) Word size: no of minimum identical matches required Window size: maximum no of insertions or deletions allowed within a given spacing There are many other pairwise sequence comparison tools such as PSI-blast and DIALIGN and versions of these

26 Expectation / Probability Two measures are often used to gauge the importance of a given alignment A P-value or the probability representing the likelihood of obtaining the given alignment by chance. So that a P(n) of means that you would expect a similar alignment to be found for every 10,000 sequences searched i.e. the probability is 1 in 10,000. An E-value, this represents the number of similar alignments you would expect to retrieve in the database with the same alignment purely by chance. Sometimes a normalised E-value is given E() this is essentially an expected normsalised for the size of the data base and is the same number as the probability.

27 Expectation / Probability The P-value is calculated from the score using appropriate probability density function of the frequency of scores obtained from alignments of randomised sequence. The E-value is related to the size of the database searched and is calculated as Pxno of Database entries Blast Score 310, P=1x10-8, E= Blast Score = 31, p= 0.003, E= 2400

28 Multiple Sequence Alignment Evolution gene divergence & duplication Over an evolutionary timescale organisms diverge and as the evolutionary distance increases then the sequence of any given protein drifts subject to evolutionary pressure for either change or conservation of given residues. The conservation of sequence is critical only in certain regions such as functional domains, domains required for the structural integrity of the protein or for binding of ligands. Sometimes as divergence occurs some genes may be duplicated and whilst the maintenance of one copy is functionally necessary the second is not and this duplicated gene may also diverge where it is evolutionarily advantageous and eventually acquire a different but related function. The similarity between such homologous genes is often sufficient to be able to detect such a relationship by sequence comparison. Such similarities are detected not by paired comparison of sequences but multiple sequence alignments using tools such as CLUSTALW

29 How do we identify sequence conservation within families Identification of the conserved regions within a family of proteins is derived from multiple sequence comparisons from putative family members By adding more and more sequences to an alignment its possible to identify which of the conserved residue are critical to function

30 Evolutionary relationship between sequences results in conservation within families A useful way of displaying information about how related sequences are is as a cladogram or phylogram. This is basically a branch system connecting related data. In the phylogram, the length of the branch indicates relatedness within a phylum ie reflecting the evolutionary change. A cladogram shows the relationship within the clade reflecting the common ancestry but not as a measure of evolutionary time. In either case the shorter the distance to a common branch the more closely related the sequences.

31 Summary Points 1. Comparison of two sequences is most simply carried out by bringing the two sequences into register such that the maximum number of identical pairs may be counted, effectively scoring by identity Why are identity matrices not used for alignments of proteins? 2. The presence of indels in one or both of sequences make it is necessary to introduce of gaps, however, in order to obtain contiguous pairing in the alignment it is necessary to incorporate penalty scores for introducing and extending GAPs forcing matched pairs to be grouped together 3. More distant evolutionary relationships require a scoring system which account for similarity and not just identity, such scoring matrices include BLOSUM and PAM Why is conservation likely to be observed in the functional domains of related proteins such as orthologues and conversely why might we expect to see more differences in regions that don t contribute to function but do play a role in the protein scaffold What is the basis of BLOSUM and PAM matrices

32 Summary Points 4. Comparisons can illustrate different properties in the relationship between two Sequences which may be represented across the entire sequences requiring global comparisons using the Needleman-Wunsch algorithm or relationships which may be limited to localised regions such as functional domains requiring analysis using Smith-Watermann algorithm Global alignment might be good at highlighting small differences between to sequences or identifying introns when comparing genomic and mrna sequences but why might it be poor at aligning two distantly related or partially overlapping sequences 5. Sequence comparison with the contents of a database is effectively multiple pairwise comparisons however, in order to make the search sufficiently rapid, whilst remaining sensitive the search tools (BLAST & FASTA) pre-filter the possible alignments seeding the start of the alignments to regions with a given amount of identity 6. An alignment of two sequences is not proof of a relationship and statistical values are used to indicate a level of confidence attached to the alignment. These are given as Log likelihood Scores, probability (P) and expected frequency (E) values What are P and E-values and how are they calculated

33 Summary Points 7. The sequence of any given gene drifts subject to evolutionary pressure for either change or conservation of given residues. The conservation of sequence is critical only in certain regions. What critical regions of a protein might be conserved and why? 8. ClustalW is a program used to produce multiple sequence alignments and JalView is a specialised program for view the output from such alignments To what end might you use multiple sequence alignment 9. There are several ways to visualise the results of an alignment one very useful way of summarising the information is a branch system connecting related sequences such as a cladogram or phylogram. 10. In the phylogram, the length of the branch indicates relatedness within a phylum ie reflecting the evolutionary change between sequences 11. A cladogram shows the relationship within the clade refecting the common ancestry. In either case the shorter the branch the more closely related the sequences.

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

Sequence Alignments. Dynamic programming approaches, scoring, and significance. Lucy Skrabanek ICB, WMC January 31, 2013 Sequence Alignments Dynamic programming approaches, scoring, and significance Lucy Skrabanek ICB, WMC January 31, 213 Sequence alignment Compare two (or more) sequences to: Find regions of conservation

More information

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

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment Algorithms in Bioinformatics FOUR Sami Khuri Department of Computer Science San José State University Pairwise Sequence Alignment Homology Similarity Global string alignment Local string alignment Dot

More information

CSE 549: Computational Biology. Substitution Matrices

CSE 549: Computational Biology. Substitution Matrices CSE 9: Computational Biology Substitution Matrices How should we score alignments So far, we ve looked at arbitrary schemes for scoring mutations. How can we assign scores in a more meaningful way? Are

More information

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

SEQUENCE ALIGNMENT BACKGROUND: BIOINFORMATICS. Prokaryotes and Eukaryotes. DNA and RNA SEQUENCE ALIGNMENT BACKGROUND: BIOINFORMATICS 1 Prokaryotes and Eukaryotes 2 DNA and RNA 3 4 Double helix structure Codons Codons are triplets of bases from the RNA sequence. Each triplet defines an amino-acid.

More information

Sequence analysis and comparison

Sequence analysis and comparison The aim with sequence identification: Sequence analysis and comparison Marjolein Thunnissen Lund September 2012 Is there any known protein sequence that is homologous to mine? Are there any other species

More information

Proteins: Characteristics and Properties of Amino Acids

Proteins: Characteristics and Properties of Amino Acids SBI4U:Biochemistry Macromolecules Eachaminoacidhasatleastoneamineandoneacidfunctionalgroupasthe nameimplies.thedifferentpropertiesresultfromvariationsinthestructuresof differentrgroups.thergroupisoftenreferredtoastheaminoacidsidechain.

More information

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

Sara C. Madeira. Universidade da Beira Interior. (Thanks to Ana Teresa Freitas, IST for useful resources on this subject) Bioinformática Sequence Alignment Pairwise Sequence Alignment Universidade da Beira Interior (Thanks to Ana Teresa Freitas, IST for useful resources on this subject) 1 16/3/29 & 23/3/29 27/4/29 Outline

More information

CONCEPT OF SEQUENCE COMPARISON. Natapol Pornputtapong 18 January 2018

CONCEPT OF SEQUENCE COMPARISON. Natapol Pornputtapong 18 January 2018 CONCEPT OF SEQUENCE COMPARISON Natapol Pornputtapong 18 January 2018 SEQUENCE ANALYSIS - A ROSETTA STONE OF LIFE Sequence analysis is the process of subjecting a DNA, RNA or peptide sequence to any of

More information

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

THEORY. Based on sequence Length According to the length of sequence being compared it is of following two types Exp 11- THEORY Sequence Alignment is a process of aligning two sequences to achieve maximum levels of identity between them. This help to derive functional, structural and evolutionary relationships between

More information

Chapter 5. Proteomics and the analysis of protein sequence Ⅱ

Chapter 5. Proteomics and the analysis of protein sequence Ⅱ Proteomics Chapter 5. Proteomics and the analysis of protein sequence Ⅱ 1 Pairwise similarity searching (1) Figure 5.5: manual alignment One of the amino acids in the top sequence has no equivalent and

More information

Biochemistry 324 Bioinformatics. Pairwise sequence alignment

Biochemistry 324 Bioinformatics. Pairwise sequence alignment Biochemistry 324 Bioinformatics Pairwise sequence alignment How do we compare genes/proteins? When we have sequenced a genome, we try and identify the function of unknown genes by finding a similar gene

More information

3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT

3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT 3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT.03.239 25.09.2012 SEQUENCE ANALYSIS IS IMPORTANT FOR... Prediction of function Gene finding the process of identifying the regions of genomic DNA that encode

More information

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

Sequence Alignment: A General Overview. COMP Fall 2010 Luay Nakhleh, Rice University Sequence Alignment: A General Overview COMP 571 - Fall 2010 Luay Nakhleh, Rice University Life through Evolution All living organisms are related to each other through evolution This means: any pair of

More information

Algorithms in Bioinformatics

Algorithms in Bioinformatics Algorithms in Bioinformatics Sami Khuri Department of omputer Science San José State University San José, alifornia, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri Pairwise Sequence Alignment Homology

More information

Pairwise & Multiple sequence alignments

Pairwise & Multiple sequence alignments Pairwise & Multiple sequence alignments Urmila Kulkarni-Kale Bioinformatics Centre 411 007 urmila@bioinfo.ernet.in Basis for Sequence comparison Theory of evolution: gene sequences have evolved/derived

More information

Computational Biology

Computational Biology Computational Biology Lecture 6 31 October 2004 1 Overview Scoring matrices (Thanks to Shannon McWeeney) BLAST algorithm Start sequence alignment 2 1 What is a homologous sequence? A homologous sequence,

More information

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

Administration. ndrew Torda April /04/2008 [ 1 ] ndrew Torda April 2008 Administration 22/04/2008 [ 1 ] Sprache? zu verhandeln (Englisch, Hochdeutsch, Bayerisch) Selection of topics Proteins / DNA / RNA Two halves to course week 1-7 Prof Torda (larger

More information

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

8 Grundlagen der Bioinformatik, SS 09, D. Huson, April 28, 2009 8 Grundlagen der Bioinformatik, SS 09, D. Huson, April 28, 2009 2 Pairwise alignment We will discuss: 1. Strings 2. Dot matrix method for comparing sequences 3. Edit distance and alignment 4. The number

More information

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

8 Grundlagen der Bioinformatik, SoSe 11, D. Huson, April 18, 2011 8 Grundlagen der Bioinformatik, SoSe 11, D. Huson, April 18, 2011 2 Pairwise alignment We will discuss: 1. Strings 2. Dot matrix method for comparing sequences 3. Edit distance and alignment 4. The number

More information

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

CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I) CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I) Contents Alignment algorithms Needleman-Wunsch (global alignment) Smith-Waterman (local alignment) Heuristic algorithms FASTA BLAST

More information

Sequence comparison: Score matrices

Sequence comparison: Score matrices Sequence comparison: Score matrices http://facultywashingtonedu/jht/gs559_2013/ Genome 559: Introduction to Statistical and omputational Genomics Prof James H Thomas FYI - informal inductive proof of best

More information

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

Sequence comparison: Score matrices. Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas Sequence comparison: Score matrices Genome 559: Introduction to Statistical and omputational Genomics Prof James H Thomas Informal inductive proof of best alignment path onsider the last step in the best

More information

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

Sequence comparison: Score matrices. Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas Sequence comparison: Score matrices Genome 559: Introduction to Statistical and omputational Genomics Prof James H Thomas FYI - informal inductive proof of best alignment path onsider the last step in

More information

Single alignment: Substitution Matrix. 16 march 2017

Single alignment: Substitution Matrix. 16 march 2017 Single alignment: Substitution Matrix 16 march 2017 BLOSUM Matrix BLOSUM Matrix [2] (Blocks Amino Acid Substitution Matrices ) It is based on the amino acids substitutions observed in ~2000 conserved block

More information

Bioinformatics. Scoring Matrices. David Gilbert Bioinformatics Research Centre

Bioinformatics. Scoring Matrices. David Gilbert Bioinformatics Research Centre Bioinformatics Scoring Matrices David Gilbert Bioinformatics Research Centre www.brc.dcs.gla.ac.uk Department of Computing Science, University of Glasgow Learning Objectives To explain the requirement

More information

Translation. A ribosome, mrna, and trna.

Translation. A ribosome, mrna, and trna. Translation The basic processes of translation are conserved among prokaryotes and eukaryotes. Prokaryotic Translation A ribosome, mrna, and trna. In the initiation of translation in prokaryotes, the Shine-Dalgarno

More information

Practical considerations of working with sequencing data

Practical considerations of working with sequencing data Practical considerations of working with sequencing data File Types Fastq ->aligner -> reference(genome) coordinates Coordinate files SAM/BAM most complete, contains all of the info in fastq and more!

More information

Sequence analysis and Genomics

Sequence analysis and Genomics Sequence analysis and Genomics October 12 th November 23 rd 2 PM 5 PM Prof. Peter Stadler Dr. Katja Nowick Katja: group leader TFome and Transcriptome Evolution Bioinformatics group Paul-Flechsig-Institute

More information

Protein structure. Protein structure. Amino acid residue. Cell communication channel. Bioinformatics Methods

Protein structure. Protein structure. Amino acid residue. Cell communication channel. Bioinformatics Methods Cell communication channel Bioinformatics Methods Iosif Vaisman Email: ivaisman@gmu.edu SEQUENCE STRUCTURE DNA Sequence Protein Sequence Protein Structure Protein structure ATGAAATTTGGAAACTTCCTTCTCACTTATCAGCCACCT...

More information

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

Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM) Bioinformatics II Probability and Statistics Universität Zürich and ETH Zürich Spring Semester 2009 Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM) Dr Fraser Daly adapted from

More information

Quantifying sequence similarity

Quantifying sequence similarity Quantifying sequence similarity Bas E. Dutilh Systems Biology: Bioinformatic Data Analysis Utrecht University, February 16 th 2016 After this lecture, you can define homology, similarity, and identity

More information

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

First generation sequencing and pairwise alignment (High-tech, not high throughput) Analysis of Biological Sequences First generation sequencing and pairwise alignment (High-tech, not high throughput) Analysis of Biological Sequences 140.638 where do sequences come from? DNA is not hard to extract (getting DNA from a

More information

Tools and Algorithms in Bioinformatics

Tools and Algorithms in Bioinformatics Tools and Algorithms in Bioinformatics GCBA815, Fall 2013 Week3: Blast Algorithm, theory and practice Babu Guda, Ph.D. Department of Genetics, Cell Biology & Anatomy Bioinformatics and Systems Biology

More information

Bioinformatics and BLAST

Bioinformatics and BLAST Bioinformatics and BLAST Overview Recap of last time Similarity discussion Algorithms: Needleman-Wunsch Smith-Waterman BLAST Implementation issues and current research Recap from Last Time Genome consists

More information

Week 10: Homology Modelling (II) - HHpred

Week 10: Homology Modelling (II) - HHpred Week 10: Homology Modelling (II) - HHpred Course: Tools for Structural Biology Fabian Glaser BKU - Technion 1 2 Identify and align related structures by sequence methods is not an easy task All comparative

More information

Viewing and Analyzing Proteins, Ligands and their Complexes 2

Viewing and Analyzing Proteins, Ligands and their Complexes 2 2 Viewing and Analyzing Proteins, Ligands and their Complexes 2 Overview Viewing the accessible surface Analyzing the properties of proteins containing thousands of atoms is best accomplished by representing

More information

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

Module: Sequence Alignment Theory and Applications Session: Introduction to Searching and Sequence Alignment Module: Sequence Alignment Theory and Applications Session: Introduction to Searching and Sequence Alignment Introduction to Bioinformatics online course : IBT Jonathan Kayondo Learning Objectives Understand

More information

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

Massachusetts Institute of Technology Computational Evolutionary Biology, Fall, 2005 Notes for November 7: Molecular evolution Massachusetts Institute of Technology 6.877 Computational Evolutionary Biology, Fall, 2005 Notes for November 7: Molecular evolution 1. Rates of amino acid replacement The initial motivation for the neutral

More information

Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment

Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment Substitution score matrices, PAM, BLOSUM Needleman-Wunsch algorithm (Global) Smith-Waterman algorithm (Local) BLAST (local, heuristic) E-value

More information

Exam III. Please read through each question carefully, and make sure you provide all of the requested information.

Exam III. Please read through each question carefully, and make sure you provide all of the requested information. 09-107 onors Chemistry ame Exam III Please read through each question carefully, and make sure you provide all of the requested information. 1. A series of octahedral metal compounds are made from 1 mol

More information

Pairwise Sequence Alignment

Pairwise Sequence Alignment Introduction to Bioinformatics Pairwise Sequence Alignment Prof. Dr. Nizamettin AYDIN naydin@yildiz.edu.tr Outline Introduction to sequence alignment pair wise sequence alignment The Dot Matrix Scoring

More information

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

Pairwise Alignment. Guan-Shieng Huang. Dept. of CSIE, NCNU. Pairwise Alignment p.1/55 Pairwise Alignment Guan-Shieng Huang shieng@ncnu.edu.tw Dept. of CSIE, NCNU Pairwise Alignment p.1/55 Approach 1. Problem definition 2. Computational method (algorithms) 3. Complexity and performance Pairwise

More information

Pairwise sequence alignment

Pairwise sequence alignment Department of Evolutionary Biology Example Alignment between very similar human alpha- and beta globins: GSAQVKGHGKKVADALTNAVAHVDDMPNALSALSDLHAHKL G+ +VK+HGKKV A+++++AH+D++ +++++LS+LH KL GNPKVKAHGKKVLGAFSDGLAHLDNLKGTFATLSELHCDKL

More information

Introduction to Comparative Protein Modeling. Chapter 4 Part I

Introduction to Comparative Protein Modeling. Chapter 4 Part I Introduction to Comparative Protein Modeling Chapter 4 Part I 1 Information on Proteins Each modeling study depends on the quality of the known experimental data. Basis of the model Search in the literature

More information

Collected Works of Charles Dickens

Collected Works of Charles Dickens Collected Works of Charles Dickens A Random Dickens Quote If there were no bad people, there would be no good lawyers. Original Sentence It was a dark and stormy night; the night was dark except at sunny

More information

Alignment & BLAST. By: Hadi Mozafari KUMS

Alignment & BLAST. By: Hadi Mozafari KUMS Alignment & BLAST By: Hadi Mozafari KUMS SIMILARITY - ALIGNMENT Comparison of primary DNA or protein sequences to other primary or secondary sequences Expecting that the function of the similar sequence

More information

Large-Scale Genomic Surveys

Large-Scale Genomic Surveys Bioinformatics Subtopics Fold Recognition Secondary Structure Prediction Docking & Drug Design Protein Geometry Protein Flexibility Homology Modeling Sequence Alignment Structure Classification Gene Prediction

More information

Using Higher Calculus to Study Biologically Important Molecules Julie C. Mitchell

Using Higher Calculus to Study Biologically Important Molecules Julie C. Mitchell Using Higher Calculus to Study Biologically Important Molecules Julie C. Mitchell Mathematics and Biochemistry University of Wisconsin - Madison 0 There Are Many Kinds Of Proteins The word protein comes

More information

Introduction to Bioinformatics

Introduction to Bioinformatics Introduction to Bioinformatics Jianlin Cheng, PhD Department of Computer Science Informatics Institute 2011 Topics Introduction Biological Sequence Alignment and Database Search Analysis of gene expression

More information

M.O. Dayhoff, R.M. Schwartz, and B. C, Orcutt

M.O. Dayhoff, R.M. Schwartz, and B. C, Orcutt A Model of volutionary Change in Proteins M.O. Dayhoff, R.M. Schwartz, and B. C, Orcutt n the eight years since we last examined the amino acid exchanges seen in closely related proteins,' the information

More information

An Introduction to Sequence Similarity ( Homology ) Searching

An Introduction to Sequence Similarity ( Homology ) Searching An Introduction to Sequence Similarity ( Homology ) Searching Gary D. Stormo 1 UNIT 3.1 1 Washington University, School of Medicine, St. Louis, Missouri ABSTRACT Homologous sequences usually have the same,

More information

Pairwise sequence alignments. Vassilios Ioannidis (From Volker Flegel )

Pairwise sequence alignments. Vassilios Ioannidis (From Volker Flegel ) Pairwise sequence alignments Vassilios Ioannidis (From Volker Flegel ) Outline Introduction Definitions Biological context of pairwise alignments Computing of pairwise alignments Some programs Importance

More information

Lecture 15: Realities of Genome Assembly Protein Sequencing

Lecture 15: Realities of Genome Assembly Protein Sequencing Lecture 15: Realities of Genome Assembly Protein Sequencing Study Chapter 8.10-8.15 1 Euler s Theorems A graph is balanced if for every vertex the number of incoming edges equals to the number of outgoing

More information

Properties of amino acids in proteins

Properties of amino acids in proteins Properties of amino acids in proteins one of the primary roles of DNA (but not the only one!) is to code for proteins A typical bacterium builds thousands types of proteins, all from ~20 amino acids repeated

More information

Structure and evolution of the spliceosomal peptidyl-prolyl cistrans isomerase Cwc27

Structure and evolution of the spliceosomal peptidyl-prolyl cistrans isomerase Cwc27 Acta Cryst. (2014). D70, doi:10.1107/s1399004714021695 Supporting information Volume 70 (2014) Supporting information for article: Structure and evolution of the spliceosomal peptidyl-prolyl cistrans isomerase

More information

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

Sequence Analysis 17: lecture 5. Substitution matrices Multiple sequence alignment Sequence Analysis 17: lecture 5 Substitution matrices Multiple sequence alignment Substitution matrices Used to score aligned positions, usually of amino acids. Expressed as the log-likelihood ratio of

More information

In-Depth Assessment of Local Sequence Alignment

In-Depth Assessment of Local Sequence Alignment 2012 International Conference on Environment Science and Engieering IPCBEE vol.3 2(2012) (2012)IACSIT Press, Singapoore In-Depth Assessment of Local Sequence Alignment Atoosa Ghahremani and Mahmood A.

More information

Other Methods for Generating Ions 1. MALDI matrix assisted laser desorption ionization MS 2. Spray ionization techniques 3. Fast atom bombardment 4.

Other Methods for Generating Ions 1. MALDI matrix assisted laser desorption ionization MS 2. Spray ionization techniques 3. Fast atom bombardment 4. Other Methods for Generating Ions 1. MALDI matrix assisted laser desorption ionization MS 2. Spray ionization techniques 3. Fast atom bombardment 4. Field Desorption 5. MS MS techniques Matrix assisted

More information

Tools and Algorithms in Bioinformatics

Tools and Algorithms in Bioinformatics Tools and Algorithms in Bioinformatics GCBA815, Fall 2015 Week-4 BLAST Algorithm Continued Multiple Sequence Alignment Babu Guda, Ph.D. Department of Genetics, Cell Biology & Anatomy Bioinformatics and

More information

Sequence Analysis and Databases 2: Sequences and Multiple Alignments

Sequence Analysis and Databases 2: Sequences and Multiple Alignments 1 Sequence Analysis and Databases 2: Sequences and Multiple Alignments Jose María González-Izarzugaza Martínez CNIO Spanish National Cancer Research Centre (jmgonzalez@cnio.es) 2 Sequence Comparisons:

More information

5. MULTIPLE SEQUENCE ALIGNMENT BIOINFORMATICS COURSE MTAT

5. MULTIPLE SEQUENCE ALIGNMENT BIOINFORMATICS COURSE MTAT 5. MULTIPLE SEQUENCE ALIGNMENT BIOINFORMATICS COURSE MTAT.03.239 03.10.2012 ALIGNMENT Alignment is the task of locating equivalent regions of two or more sequences to maximize their similarity. Homology:

More information

Finding the Best Biological Pairwise Alignment Through Genetic Algorithm Determinando o Melhor Alinhamento Biológico Através do Algoritmo Genético

Finding the Best Biological Pairwise Alignment Through Genetic Algorithm Determinando o Melhor Alinhamento Biológico Através do Algoritmo Genético Finding the Best Biological Pairwise Alignment Through Genetic Algorithm Determinando o Melhor Alinhamento Biológico Através do Algoritmo Genético Paulo Mologni 1, Ailton Akira Shinoda 2, Carlos Dias Maciel

More information

PROTEIN SECONDARY STRUCTURE PREDICTION: AN APPLICATION OF CHOU-FASMAN ALGORITHM IN A HYPOTHETICAL PROTEIN OF SARS VIRUS

PROTEIN SECONDARY STRUCTURE PREDICTION: AN APPLICATION OF CHOU-FASMAN ALGORITHM IN A HYPOTHETICAL PROTEIN OF SARS VIRUS Int. J. LifeSc. Bt & Pharm. Res. 2012 Kaladhar, 2012 Research Paper ISSN 2250-3137 www.ijlbpr.com Vol.1, Issue. 1, January 2012 2012 IJLBPR. All Rights Reserved PROTEIN SECONDARY STRUCTURE PREDICTION:

More information

Scoring Matrices. Shifra Ben-Dor Irit Orr

Scoring Matrices. Shifra Ben-Dor Irit Orr Scoring Matrices Shifra Ben-Dor Irit Orr Scoring matrices Sequence alignment and database searching programs compare sequences to each other as a series of characters. All algorithms (programs) for comparison

More information

Sequence Based Bioinformatics

Sequence Based Bioinformatics Structural and Functional Analysis of Inosine Monophosphate Dehydrogenase using Sequence-Based Bioinformatics Barry Sexton 1,2 and Troy Wymore 3 1 Bioengineering and Bioinformatics Summer Institute, Department

More information

Copyright 2000 N. AYDIN. All rights reserved. 1

Copyright 2000 N. AYDIN. All rights reserved. 1 Introduction to Bioinformatics Prof. Dr. Nizamettin AYDIN naydin@yildiz.edu.tr Multiple Sequence Alignment Outline Multiple sequence alignment introduction to msa methods of msa progressive global alignment

More information

Solutions In each case, the chirality center has the R configuration

Solutions In each case, the chirality center has the R configuration CAPTER 25 669 Solutions 25.1. In each case, the chirality center has the R configuration. C C 2 2 C 3 C(C 3 ) 2 D-Alanine D-Valine 25.2. 2 2 S 2 d) 2 25.3. Pro,, Trp, Tyr, and is, Trp, Tyr, and is Arg,

More information

Motivating the need for optimal sequence alignments...

Motivating the need for optimal sequence alignments... 1 Motivating the need for optimal sequence alignments... 2 3 Note that this actually combines two objectives of optimal sequence alignments: (i) use the score of the alignment o infer homology; (ii) use

More information

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

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

More information

Bioinformatics for Biologists

Bioinformatics for Biologists Bioinformatics for Biologists Sequence Analysis: Part I. Pairwise alignment and database searching Fran Lewitter, Ph.D. Head, Biocomputing Whitehead Institute Bioinformatics Definitions The use of computational

More information

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

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 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 Introduction to bioinformatics 2007 Lecture 5 Pair-wise Sequence Alignment Bioinformatics Nothing in Biology makes sense except in

More information

Pairwise sequence alignments

Pairwise sequence alignments Pairwise sequence alignments Volker Flegel VI, October 2003 Page 1 Outline Introduction Definitions Biological context of pairwise alignments Computing of pairwise alignments Some programs VI, October

More information

Global alignments - review

Global alignments - review Global alignments - review Take two sequences: X[j] and Y[j] M[i-1, j-1] ± 1 M[i, j] = max M[i, j-1] 2 M[i-1, j] 2 The best alignment for X[1 i] and Y[1 j] is called M[i, j] X[j] Initiation: M[,]= pply

More information

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

Sequence Alignment: Scoring Schemes. COMP 571 Luay Nakhleh, Rice University Sequence Alignment: Scoring Schemes COMP 571 Luay Nakhleh, Rice University Scoring Schemes Recall that an alignment score is aimed at providing a scale to measure the degree of similarity (or difference)

More information

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

Bioinformatics for Computer Scientists (Part 2 Sequence Alignment) Sepp Hochreiter Bioinformatics for Computer Scientists (Part 2 Sequence Alignment) Institute of Bioinformatics Johannes Kepler University, Linz, Austria Sequence Alignment 2. Sequence Alignment Sequence Alignment 2.1

More information

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

InDel 3-5. InDel 8-9. InDel 3-5. InDel 8-9. InDel InDel 8-9 Lecture 5 Alignment I. Introduction. For sequence data, the process of generating an alignment establishes positional homologies; that is, alignment provides the identification of homologous phylogenetic

More information

Alignment principles and homology searching using (PSI-)BLAST. Jaap Heringa Centre for Integrative Bioinformatics VU (IBIVU)

Alignment principles and homology searching using (PSI-)BLAST. Jaap Heringa Centre for Integrative Bioinformatics VU (IBIVU) Alignment principles and homology searching using (PSI-)BLAST Jaap Heringa Centre for Integrative Bioinformatics VU (IBIVU) http://ibivu.cs.vu.nl Bioinformatics Nothing in Biology makes sense except in

More information

Sequences, Structures, and Gene Regulatory Networks

Sequences, Structures, and Gene Regulatory Networks Sequences, Structures, and Gene Regulatory Networks Learning Outcomes After this class, you will Understand gene expression and protein structure in more detail Appreciate why biologists like to align

More information

Ramachandran Plot. 4ysz Phi (degrees) Plot statistics

Ramachandran Plot. 4ysz Phi (degrees) Plot statistics B Ramachandran Plot ~b b 135 b ~b ~l l Psi (degrees) 5-5 a A ~a L - -135 SER HIS (F) 59 (G) SER (B) ~b b LYS ASP ASP 315 13 13 (A) (F) (B) LYS ALA ALA 315 173 (E) 173 (E)(A) ~p p ~b - -135 - -5 5 135 (degrees)

More information

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

20 Grundlagen der Bioinformatik, SS 08, D. Huson, May 27, Global and local alignment of two sequences using dynamic programming 20 Grundlagen der Bioinformatik, SS 08, D. Huson, May 27, 2008 4 Pairwise alignment We will discuss: 1. Strings 2. Dot matrix method for comparing sequences 3. Edit distance 4. Global and local alignment

More information

Homology Modeling. Roberto Lins EPFL - summer semester 2005

Homology Modeling. Roberto Lins EPFL - summer semester 2005 Homology Modeling Roberto Lins EPFL - summer semester 2005 Disclaimer: course material is mainly taken from: P.E. Bourne & H Weissig, Structural Bioinformatics; C.A. Orengo, D.T. Jones & J.M. Thornton,

More information

Sequence Alignment Techniques and Their Uses

Sequence Alignment Techniques and Their Uses Sequence Alignment Techniques and Their Uses Sarah Fiorentino Since rapid sequencing technology and whole genomes sequencing, the amount of sequence information has grown exponentially. With all of this

More information

Clustering and Model Integration under the Wasserstein Metric. Jia Li Department of Statistics Penn State University

Clustering and Model Integration under the Wasserstein Metric. Jia Li Department of Statistics Penn State University Clustering and Model Integration under the Wasserstein Metric Jia Li Department of Statistics Penn State University Clustering Data represented by vectors or pairwise distances. Methods Top- down approaches

More information

Comparing whole genomes

Comparing whole genomes BioNumerics Tutorial: Comparing whole genomes 1 Aim The Chromosome Comparison window in BioNumerics has been designed for large-scale comparison of sequences of unlimited length. In this tutorial you will

More information

Physiochemical Properties of Residues

Physiochemical Properties of Residues Physiochemical Properties of Residues Various Sources C N Cα R Slide 1 Conformational Propensities Conformational Propensity is the frequency in which a residue adopts a given conformation (in a polypeptide)

More information

Chemistry Chapter 22

Chemistry Chapter 22 hemistry 2100 hapter 22 Proteins Proteins serve many functions, including the following. 1. Structure: ollagen and keratin are the chief constituents of skin, bone, hair, and nails. 2. atalysts: Virtually

More information

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

Protein Bioinformatics. Rickard Sandberg Dept. of Cell and Molecular Biology Karolinska Institutet sandberg.cmb.ki. Protein Bioinformatics Rickard Sandberg Dept. of Cell and Molecular Biology Karolinska Institutet rickard.sandberg@ki.se sandberg.cmb.ki.se Outline Protein features motifs patterns profiles signals 2 Protein

More information

Supplemental Materials for. Structural Diversity of Protein Segments Follows a Power-law Distribution

Supplemental Materials for. Structural Diversity of Protein Segments Follows a Power-law Distribution Supplemental Materials for Structural Diversity of Protein Segments Follows a Power-law Distribution Yoshito SAWADA and Shinya HONDA* National Institute of Advanced Industrial Science and Technology (AIST),

More information

Introduction to Computational Modelling and Functional Analysis of Proteins

Introduction to Computational Modelling and Functional Analysis of Proteins Introduction to Computational Modelling and Functional Analysis of Proteins AG Prof. Dr. Monika Fritz Pure and Applied Biomineralisation Institute for Biophysics AG Prof. Dr. Manfred Radmacher Institute

More information

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

... and searches for related sequences probably make up the vast bulk of bioinformatics activities. 1 2 ... and searches for related sequences probably make up the vast bulk of bioinformatics activities. 3 The terms homology and similarity are often confused and used incorrectly. Homology is a quality.

More information

Protein Fragment Search Program ver Overview: Contents:

Protein Fragment Search Program ver Overview: Contents: Protein Fragment Search Program ver 1.1.1 Developed by: BioPhysics Laboratory, Faculty of Life and Environmental Science, Shimane University 1060 Nishikawatsu-cho, Matsue-shi, Shimane, 690-8504, Japan

More information

Introduction to the Ribosome Overview of protein synthesis on the ribosome Prof. Anders Liljas

Introduction to the Ribosome Overview of protein synthesis on the ribosome Prof. Anders Liljas Introduction to the Ribosome Molecular Biophysics Lund University 1 A B C D E F G H I J Genome Protein aa1 aa2 aa3 aa4 aa5 aa6 aa7 aa10 aa9 aa8 aa11 aa12 aa13 a a 14 How is a polypeptide synthesized? 2

More information

Statistical Distributions of Optimal Global Alignment Scores of Random Protein Sequences

Statistical Distributions of Optimal Global Alignment Scores of Random Protein Sequences BMC Bioinformatics This Provisional PDF corresponds to the article as it appeared upon acceptance. The fully-formatted PDF version will become available shortly after the date of publication, from the

More information

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure Bioch/BIMS 503 Lecture 2 Structure and Function of Proteins August 28, 2008 Robert Nakamoto rkn3c@virginia.edu 2-0279 Secondary Structure Φ Ψ angles determine protein structure Φ Ψ angles are restricted

More information

Supplementary Figure 3 a. Structural comparison between the two determined structures for the IL 23:MA12 complex. The overall RMSD between the two

Supplementary Figure 3 a. Structural comparison between the two determined structures for the IL 23:MA12 complex. The overall RMSD between the two Supplementary Figure 1. Biopanningg and clone enrichment of Alphabody binders against human IL 23. Positive clones in i phage ELISA with optical density (OD) 3 times higher than background are shown for

More information

Bioinformatics Exercises

Bioinformatics Exercises Bioinformatics Exercises AP Biology Teachers Workshop Susan Cates, Ph.D. Evolution of Species Phylogenetic Trees show the relatedness of organisms Common Ancestor (Root of the tree) 1 Rooted vs. Unrooted

More information

Aoife McLysaght Dept. of Genetics Trinity College Dublin

Aoife McLysaght Dept. of Genetics Trinity College Dublin Aoife McLysaght Dept. of Genetics Trinity College Dublin Evolution of genome arrangement Evolution of genome content. Evolution of genome arrangement Gene order changes Inversions, translocations Evolution

More information

What makes a good graphene-binding peptide? Adsorption of amino acids and peptides at aqueous graphene interfaces: Electronic Supplementary

What makes a good graphene-binding peptide? Adsorption of amino acids and peptides at aqueous graphene interfaces: Electronic Supplementary Electronic Supplementary Material (ESI) for Journal of Materials Chemistry B. This journal is The Royal Society of Chemistry 21 What makes a good graphene-binding peptide? Adsorption of amino acids and

More information

Advanced Topics in RNA and DNA. DNA Microarrays Aptamers

Advanced Topics in RNA and DNA. DNA Microarrays Aptamers Quiz 1 Advanced Topics in RNA and DNA DNA Microarrays Aptamers 2 Quantifying mrna levels to asses protein expression 3 The DNA Microarray Experiment 4 Application of DNA Microarrays 5 Some applications

More information

Sequence Analysis, '18 -- lecture 9. Families and superfamilies. Sequence weights. Profiles. Logos. Building a representative model for a gene.

Sequence Analysis, '18 -- lecture 9. Families and superfamilies. Sequence weights. Profiles. Logos. Building a representative model for a gene. Sequence Analysis, '18 -- lecture 9 Families and superfamilies. Sequence weights. Profiles. Logos. Building a representative model for a gene. How can I represent thousands of homolog sequences in a compact

More information