Motif discovery and Phylogenetic trees.

Slides:



Advertisements
Similar presentations
Computing a tree Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas.
Advertisements

Phylogenetic Tree A Phylogeny (Phylogenetic tree) or Evolutionary tree represents the evolutionary relationships among a set of organisms or groups of.
Bioinformatics Phylogenetic analysis and sequence alignment The concept of evolutionary tree Types of phylogenetic trees Measurements of genetic distances.
An Introduction to Phylogenetic Methods
Multiple Sequence Alignment & Phylogenetic Trees.
Computing a tree Genome 559: Introduction to Statistical and Computational Genomics Prof. James H. Thomas.
Regulatory Motifs. Contents Biology of regulatory motifs Experimental discovery Computational discovery PSSM MEME.
1 General Phylogenetics Points that will be covered in this presentation Tree TerminologyTree Terminology General Points About Phylogenetic TreesGeneral.
Phylogenetics - Distance-Based Methods CIS 667 March 11, 2204.
Summer Bioinformatics Workshop 2008 Comparative Genomics and Phylogenetics Chi-Cheng Lin, Ph.D., Professor Department of Computer Science Winona State.
Phylogenetic reconstruction
Phylogenetic trees Sushmita Roy BMI/CS 576 Sep 23 rd, 2014.
Molecular Evolution Revised 29/12/06
Tree Reconstruction.
© Wiley Publishing All Rights Reserved. Phylogeny.
Lecture 7 – Algorithmic Approaches Justification: Any estimate of a phylogenetic tree has a large variance. Therefore, any tree that we can demonstrate.
Sequence Motifs. Motifs Motifs represent a short common sequence –Regulatory motifs (TF binding sites) –Functional site in proteins (DNA binding motif)
Phylogenetic Trees Tutorial 6. Measuring distance Bottom-up algorithm (Neighbor Joining) –Distance based algorithm –Relative distance based Phylogenetic.
Lecture 24 Inferring molecular phylogeny Distance methods
Phylogenetic Trees Tutorial 6. Measuring distance Bottom-up algorithm (Neighbor Joining) –Distance based algorithm –Relative distance based Phylogenetic.
Introduction to Bioinformatics Molecular Phylogeny Lesson 5.
Probabilistic methods for phylogenetic trees (Part 2)
Phylogenetic Analysis. 2 Phylogenetic Analysis Overview Insight into evolutionary relationships Inferring or estimating these evolutionary relationships.
Phylogenetic trees Tutorial 6. Distance based methods UPGMA Neighbor Joining Tools Mega phylogeny.fr DrewTree Phylogenetic Trees.
Phylogenetic trees Sushmita Roy BMI/CS 576
Multiple Sequence Alignments and Phylogeny.  Within a protein sequence, some regions will be more conserved than others. As more conserved,
Phylogenetic analyses Kirsi Kostamo. The aim: To construct a visual representation (a tree) to describe the assumed evolution occurring between and among.
Phylogeny Estimation: Traditional and Bayesian Approaches Molecular Evolution, 2003
Terminology of phylogenetic trees
Molecular evidence for endosymbiosis Perform blastp to investigate sequence similarity among domains of life Found yeast nuclear genes exhibit more sequence.
Phylogenetics Alexei Drummond. CS Friday quiz: How many rooted binary trees having 20 labeled terminal nodes are there? (A) (B)
1 Summary on similarity search or Why do we care about far homologies ? A protein from a new pathogenic bacteria. We have no idea what it does A protein.
Phylogenetic Analysis. General comments on phylogenetics Phylogenetics is the branch of biology that deals with evolutionary relatedness Uses some measure.
Computational Biology, Part D Phylogenetic Trees Ramamoorthi Ravi/Robert F. Murphy Copyright  2000, All rights reserved.
BINF6201/8201 Molecular phylogenetic methods
Phylogenetics and Coalescence Lab 9 October 24, 2012.
Bioinformatics 2011 Molecular Evolution Revised 29/12/06.
OUTLINE Phylogeny UPGMA Neighbor Joining Method Phylogeny Understanding life through time, over long periods of past time, the connections between all.
Phylogenetic Prediction Lecture II by Clarke S. Arnold March 19, 2002.
Phylogenetic Trees  Importance of phylogenetic trees  What is the phylogenetic analysis  Example of cladistics  Assumptions in cladistics  Frequently.
Building phylogenetic trees. Contents Phylogeny Phylogenetic trees How to make a phylogenetic tree from pairwise distances  UPGMA method (+ an example)
Introduction to Phylogenetics
Calculating branch lengths from distances. ABC A B C----- a b c.
Molecular Phylogeny. 2 Phylogeny is the inference of evolutionary relationships. Traditionally, phylogeny relied on the comparison of morphological features.
Phylogenetic Analysis Gabor T. Marth Department of Biology, Boston College BI420 – Introduction to Bioinformatics Figures from Higgs & Attwood.
Phylogeny Ch. 7 & 8.
Phylogenetic trees Sushmita Roy BMI/CS 576 Sep 23 rd, 2014.
Applied Bioinformatics Week 8 Jens Allmer. Theory I.
Local Multiple Sequence Alignment Sequence Motifs
Tutorial 5 Phylogenetic Trees.
Ayesha M.Khan Spring Phylogenetic Basics 2 One central field in biology is to infer the relation between species. Do they possess a common ancestor?
Distance-Based Approaches to Inferring Phylogenetic Trees BMI/CS 576 Colin Dewey Fall 2010.
Distance-based methods for phylogenetic tree reconstruction Colin Dewey BMI/CS 576 Fall 2015.
Phylogenetic trees. 2 Phylogeny is the inference of evolutionary relationships. Traditionally, phylogeny relied on the comparison of morphological features.
Multiple Sequence alignment and Phylogenetic trees.
Introduction to Bioinformatics Resources for DNA Barcoding
Evolutionary genomics can now be applied beyond ‘model’ organisms
Phylogenetic basis of systematics
Inferring a phylogeny is an estimation procedure.
Clustering methods Tree building methods for distance-based trees
Methods of molecular phylogeny
The Tree of Life From Ernst Haeckel, 1891.
Inferring phylogenetic trees: Distance and maximum likelihood methods
Phylogenetic Trees.
Dr Tan Tin Wee Director Bioinformatics Centre
Chapter 19 Molecular Phylogenetics
Lecture 7 – Algorithmic Approaches
Phylogeny.
Unit Genomic sequencing
Presentation transcript:

Motif discovery and Phylogenetic trees

Motif Discovery Challenges How to recognize a known regulatory motif in genome scale? Can we discover new motifs within upstream sequences of genes?

Scenario 1 : Binding motif is known

Building a PSSM for short motifs Collect all known sequences that bind a certain TF. Align all sequences (using multiple sequence alignment). Compute the frequency of each nucleotide in each position (PSPM). Incorporate background frequency for each nucleotide (PSSM).

PROBLEMS… When searching for a motif in a genome using PSSM or other methods – the motif is usually found all over the place ->The motif is considered real if found in the vicinity of a gene. Checking experimentally for the binding sites of a specific TF (location analysis) – the sites that bind the motif are in some cases similar to the PSSM and sometimes not!

Scenario 2 : Binding motif is unknown

Finding new Motifs We are given a group of genes, which presumably contain a common regulatory motif. We know nothing of the TF that binds to the putative motif. The problem: discover the motif.

Motif Discovery Motif Discovery

Computational Methods Methods include: Probabilistic methods – hidden Markov models (HMMs), expectation maximization (EM), Gibbs sampling, etc. Enumeration methods – problematic for inexact motifs of length k>10. … Current status: Problem is still open.

Tools on the Web MEME – Multiple EM for Motif Elicitation. http://meme.sdsc.edu/meme/website/ metaMEME- Uses HMM method http://meme.sdsc.edu/meme MAST-Motif Alignment and Search Tool TRANSFAC - database of eukaryotic cis-acting regulatory DNA elements and trans-acting factors. http://transfac.gbf.de/TRANSFAC/ eMotif - allows to scan, make and search for motifs at the protein level. http://motif.stanford.edu/emotif/

From MSA To Phylogenetic trees

Phylogeny is the inference of evolutionary relationships. Traditionally, phylogeny relied on the comparison of morphological features between organisms. Today, molecular sequence data are mainly used for phylogenetic analyses. One tree of life A sketch Darwin made soon after returning from his voyage on HMS Beagle (1831–36) showed his thinking about the diversification of species from a single stock (see Figure, overleaf). This branching, extended by the concept of common descent,

Haeckel (1879) Pace (2001)

Molecular phylogeny uses trees to depict evolutionary relationships among organisms. These trees are based upon DNA and protein sequence data Human Chimpanzee Gorilla Orangutan Gorilla Chimpanzee Orangutan Human Pre-Molecular analysis: The great apes (chimpanzee, Gorilla & orangutan) Separate from the human Molecular analysis: Chimpanzee is related more closely to human than the gorilla

What can we learn from phylogenetics tree?

1. Determine the closest relatives of one organism in which we are interested Was the extinct quagga more like a zebra or a horse?

Which species are closest to Human? Gorilla Human Chimpanzee Gorilla Orangutan Chimpanzee Orangutan Human

2. Help to find the relationship between the species and identify new species Example Metagenomics A new field in genomics aims the study the genomes recovered from environmental samples. A powerful tool to access the wealthy biodiversity of native environmental samples

106 cells/ ml seawater 107 virus particles/ ml seawater >99% uncultivated microbes

From : “The Sorcerer II Global Ocean Sampling Expedition: Metagenomic Characterization of Viruses within Aquatic Microbial Samples” Williamson et al, PLOS ONE 2008

3. Discover a function of an unknown gene or protein RBP1_HS RBP2_pig Hypothetical protein RBP_RAT ALP_HS ALPEC_BV ALPA1_RAT ECBLC Hypothetical protein X Hypothetical protein

Relationships can be represented by Phylogenetic Tree or Dendrogram F E B D A C

Phylogenetic Tree Terminology Graph composed of nodes & branches Each branch connects two adjacent nodes R F E B D A C

Phylogenetic Tree Terminology Rooted tree Un-rooted tree Human Chicken Gorilla Chimp Gorilla Human Chicken Chimp

Rooted vs. unrooted trees 3 1 2 3 1 2

How can we build a tree with molecular data? -Trees based on DNA sequence (rRNA) -Trees based on Protein sequences atcgatcgtgatcgatcgtagcatcgatgcatcgtacg MWRCPYCGKRQWCMWG

Approach 1 - Distance methods Algorithms : - UPGMA (rooted) , - Neighbor joining (unrooted) Approach 2 - State methods Algorithms: Maximum parsimony (MP) Maximum likelihood (ML)

Basic algorithm for constructing a rooted tree Unweighted Pair Group Method using Arithmetic Averages (UPGMA) Assumption: Divergence of sequences is assumed to occur at a constant rate  Distance to root is equal Sequence a ACGCGTTGGGCGATGGCAAC Sequence b ACGCGTTGGGCGACGGTAAT Sequence c ACGCATTGAATGATGATAAT Sequence d ACACATTGAGTGTGATAATA a b c d

Basic Algorithm UPGMA Sequences Distance Table a b c d 8 7 5 3 9 Sequence a ACGCGTTGGGCGATGGCAAC Sequence b ACACATTGAGTGTGATCAAC Sequence c ACACATTGAGTGAGGACAAC Sequence d ACGCGTTGGGCGACGGTAAT a b c d 8 7 5 3 9 Distances * Dab = 8 Dac = 7 Dad = 5 Dbc = 3 Dbd = 9 Dcd = 8 * Can be calculated using different distance metrics 29

Selection step a d c b a b c d 8 7 5 3 9 8 7 5 3 9 Choose the nodes with the shortest distance and fuse them. 30

a Next Step a b c d 8 7 5 3 9 a d e 5 6 7 d c,b e a Then recalculate the distance between the rest of the remaining sequences (a and d) to the new node (e) and remove the fused nodes from the table. D (EA) = (D(AC)+ D(AB)-D(CB))/2 D (ED) = (D(DC)+ D(DB)-D(CB))/2

In order to get a tree, un-fuse c and b by Next Step a c a d e 5 6 7 Dce e d Dde b In order to get a tree, un-fuse c and b by calculating their distance to the new node (e) !!!The distances Dce and Dde are calculated independently (formula will be given in tirgul)

We want to fuse the next closest nodes 5 6 7 Dce a,d e f Dde b

We need to calculate the distance between e and f Finally We need to calculate the distance between e and f c a f e 4 Daf e Dce f Dbf Dde b d D (EF) = (D(EA)+ D(ED)-D(AD))/2

a d c b f e b c a d

IMPORTANT !!! Neighbor Joining (NJ)- is an algorithm which is Usually we don’t assume a constant mutation rate and in order to choose the nodes to fuse we have to calculate the relative distance of each node to all other nodes . Neighbor Joining (NJ)- is an algorithm which is suitable to cases when the rate of evolution varies

Neighbor Joining (NJ) Reconstructs an unrooted tree Calculates branch lengths Based on pairwise distances In each stage, the two nearest nodes of the tree are chosen and defined as neighbors in our tree. This is done recursively until all of the nodes are paired together.

Advantages and disadvantages of the neighbor-joining method -It is fast and thus suited for large datasets -Permits lineages with largely different branch lengths Disadvantages - Sequence information is reduced - Gives only one possible tree

Problems with phylogenetic trees - Using different regions from a same alignment may produce different trees.

Problems with phylogenetic trees

Problems with phylogenetic trees Bacillus Bacillus Burkholderias Aeromonas Aeromonas Pseudomonas Pseudomonas Burkholderias Lechevaliera Lechevaliera E.coli E.coli Salmonella Salmonella Bacillus Pseudomonas Pseudomonas Aeromonas Burkholderias Burkholderias Aeromonas Bacillus Lechevaliera Lechevaliera E.coli E.coli Salmonella Salmonella

Problems with phylogenetic trees What to do ?

Bootstrapping We create new data sets by sampling N positions with replacement. We generate 100 - 1000 such pseudo-data sets. For each such data set we reconstruct a tree, using the same method. We note the agreement between the tree reconstructed from the pseudo-data set to the original tree. Note: we do not change the number of sequences !

Bootstrapped tree Less reliable Branch Highly reliable branch

Open Questions Do DNA and proteins from the same gene produce different trees ? Can different genes have different evolutionary history ?

Tools for tree reconstruction CLUSTALX (NJ method) Phylip -PHYLogeny Inference Package includes parsimony, distance matrix, and likelihood methods, including bootstrapping. Phyml (maximum likelihood method) MEGA (Molecular Evolution Genomic Analysis) More phylogeny programs

362

http://www.phylogeny.fr