SlideShare uma empresa Scribd logo
1 de 44
Baixar para ler offline
BLS 303: Principles of Computational Biology




    Lecture 1: Molecular Phylogenetics
Topics

•   i. Molecular Evolution
•   ii. Calculating Distances
•   iii. Clustering Algorithms
•   iv. Cladistic Methods
•   v. Computer Software
Evolution
• The theory of evolution is the
  foundation upon which all of
  modern biology is built.
• From anatomy to behavior to genomics, the
  scientific method requires an appreciation of
  changes in organisms over time.
• It is impossible to evaluate relationships among
  gene sequences without taking into consideration
  the way these sequences have been modified over
  time
Relationships
Similarity searches and multiple alignments of
sequences naturally lead to the question:
  “How are these sequences related?”
and more generally:

“How are the organisms from which
these sequences come related?”
Taxonomy
• The study of the relationships between groups of
  organisms is called taxonomy, an ancient and
  venerable branch of classical biology.

• Taxonomy is the art of classifying things into
  groups — a quintessential human behavior —
  established as a mainstream scientific field by
  Carolus Linnaeus (1707-1778).
Phylogenetics
• Evolutionary theory states that groups of similar
  organisms are descended from a common ancestor.
• Phylogenetic systematics (cladistics) is a method
  of taxonomic classification based on their
  evolutionary history.

• It was developed by Willi Hennig,
  a German entomologist, in 1950.
Cladistic Methods
• Evolutionary relationships are documented by
  creating a branching structure, termed a phylogeny
  or tree, that illustrates the relationships between the
  sequences.
• Cladistic methods construct a tree (cladogram) by
  considering the various possible pathways of
  evolution and choose from among these the best
  possible tree.
• A phylogram is a tree with branches that are
  proportional to evolutionary distances.
Molecular Evolution
• Phylogenetics often makes use of numerical data,
  (numerical taxonomy) which can be scores for
  various “character states” such as the size of a
  visible structure or it can be DNA sequences.
• Similarities and differences between organisms can
  be coded as a set of characters, each with two or
  more alternative character states.
• In an alignment of DNA sequences, each position
  is a separate character, with four possible character
  states, the four nucleotides.
DNA is a good tool for taxonomy

DNA sequences have many advantages
over classical types of taxonomic
characters:
– Character states can be scored unambiguously
– Large numbers of characters can be scored for
  each individual
– Information on both the extent and the nature of
  divergence between sequences is available
  (nucleotide substitutions, insertion/deletions, or
  genome rearrangements)
A    aat tcg ctt cta gga atc tgc cta
atc ctg
B    ... ..a ..g ..a .t. ... ... t..
... ..a
C    ... ..a ..c ..c ... ..t ... ...
... t.a
D    ... ..a ..a ..g ..g ..t ... t.t
 Each nucleotide difference is a character
..t t..
Sequences Reflect Relationships

• After working with sequences for a while, one develops an
  intuitive understanding that “for a given gene, closely related
  organisms have similar sequences and more distantly related
  organisms have more dissimilar sequences. These
  differences can be quantified”.

• Given a set of gene sequences, it should be possible to
  reconstruct the evolutionary relationships among genes
  and among organisms.
What Sequences to Study?
• Different sequences accumulate changes at
  different rates - chose level of variation that is
  appropriate to the group of organisms being
  studied.
   – Proteins (or protein coding DNAs) are constrained by
     natural selection - better for very distant relationships
   – Some sequences are highly variable (rRNA spacer
     regions, immunoglobulin genes), while others are
     highly conserved (actin, rRNA coding regions)
   – Different regions within a single gene can evolve at
     different rates (conserved vs. variable domains)
(globin)     Ancestral gene
                             A

                                     Duplication

     (hemoglobin)        A       B          (myoglobin)



                                            Speciation



A1                  B1               A2                   B2

       (mouse)                               (human)
Orthologs vs. Paralogs
• When comparing gene sequences, it is important
  to distinguish between identical vs. merely similar
  genes in different organisms.
• Orthologs are homologous genes in different
  species with analogous functions.
• Paralogs are similar genes that are the result of a
  gene duplication.
   – A phylogeny that includes both orthologs and paralogs
     is likely to be incorrect.
   – Sometimes phylogenetic analysis is the best way to
     determine if a new gene is an ortholog or paralog to
     other known genes.
Terminologies of phylogeny
• Phylogenetic (binary) tree: A tree is a graph composed of
  nodes and branches, in which any two nodes are connected
  by a unique path.

• Nodes: Nodes in phylogenetic trees are called taxonomic
  units (TUs) Usually, taxonomic units are represented by
  sequences (DNA or RNA nucleotides or amino acids).

• Branches: Branches in phylogenetic trees indicate
  descent/ancestry relationships among the TUs.

• Terminal (external) nodes: The terminal nodes are also
  called the external nodes, leaves, or tips of the tree and are
  also called extant taxonomic units or operational taxonomic
  units (OTUs)
Terminologies of phylogeny
• Internal nodes: The internal nodes are nodes, which are
  not terminal. They are also called ancestral TUs.

• Root: The root is a node from which a unique path leads to
  any other node, in the direction of evolutionary time. The
  root is the common ancestor of all TU’s under study.

• Topology: The topology is the branching pattern of a tree.

• Branch length: The lengths of the branches determine the
  metrics of a tree. In phylogenetic trees, lengths of branches
  are measured in units of evolutionary time.
Example of phylogenetic tree: VP1 gene for FMDV
Genes vs. Species
• Relationships calculated from sequence data represent
  the relationships between genes, this is not necessarily
  the same as relationships between species.
• Your sequence data may not have the same
  phylogenetic history as the species from which they
  were isolated.
• Different genes evolve at different speeds, and there is
  always the possibility of horizontal gene transfer
  (hybridization, vector mediated DNA movement, or
  direct uptake of DNA).
Cladistic vs. Phenetic

Within the field of taxonomy there are two
different methods and philosophies of building
phylogenetic trees: cladistic and phenetic
– Phenetic methods construct trees (phenograms) by
  considering the current states of characters without
  regard to the evolutionary history that brought the
  species to their current phenotypes.

– Cladistic methods rely on assumptions about
  ancestral relationships as well as on current data.
Phenetic Methods
• Computer algorithms based on the phenetic model rely on
  Distance Methods to build of trees from sequence data.
• Phenetic methods count each base of sequence difference
  equally, so a single event that creates a large change in
  sequence (insertion/deletion or recombination) will move two
  sequences far apart on the final tree.
• Phenetic approaches generally lead to faster algorithms and
  they often have nicer statistical properties for molecular data.
• The phenetic approach is popular with molecular
  evolutionists because it relies heavily on objective character
  data (such as sequences) and it requires relatively few
  assumptions.
Cladistic Methods

• For character data about the physical traits of
  organisms (such as morphology of organs etc.)
  and for deeper levels of taxonomy, the cladistic
  approach is almost certainly superior.
• Cladistic methods are often difficult to
  implement with molecular data because all of
  the assumptions are generally not satisfied.
Distances Measurements
• It is often useful to measure the genetic distance between
  two species, between two populations, or even between
  two individuals.
• The entire concept of numerical taxonomy is based on
  computing phylogenies from a table of distances.
• In the case of sequence data, pairwise distances must be
  calculated between all sequences that will be used to build
  the tree - thus creating a distance matrix.
• Distance methods give a single measurement of the
  amount of evolutionary change between two sequences
  since divergence from a common ancestor.
DNA Distances
• Distances between pairs of DNA sequences are relatively
  simple to compute as the sum of all base pair differences
  between the two sequences.
   – this type of algorithm can only work for pairs of sequences that are
     similar enough to be aligned
• Generally all base changes are considered equal
• Insertion/deletions are generally given a larger weight than
  replacements (gap penalties).
• It is also possible to correct for multiple substitutions at a
  single site, which is common in distant relationships and
  for rapidly evolving sites.
Amino Acid Distances
• Distances between amino acid sequences are a bit more
  complicated to calculate.
• Some amino acids can replace one another with relatively little
  effect on the structure and function of the final protein while
  other replacements can be functionally devastating.
• From the standpoint of the genetic code, some amino acid
  changes can be made by a single DNA mutation while others
  require two or even three changes in the DNA sequence.
• In practice, what has been done is to calculate tables of
  frequencies of all amino acid replacements within families of
  related protein sequences in the databanks: i.e. PAM and
  BLOSSUM
The PAM 250 scoring matrix
                  A R N D C             Q    E    G    H    I    L    K    M    F   P   S   T   W   Y   V
               A 2
               R -2 6
               N 0 0 2
               D 0 -1 2 4
              C -2 -4 4 -5 4
              Q 0 1 1 2 -5             4
              E 0 -1 1 3 -5            2     4
              G 1 -3 0 1 -3           -1     0    5
              H -1 2 2 1 -3            3     1   -2    6
              I -1 -2 -2 -2 -2        -2    -2   -3   -2    5
              L -2 -3 -3 -4 -6        -2    -3   -4   -2    2    6
              K -1 3 1 0 -5            1     0   -2    0   -2   -3    5
              M -1 0 -2 -3 -5         -1    -2   -3   -2    2    4    0    6
              F -4 -4 -4 -6 -4        -5    -5   -5   -2    1    2   -5    0    9
              P 1 0 -1 -1 -3           0    -1   -1    0   -2   -3   -1   -2   -5 6
              S 1 0 1 0 0             -1     0    1   -1   -1   -3    0   -2   -3 1 3
              T 1 -1 0 0 -2           -1     0    0   -1    0   -2    0   -1   -2 0 1 3
              W -6 2 -4 -7 -8         -5    -7   -7   -3   -5   -2   -3   -4    0 -6 -2 -5 17
              Y -3 -4 -2 -4 0         -4    -4   -5    0   -1   -1   -4   -2    7 -5 -3 -3 0 10
              V 0 -2 -2 -2 -2         -2    -2   -1   -2    4    2   -2    2   -1 -1 -1 0 -6 -2         4

Dayhoff, M, Schwartz, RM, Orcutt, BC (1978) A model of evolutionary change in proteins. in Atlas of Protein
Sequence and Structure, vol 5, sup. 3, pp 345-352. M. Dayhoff ed., National Biomedical Research Foundation,
Silver Spring, MD.
Clustering Algorithms
Clustering algorithms use distances to calculate
phylogenetic trees. These trees are based solely on
the relative numbers of similarities and differences
between a set of sequences.
– Start with a matrix of pairwise distances

– Cluster methods construct a tree by linking the least
  distant pairs of taxa, followed by successively more
  distant taxa.
UPGMA
• The simplest of the distance methods is the UPGMA
  (Unweighted Pair Group Method using Arithmetic averages)
• The PHYLIP programs DNADIST and PROTDIST
  calculate absolute pairwise distances between a group of
  sequences. Then the GCG program GROWTREE uses
  UPGMA to build a tree.
• Many multiple alignment programs such as PILEUP use a
  variant of UPGMA to create a dendrogram of DNA
  sequences which is then used to guide the multiple alignment
  algorithm.
Neighbor Joining
• The Neighbor Joining method is the most popular
  way to build trees from distance measurements
                    (Saitou and Nei 1987, Mol. Biol. Evol. 4:406)

  –    Neighbor Joining corrects the UPGMA method for its (frequently
      invalid) assumption that the same rate of evolution applies to each
      branch of a tree.
  – The distance matrix is adjusted for differences in the rate of
      evolution of each taxon (branch).

  – Neighbor Joining has given the best results in simulation studies
    and it is the most computationally efficient of the distance
    algorithms (N. Saitou and T. Imanishi, Mol. Biol. Evol. 6:514 (1989)
Cladistic methods
• Cladistic methods are based on the assumption that a
  set of sequences evolved from a common ancestor by
  a process of mutation and selection without mixing
  (hybridization or other horizontal gene transfers).
• These methods work best if a specific tree, or at least
  an ancestral sequence, is already known so that
  comparisons can be made between a finite number of
  alternate trees rather than calculating all possible trees
  for a given set of sequences.
Parsimony
• Parsimony is the most popular method for
  reconstructing ancestral relationships.
• Parsimony allows the use of all known evolutionary
  information in building a tree
   – In contrast, distance methods compress all of the
     differences between pairs of sequences into a single
     number
Building Trees with Parsimony
• Parsimony involves evaluating all possible trees
  and giving each a score based on the number of
  evolutionary changes that are needed to explain
  the observed data.
• The best tree is the one that requires the fewest
  base changes for all sequences to derive from a
  common ancestor.
Parsimony Example

• Consider four sequences: ATCG, TTCG,
  ATCC, and TCCG
• Imagine a tree that branches at the first
  position, grouping ATCG and ATCC on
  one branch, TTCG and TCCG on the other
  branch.
• Then each branch splits, for a total of 3
  nodes on the tree (Tree #1)
Compare Tree #1 with one that first divides ATCC on its own
branch, then splits off ATCG, and finally divides TTCG from
TCCG (Tree #2).
 Trees #1 and #2 both have three nodes, but when all of the
distances back to the root (# of nodes crossed) are summed,
the total is equal to 8 for Tree #1 and 9 for Tree #2.




         Tree                               Tree
         #1                                 #2
Maximum Likelihood
• The method of Maximum Likelihood attempts to
  reconstruct a phylogeny using an explicit model of
  evolution.
• This method works best when it is used to test (or
  improve) an existing tree.
• Even with simple models of evolutionary change,
  the computational task is enormous, making this
  the slowest of all phylogenetic methods.
Assumptions for Maximum Likelihood
 • The frequencies of DNA transitions (C<->T,A<->G) and
   transversions (C or T<->A or G).
 • The assumptions for protein sequence changes are taken
   from the PAM matrix - and are quite likely to be violated in
   “real” data.
 • Since each nucleotide site evolves independently, the tree is
   calculated separately for each site. The product of the
   likelihood's for each site provides the overall likelihood of
   the observed data.
Computer Software for Phylogenetics
Due to the lack of consensus among evolutionary biologists
about basic principles for phylogenetic analysis, it is not
surprising that there is a wide array of computer software
available for this purpose.
– PHYLIP is a free package that includes 30 programs that compute
  various phylogenetic algorithms on different kinds of data.
– The GCG package (available at most research institutions) contains
  a full set of programs for phylogenetic analysis including simple
  distance-based clustering and the complex cladistic analysis
  program PAUP (Phylogenetic Analysis Using Parsimony)
– CLUSTALX is a multiple alignment program that includes the
  ability to create trees based on Neighbor Joining.
– DNAStar
– MacClade is a well designed cladistics program that allows the user
  to explore possible trees for a data set.
Phylogenetics on the Web
• There are several phylogenetics servers available
  on the Web
     – some of these will change or disappear in the near future
     – these programs can be very slow so keep your sample sets small
•   The Institut Pasteur, Paris has a PHYLIP server at:
         http://bioweb.pasteur.fr/seqanal/phylogeny/phylip-uk.html
•   Louxin Zhang at the Natl. University of Singapore has a WebPhylip server:
          http://sdmc.krdl.org.sg:8080/~lxzhang/phylip/
•    The Belozersky Institute at Moscow State University has their own
    "GeneBee" phylogenetics server:
          http://www.genebee.msu.su/services/phtree_reduced.html
• The Phylodendron website is a tree drawing program with a nice user
  interface and a lot of options, however, the output is limited to gifs at
    72 dpi - not publication quality.
         http://iubio.bio.indiana.edu/treeapp/treeprint-form.html
Other Web Resources
• Joseph Felsenstein (author of PHYLIP) maintains a
  comprehensive list of Phylogeny programs at:
 http://evolution.genetics.washington.edu/phylip
  /software.html
• Introduction to Phylogenetic Systematics,
  Peter H. Weston & Michael D. Crisp, Society of Australian Systematic
  Biologists
  http://www.science.uts.edu.au/sasb/WestonCrisp.html
• University of California, Berkeley Museum of
  Paleontology (UCMP)
   http://www.ucmp.berkeley.edu/clad/clad4.html
Software Hazards
• There are a variety of programs for Macs and PCs,
  but you can easily tie up your machine for many
  hours with even moderately sized data sets (i.e.
  fifty 300 bp sequences)
• Moving sequences into different programs can be
  a major hassle due to incompatible file formats.
• Just because a program can perform a given
  computation on a set of data does not mean that
  that is the appropriate algorithm for that type of
  data.
Conclusions
Given the huge variety of methods for computing
phylogenies, how can the biologist determine what
is the best method for analyzing a given data set?
– Published papers that address phylogenetic issues generally
  make use of several different algorithms and data sets in order
  to support their conclusions.
– In some cases different methods of analysis can work
  synergistically
    • Neighbor Joining methods generally produce just one tree, which can
      help to validate a tree built with the parsimony or maximum likelihood
      method
– Using several alternate methods can give an indication of the
  robustness of a given conclusion.

Mais conteúdo relacionado

Mais procurados

Phylogenetic Tree, types and Applicantion
Phylogenetic Tree, types and Applicantion Phylogenetic Tree, types and Applicantion
Phylogenetic Tree, types and Applicantion Faisal Hussain
 
Sequence alignment 1
Sequence alignment 1Sequence alignment 1
Sequence alignment 1SumatiHajela
 
Sequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsSequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsNikesh Narayanan
 
Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-naveed ul mushtaq
 
Distance based method
Distance based method Distance based method
Distance based method Adhena Lulli
 
Sequence similarity tools.pptx
Sequence similarity tools.pptxSequence similarity tools.pptx
Sequence similarity tools.pptxPagudalaSangeetha
 
Introduction to sequence alignment partii
Introduction to sequence alignment partiiIntroduction to sequence alignment partii
Introduction to sequence alignment partiiSumatiHajela
 
Phylogenetic trees
Phylogenetic treesPhylogenetic trees
Phylogenetic treesmartyynyyte
 
Phylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodPhylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodAfnan Zuiter
 
PHYSICAL MAPPING STRATEGIES IN GENOMICS
PHYSICAL MAPPING STRATEGIES IN GENOMICSPHYSICAL MAPPING STRATEGIES IN GENOMICS
PHYSICAL MAPPING STRATEGIES IN GENOMICSUsman Arshad
 
Pairwise sequence alignment
Pairwise sequence alignmentPairwise sequence alignment
Pairwise sequence alignmentavrilcoghlan
 
MEGA (Molecular Evolutionary Genetics Analysis)
MEGA (Molecular Evolutionary Genetics Analysis)MEGA (Molecular Evolutionary Genetics Analysis)
MEGA (Molecular Evolutionary Genetics Analysis)Athar Mutahari
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomicsprateek kumar
 
Orthologs,Paralogs & Xenologs
 Orthologs,Paralogs & Xenologs  Orthologs,Paralogs & Xenologs
Orthologs,Paralogs & Xenologs OsamaZafar16
 

Mais procurados (20)

Phylogenetic analysis
Phylogenetic analysisPhylogenetic analysis
Phylogenetic analysis
 
Phylogenetic Tree, types and Applicantion
Phylogenetic Tree, types and Applicantion Phylogenetic Tree, types and Applicantion
Phylogenetic Tree, types and Applicantion
 
Sequence alignment 1
Sequence alignment 1Sequence alignment 1
Sequence alignment 1
 
Sequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsSequence Alignment In Bioinformatics
Sequence Alignment In Bioinformatics
 
Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-
 
Distance based method
Distance based method Distance based method
Distance based method
 
Sequence similarity tools.pptx
Sequence similarity tools.pptxSequence similarity tools.pptx
Sequence similarity tools.pptx
 
Phylogenetics
PhylogeneticsPhylogenetics
Phylogenetics
 
Introduction to sequence alignment partii
Introduction to sequence alignment partiiIntroduction to sequence alignment partii
Introduction to sequence alignment partii
 
Phylogenetic trees
Phylogenetic treesPhylogenetic trees
Phylogenetic trees
 
Phylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodPhylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony method
 
PHYSICAL MAPPING STRATEGIES IN GENOMICS
PHYSICAL MAPPING STRATEGIES IN GENOMICSPHYSICAL MAPPING STRATEGIES IN GENOMICS
PHYSICAL MAPPING STRATEGIES IN GENOMICS
 
Pairwise sequence alignment
Pairwise sequence alignmentPairwise sequence alignment
Pairwise sequence alignment
 
C value
C value C value
C value
 
PAM matrices evolution
PAM matrices evolutionPAM matrices evolution
PAM matrices evolution
 
EMBL-EBI
EMBL-EBIEMBL-EBI
EMBL-EBI
 
MEGA (Molecular Evolutionary Genetics Analysis)
MEGA (Molecular Evolutionary Genetics Analysis)MEGA (Molecular Evolutionary Genetics Analysis)
MEGA (Molecular Evolutionary Genetics Analysis)
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomics
 
Molecular phylogenetics
Molecular phylogeneticsMolecular phylogenetics
Molecular phylogenetics
 
Orthologs,Paralogs & Xenologs
 Orthologs,Paralogs & Xenologs  Orthologs,Paralogs & Xenologs
Orthologs,Paralogs & Xenologs
 

Destaque

The Structure of Level-k Phylogenetic Networks
The Structure of Level-k Phylogenetic NetworksThe Structure of Level-k Phylogenetic Networks
The Structure of Level-k Phylogenetic NetworksPhilippe Gambette
 
Phylogenetics in R
Phylogenetics in RPhylogenetics in R
Phylogenetics in Rschamber
 
B.sc biochem i bobi u 4 gene prediction
B.sc biochem i bobi u 4 gene predictionB.sc biochem i bobi u 4 gene prediction
B.sc biochem i bobi u 4 gene predictionRai University
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function predictionLars Juhl Jensen
 
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...Jonathan Eisen
 
Bioinformatics Project Training for 2,4,6 month
Bioinformatics Project Training for 2,4,6 monthBioinformatics Project Training for 2,4,6 month
Bioinformatics Project Training for 2,4,6 monthbiinoida
 
Survey of softwares for phylogenetic analysis
Survey of softwares for phylogenetic analysisSurvey of softwares for phylogenetic analysis
Survey of softwares for phylogenetic analysisArindam Ghosh
 
General bacteriology / /certified fixed orthodontic courses by Indian dental...
General bacteriology  / /certified fixed orthodontic courses by Indian dental...General bacteriology  / /certified fixed orthodontic courses by Indian dental...
General bacteriology / /certified fixed orthodontic courses by Indian dental...Indian dental academy
 
Taxonomic categories 6
Taxonomic categories 6Taxonomic categories 6
Taxonomic categories 6Aftab Badshah
 
Gene prediction methods vijay
Gene prediction methods  vijayGene prediction methods  vijay
Gene prediction methods vijayVijay Hemmadi
 
What is a phylogenetic tree
What is a phylogenetic treeWhat is a phylogenetic tree
What is a phylogenetic treeislam jan buneri
 
Classification of Enterobacteriaceae family
Classification of Enterobacteriaceae familyClassification of Enterobacteriaceae family
Classification of Enterobacteriaceae familyAbhijit Chaudhury
 
Tooth Morphology Basics
Tooth Morphology BasicsTooth Morphology Basics
Tooth Morphology Basicshchidmd
 
1.1 Classsification Of Microorganisms
1.1 Classsification  Of  Microorganisms1.1 Classsification  Of  Microorganisms
1.1 Classsification Of Microorganismsmgcnkedahsc
 
Classification of microorganisms lecture note by rm patel
Classification of microorganisms lecture note by rm patelClassification of microorganisms lecture note by rm patel
Classification of microorganisms lecture note by rm patelrajmit_120
 

Destaque (19)

Phylogenetic studies
Phylogenetic studiesPhylogenetic studies
Phylogenetic studies
 
The Structure of Level-k Phylogenetic Networks
The Structure of Level-k Phylogenetic NetworksThe Structure of Level-k Phylogenetic Networks
The Structure of Level-k Phylogenetic Networks
 
Phylogenetics in R
Phylogenetics in RPhylogenetics in R
Phylogenetics in R
 
B.sc biochem i bobi u 4 gene prediction
B.sc biochem i bobi u 4 gene predictionB.sc biochem i bobi u 4 gene prediction
B.sc biochem i bobi u 4 gene prediction
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function prediction
 
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...
Evolution of DNA Sequencing - talk by Jonathan Eisen for the Bodega Workshop ...
 
Bioinformatics Project Training for 2,4,6 month
Bioinformatics Project Training for 2,4,6 monthBioinformatics Project Training for 2,4,6 month
Bioinformatics Project Training for 2,4,6 month
 
Survey of softwares for phylogenetic analysis
Survey of softwares for phylogenetic analysisSurvey of softwares for phylogenetic analysis
Survey of softwares for phylogenetic analysis
 
General bacteriology / /certified fixed orthodontic courses by Indian dental...
General bacteriology  / /certified fixed orthodontic courses by Indian dental...General bacteriology  / /certified fixed orthodontic courses by Indian dental...
General bacteriology / /certified fixed orthodontic courses by Indian dental...
 
Taxonomic categories 6
Taxonomic categories 6Taxonomic categories 6
Taxonomic categories 6
 
Phylogeny
PhylogenyPhylogeny
Phylogeny
 
Gene prediction methods vijay
Gene prediction methods  vijayGene prediction methods  vijay
Gene prediction methods vijay
 
Faridchapter4microbiology
Faridchapter4microbiologyFaridchapter4microbiology
Faridchapter4microbiology
 
What is a phylogenetic tree
What is a phylogenetic treeWhat is a phylogenetic tree
What is a phylogenetic tree
 
Classification of Enterobacteriaceae family
Classification of Enterobacteriaceae familyClassification of Enterobacteriaceae family
Classification of Enterobacteriaceae family
 
Bacterial physiology ppt
Bacterial physiology pptBacterial physiology ppt
Bacterial physiology ppt
 
Tooth Morphology Basics
Tooth Morphology BasicsTooth Morphology Basics
Tooth Morphology Basics
 
1.1 Classsification Of Microorganisms
1.1 Classsification  Of  Microorganisms1.1 Classsification  Of  Microorganisms
1.1 Classsification Of Microorganisms
 
Classification of microorganisms lecture note by rm patel
Classification of microorganisms lecture note by rm patelClassification of microorganisms lecture note by rm patel
Classification of microorganisms lecture note by rm patel
 

Semelhante a Bls 303 l1.phylogenetics

Molecular basis of evolution and softwares used in phylogenetic tree contruction
Molecular basis of evolution and softwares used in phylogenetic tree contructionMolecular basis of evolution and softwares used in phylogenetic tree contruction
Molecular basis of evolution and softwares used in phylogenetic tree contructionUdayBhanushali111
 
Methods of illustrating evolutionary relationship
Methods of illustrating evolutionary relationshipMethods of illustrating evolutionary relationship
Methods of illustrating evolutionary relationshipEmaSushan
 
Phylogenetics Basics.pptx
Phylogenetics Basics.pptxPhylogenetics Basics.pptx
Phylogenetics Basics.pptxSwami53
 
Bioinformatics presentation shabir .pptx
Bioinformatics presentation shabir .pptxBioinformatics presentation shabir .pptx
Bioinformatics presentation shabir .pptxshabirhassan4585
 
BTC 506 Phylogenetic Analysis.pptx
BTC 506 Phylogenetic Analysis.pptxBTC 506 Phylogenetic Analysis.pptx
BTC 506 Phylogenetic Analysis.pptxChijiokeNsofor
 
Basics of constructing Phylogenetic tree.ppt
Basics of constructing Phylogenetic tree.pptBasics of constructing Phylogenetic tree.ppt
Basics of constructing Phylogenetic tree.pptSehrishSarfraz2
 
Introduction to Modern Biosystemaics for Fungal Classification
Introduction to Modern Biosystemaics for Fungal ClassificationIntroduction to Modern Biosystemaics for Fungal Classification
Introduction to Modern Biosystemaics for Fungal ClassificationMrinal Vashisth
 
Phylogenetic analysis
Phylogenetic analysis Phylogenetic analysis
Phylogenetic analysis Nitin Naik
 
Comparative Genomics and Visualisation BS32010
Comparative Genomics and Visualisation BS32010Comparative Genomics and Visualisation BS32010
Comparative Genomics and Visualisation BS32010Leighton Pritchard
 
Multiple Sequence Alignment-just glims of viewes on bioinformatics.
 Multiple Sequence Alignment-just glims of viewes on bioinformatics. Multiple Sequence Alignment-just glims of viewes on bioinformatics.
Multiple Sequence Alignment-just glims of viewes on bioinformatics.Arghadip Samanta
 
Lecture 02 (2 04-2021) phylogeny
Lecture 02 (2 04-2021) phylogenyLecture 02 (2 04-2021) phylogeny
Lecture 02 (2 04-2021) phylogenyKristen DeAngelis
 
Applied bioinformatics
Applied bioinformaticsApplied bioinformatics
Applied bioinformaticsMaryam Saddiqa
 
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdf
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdfphylogenetictreeanditsconstructionandphylogenyof-191208102256.pdf
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdfalizain9604
 
Phylogenetic tree and its construction and phylogeny of
Phylogenetic tree and its construction and phylogeny ofPhylogenetic tree and its construction and phylogeny of
Phylogenetic tree and its construction and phylogeny ofbhavnesthakur
 
Basic concepts in systamatics,taxonomy and phylogenetic tree
Basic concepts in systamatics,taxonomy and phylogenetic treeBasic concepts in systamatics,taxonomy and phylogenetic tree
Basic concepts in systamatics,taxonomy and phylogenetic treeBansari Patel
 

Semelhante a Bls 303 l1.phylogenetics (20)

Phylogeny-Abida.pptx
Phylogeny-Abida.pptxPhylogeny-Abida.pptx
Phylogeny-Abida.pptx
 
07_Phylogeny_2022.pdf
07_Phylogeny_2022.pdf07_Phylogeny_2022.pdf
07_Phylogeny_2022.pdf
 
Molecular basis of evolution and softwares used in phylogenetic tree contruction
Molecular basis of evolution and softwares used in phylogenetic tree contructionMolecular basis of evolution and softwares used in phylogenetic tree contruction
Molecular basis of evolution and softwares used in phylogenetic tree contruction
 
Methods of illustrating evolutionary relationship
Methods of illustrating evolutionary relationshipMethods of illustrating evolutionary relationship
Methods of illustrating evolutionary relationship
 
Phylogenetics Basics.pptx
Phylogenetics Basics.pptxPhylogenetics Basics.pptx
Phylogenetics Basics.pptx
 
Bioinformatics presentation shabir .pptx
Bioinformatics presentation shabir .pptxBioinformatics presentation shabir .pptx
Bioinformatics presentation shabir .pptx
 
BTC 506 Phylogenetic Analysis.pptx
BTC 506 Phylogenetic Analysis.pptxBTC 506 Phylogenetic Analysis.pptx
BTC 506 Phylogenetic Analysis.pptx
 
Basics of constructing Phylogenetic tree.ppt
Basics of constructing Phylogenetic tree.pptBasics of constructing Phylogenetic tree.ppt
Basics of constructing Phylogenetic tree.ppt
 
phylogenetics.pdf
phylogenetics.pdfphylogenetics.pdf
phylogenetics.pdf
 
Introduction to Modern Biosystemaics for Fungal Classification
Introduction to Modern Biosystemaics for Fungal ClassificationIntroduction to Modern Biosystemaics for Fungal Classification
Introduction to Modern Biosystemaics for Fungal Classification
 
Phylogenetic analysis
Phylogenetic analysis Phylogenetic analysis
Phylogenetic analysis
 
Comparative Genomics and Visualisation BS32010
Comparative Genomics and Visualisation BS32010Comparative Genomics and Visualisation BS32010
Comparative Genomics and Visualisation BS32010
 
Multiple Sequence Alignment-just glims of viewes on bioinformatics.
 Multiple Sequence Alignment-just glims of viewes on bioinformatics. Multiple Sequence Alignment-just glims of viewes on bioinformatics.
Multiple Sequence Alignment-just glims of viewes on bioinformatics.
 
Lecture 02 (2 04-2021) phylogeny
Lecture 02 (2 04-2021) phylogenyLecture 02 (2 04-2021) phylogeny
Lecture 02 (2 04-2021) phylogeny
 
Applied bioinformatics
Applied bioinformaticsApplied bioinformatics
Applied bioinformatics
 
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdf
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdfphylogenetictreeanditsconstructionandphylogenyof-191208102256.pdf
phylogenetictreeanditsconstructionandphylogenyof-191208102256.pdf
 
Phylogenetic tree and its construction and phylogeny of
Phylogenetic tree and its construction and phylogeny ofPhylogenetic tree and its construction and phylogeny of
Phylogenetic tree and its construction and phylogeny of
 
Basic concepts in systamatics,taxonomy and phylogenetic tree
Basic concepts in systamatics,taxonomy and phylogenetic treeBasic concepts in systamatics,taxonomy and phylogenetic tree
Basic concepts in systamatics,taxonomy and phylogenetic tree
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomics
 
Phylogeny
PhylogenyPhylogeny
Phylogeny
 

Mais de Bruno Mmassy

Family rhabdoviridae
Family rhabdoviridaeFamily rhabdoviridae
Family rhabdoviridaeBruno Mmassy
 
Processing the crime scene
Processing the crime sceneProcessing the crime scene
Processing the crime sceneBruno Mmassy
 
Molecular forensics 2
Molecular forensics 2Molecular forensics 2
Molecular forensics 2Bruno Mmassy
 
Medical aspects of human identification
Medical aspects of human identificationMedical aspects of human identification
Medical aspects of human identificationBruno Mmassy
 
Forensic chemistry introduction
Forensic chemistry introductionForensic chemistry introduction
Forensic chemistry introductionBruno Mmassy
 
Sero and phage typing bls 206
Sero and phage typing bls 206Sero and phage typing bls 206
Sero and phage typing bls 206Bruno Mmassy
 
Selected gram positives bls 206
Selected gram positives bls 206Selected gram positives bls 206
Selected gram positives bls 206Bruno Mmassy
 
Rickettsia & chlamydia bls 206
Rickettsia & chlamydia bls 206Rickettsia & chlamydia bls 206
Rickettsia & chlamydia bls 206Bruno Mmassy
 
Pathogenic anaerobe gram positive bls 206
Pathogenic anaerobe gram positive bls 206Pathogenic anaerobe gram positive bls 206
Pathogenic anaerobe gram positive bls 206Bruno Mmassy
 
Lecture 2 diagnostic molecular microbiology bls
Lecture 2 diagnostic molecular microbiology blsLecture 2 diagnostic molecular microbiology bls
Lecture 2 diagnostic molecular microbiology blsBruno Mmassy
 
Antimicrobial susceptibility test and assay bls 206
Antimicrobial susceptibility test and assay bls 206Antimicrobial susceptibility test and assay bls 206
Antimicrobial susceptibility test and assay bls 206Bruno Mmassy
 
Antimicrobial agents and mechanisms of action 2
Antimicrobial agents and mechanisms of action 2Antimicrobial agents and mechanisms of action 2
Antimicrobial agents and mechanisms of action 2Bruno Mmassy
 
Antibiotics lecture may 2010
Antibiotics lecture may 2010Antibiotics lecture may 2010
Antibiotics lecture may 2010Bruno Mmassy
 
Streptococci and enterococci bls 206
Streptococci and enterococci bls 206Streptococci and enterococci bls 206
Streptococci and enterococci bls 206Bruno Mmassy
 
Bls 107 general microbiology
Bls 107 general microbiologyBls 107 general microbiology
Bls 107 general microbiologyBruno Mmassy
 

Mais de Bruno Mmassy (20)

Family rhabdoviridae
Family rhabdoviridaeFamily rhabdoviridae
Family rhabdoviridae
 
Antiviral 1
Antiviral 1Antiviral 1
Antiviral 1
 
Processing the crime scene
Processing the crime sceneProcessing the crime scene
Processing the crime scene
 
Molecular forensics 2
Molecular forensics 2Molecular forensics 2
Molecular forensics 2
 
Medical aspects of human identification
Medical aspects of human identificationMedical aspects of human identification
Medical aspects of human identification
 
Forensic
ForensicForensic
Forensic
 
Forensic chemistry introduction
Forensic chemistry introductionForensic chemistry introduction
Forensic chemistry introduction
 
Dna forensic
Dna forensicDna forensic
Dna forensic
 
Sero and phage typing bls 206
Sero and phage typing bls 206Sero and phage typing bls 206
Sero and phage typing bls 206
 
Selected gram positives bls 206
Selected gram positives bls 206Selected gram positives bls 206
Selected gram positives bls 206
 
Rickettsia & chlamydia bls 206
Rickettsia & chlamydia bls 206Rickettsia & chlamydia bls 206
Rickettsia & chlamydia bls 206
 
Pathogenic anaerobe gram positive bls 206
Pathogenic anaerobe gram positive bls 206Pathogenic anaerobe gram positive bls 206
Pathogenic anaerobe gram positive bls 206
 
Lecture 2 diagnostic molecular microbiology bls
Lecture 2 diagnostic molecular microbiology blsLecture 2 diagnostic molecular microbiology bls
Lecture 2 diagnostic molecular microbiology bls
 
Antimicrobial susceptibility test and assay bls 206
Antimicrobial susceptibility test and assay bls 206Antimicrobial susceptibility test and assay bls 206
Antimicrobial susceptibility test and assay bls 206
 
Antimicrobial agents and mechanisms of action 2
Antimicrobial agents and mechanisms of action 2Antimicrobial agents and mechanisms of action 2
Antimicrobial agents and mechanisms of action 2
 
Antibiotics lecture may 2010
Antibiotics lecture may 2010Antibiotics lecture may 2010
Antibiotics lecture may 2010
 
Streptococci and enterococci bls 206
Streptococci and enterococci bls 206Streptococci and enterococci bls 206
Streptococci and enterococci bls 206
 
Bls 107 general microbiology
Bls 107 general microbiologyBls 107 general microbiology
Bls 107 general microbiology
 
Bacteriophage 1
Bacteriophage 1Bacteriophage 1
Bacteriophage 1
 
Bacterial toxins
Bacterial toxinsBacterial toxins
Bacterial toxins
 

Último

Nell’iperspazio con Rocket: il Framework Web di Rust!
Nell’iperspazio con Rocket: il Framework Web di Rust!Nell’iperspazio con Rocket: il Framework Web di Rust!
Nell’iperspazio con Rocket: il Framework Web di Rust!Commit University
 
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Mark Simos
 
Unleash Your Potential - Namagunga Girls Coding Club
Unleash Your Potential - Namagunga Girls Coding ClubUnleash Your Potential - Namagunga Girls Coding Club
Unleash Your Potential - Namagunga Girls Coding ClubKalema Edgar
 
Generative AI for Technical Writer or Information Developers
Generative AI for Technical Writer or Information DevelopersGenerative AI for Technical Writer or Information Developers
Generative AI for Technical Writer or Information DevelopersRaghuram Pandurangan
 
unit 4 immunoblotting technique complete.pptx
unit 4 immunoblotting technique complete.pptxunit 4 immunoblotting technique complete.pptx
unit 4 immunoblotting technique complete.pptxBkGupta21
 
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024BookNet Canada
 
Commit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyCommit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyAlfredo García Lavilla
 
DSPy a system for AI to Write Prompts and Do Fine Tuning
DSPy a system for AI to Write Prompts and Do Fine TuningDSPy a system for AI to Write Prompts and Do Fine Tuning
DSPy a system for AI to Write Prompts and Do Fine TuningLars Bell
 
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfHyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfPrecisely
 
DevoxxFR 2024 Reproducible Builds with Apache Maven
DevoxxFR 2024 Reproducible Builds with Apache MavenDevoxxFR 2024 Reproducible Builds with Apache Maven
DevoxxFR 2024 Reproducible Builds with Apache MavenHervé Boutemy
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024Lorenzo Miniero
 
Take control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteTake control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteDianaGray10
 
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptx
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptxPasskey Providers and Enabling Portability: FIDO Paris Seminar.pptx
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptxLoriGlavin3
 
Gen AI in Business - Global Trends Report 2024.pdf
Gen AI in Business - Global Trends Report 2024.pdfGen AI in Business - Global Trends Report 2024.pdf
Gen AI in Business - Global Trends Report 2024.pdfAddepto
 
Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Mattias Andersson
 
Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 3652toLead Limited
 
What's New in Teams Calling, Meetings and Devices March 2024
What's New in Teams Calling, Meetings and Devices March 2024What's New in Teams Calling, Meetings and Devices March 2024
What's New in Teams Calling, Meetings and Devices March 2024Stephanie Beckett
 
How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.Curtis Poe
 
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024BookNet Canada
 

Último (20)

Nell’iperspazio con Rocket: il Framework Web di Rust!
Nell’iperspazio con Rocket: il Framework Web di Rust!Nell’iperspazio con Rocket: il Framework Web di Rust!
Nell’iperspazio con Rocket: il Framework Web di Rust!
 
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
Tampa BSides - Chef's Tour of Microsoft Security Adoption Framework (SAF)
 
Unleash Your Potential - Namagunga Girls Coding Club
Unleash Your Potential - Namagunga Girls Coding ClubUnleash Your Potential - Namagunga Girls Coding Club
Unleash Your Potential - Namagunga Girls Coding Club
 
Generative AI for Technical Writer or Information Developers
Generative AI for Technical Writer or Information DevelopersGenerative AI for Technical Writer or Information Developers
Generative AI for Technical Writer or Information Developers
 
unit 4 immunoblotting technique complete.pptx
unit 4 immunoblotting technique complete.pptxunit 4 immunoblotting technique complete.pptx
unit 4 immunoblotting technique complete.pptx
 
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
New from BookNet Canada for 2024: Loan Stars - Tech Forum 2024
 
DMCC Future of Trade Web3 - Special Edition
DMCC Future of Trade Web3 - Special EditionDMCC Future of Trade Web3 - Special Edition
DMCC Future of Trade Web3 - Special Edition
 
Commit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easyCommit 2024 - Secret Management made easy
Commit 2024 - Secret Management made easy
 
DSPy a system for AI to Write Prompts and Do Fine Tuning
DSPy a system for AI to Write Prompts and Do Fine TuningDSPy a system for AI to Write Prompts and Do Fine Tuning
DSPy a system for AI to Write Prompts and Do Fine Tuning
 
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdfHyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
Hyperautomation and AI/ML: A Strategy for Digital Transformation Success.pdf
 
DevoxxFR 2024 Reproducible Builds with Apache Maven
DevoxxFR 2024 Reproducible Builds with Apache MavenDevoxxFR 2024 Reproducible Builds with Apache Maven
DevoxxFR 2024 Reproducible Builds with Apache Maven
 
SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024SIP trunking in Janus @ Kamailio World 2024
SIP trunking in Janus @ Kamailio World 2024
 
Take control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test SuiteTake control of your SAP testing with UiPath Test Suite
Take control of your SAP testing with UiPath Test Suite
 
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptx
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptxPasskey Providers and Enabling Portability: FIDO Paris Seminar.pptx
Passkey Providers and Enabling Portability: FIDO Paris Seminar.pptx
 
Gen AI in Business - Global Trends Report 2024.pdf
Gen AI in Business - Global Trends Report 2024.pdfGen AI in Business - Global Trends Report 2024.pdf
Gen AI in Business - Global Trends Report 2024.pdf
 
Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?Are Multi-Cloud and Serverless Good or Bad?
Are Multi-Cloud and Serverless Good or Bad?
 
Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365Ensuring Technical Readiness For Copilot in Microsoft 365
Ensuring Technical Readiness For Copilot in Microsoft 365
 
What's New in Teams Calling, Meetings and Devices March 2024
What's New in Teams Calling, Meetings and Devices March 2024What's New in Teams Calling, Meetings and Devices March 2024
What's New in Teams Calling, Meetings and Devices March 2024
 
How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.How AI, OpenAI, and ChatGPT impact business and software.
How AI, OpenAI, and ChatGPT impact business and software.
 
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
Transcript: New from BookNet Canada for 2024: BNC CataList - Tech Forum 2024
 

Bls 303 l1.phylogenetics

  • 1. BLS 303: Principles of Computational Biology Lecture 1: Molecular Phylogenetics
  • 2. Topics • i. Molecular Evolution • ii. Calculating Distances • iii. Clustering Algorithms • iv. Cladistic Methods • v. Computer Software
  • 3. Evolution • The theory of evolution is the foundation upon which all of modern biology is built. • From anatomy to behavior to genomics, the scientific method requires an appreciation of changes in organisms over time. • It is impossible to evaluate relationships among gene sequences without taking into consideration the way these sequences have been modified over time
  • 4. Relationships Similarity searches and multiple alignments of sequences naturally lead to the question: “How are these sequences related?” and more generally: “How are the organisms from which these sequences come related?”
  • 5. Taxonomy • The study of the relationships between groups of organisms is called taxonomy, an ancient and venerable branch of classical biology. • Taxonomy is the art of classifying things into groups — a quintessential human behavior — established as a mainstream scientific field by Carolus Linnaeus (1707-1778).
  • 6.
  • 7. Phylogenetics • Evolutionary theory states that groups of similar organisms are descended from a common ancestor. • Phylogenetic systematics (cladistics) is a method of taxonomic classification based on their evolutionary history. • It was developed by Willi Hennig, a German entomologist, in 1950.
  • 8. Cladistic Methods • Evolutionary relationships are documented by creating a branching structure, termed a phylogeny or tree, that illustrates the relationships between the sequences. • Cladistic methods construct a tree (cladogram) by considering the various possible pathways of evolution and choose from among these the best possible tree. • A phylogram is a tree with branches that are proportional to evolutionary distances.
  • 9.
  • 10. Molecular Evolution • Phylogenetics often makes use of numerical data, (numerical taxonomy) which can be scores for various “character states” such as the size of a visible structure or it can be DNA sequences. • Similarities and differences between organisms can be coded as a set of characters, each with two or more alternative character states. • In an alignment of DNA sequences, each position is a separate character, with four possible character states, the four nucleotides.
  • 11. DNA is a good tool for taxonomy DNA sequences have many advantages over classical types of taxonomic characters: – Character states can be scored unambiguously – Large numbers of characters can be scored for each individual – Information on both the extent and the nature of divergence between sequences is available (nucleotide substitutions, insertion/deletions, or genome rearrangements)
  • 12. A aat tcg ctt cta gga atc tgc cta atc ctg B ... ..a ..g ..a .t. ... ... t.. ... ..a C ... ..a ..c ..c ... ..t ... ... ... t.a D ... ..a ..a ..g ..g ..t ... t.t Each nucleotide difference is a character ..t t..
  • 13. Sequences Reflect Relationships • After working with sequences for a while, one develops an intuitive understanding that “for a given gene, closely related organisms have similar sequences and more distantly related organisms have more dissimilar sequences. These differences can be quantified”. • Given a set of gene sequences, it should be possible to reconstruct the evolutionary relationships among genes and among organisms.
  • 14.
  • 15. What Sequences to Study? • Different sequences accumulate changes at different rates - chose level of variation that is appropriate to the group of organisms being studied. – Proteins (or protein coding DNAs) are constrained by natural selection - better for very distant relationships – Some sequences are highly variable (rRNA spacer regions, immunoglobulin genes), while others are highly conserved (actin, rRNA coding regions) – Different regions within a single gene can evolve at different rates (conserved vs. variable domains)
  • 16. (globin) Ancestral gene A Duplication (hemoglobin) A B (myoglobin) Speciation A1 B1 A2 B2 (mouse) (human)
  • 17. Orthologs vs. Paralogs • When comparing gene sequences, it is important to distinguish between identical vs. merely similar genes in different organisms. • Orthologs are homologous genes in different species with analogous functions. • Paralogs are similar genes that are the result of a gene duplication. – A phylogeny that includes both orthologs and paralogs is likely to be incorrect. – Sometimes phylogenetic analysis is the best way to determine if a new gene is an ortholog or paralog to other known genes.
  • 18. Terminologies of phylogeny • Phylogenetic (binary) tree: A tree is a graph composed of nodes and branches, in which any two nodes are connected by a unique path. • Nodes: Nodes in phylogenetic trees are called taxonomic units (TUs) Usually, taxonomic units are represented by sequences (DNA or RNA nucleotides or amino acids). • Branches: Branches in phylogenetic trees indicate descent/ancestry relationships among the TUs. • Terminal (external) nodes: The terminal nodes are also called the external nodes, leaves, or tips of the tree and are also called extant taxonomic units or operational taxonomic units (OTUs)
  • 19. Terminologies of phylogeny • Internal nodes: The internal nodes are nodes, which are not terminal. They are also called ancestral TUs. • Root: The root is a node from which a unique path leads to any other node, in the direction of evolutionary time. The root is the common ancestor of all TU’s under study. • Topology: The topology is the branching pattern of a tree. • Branch length: The lengths of the branches determine the metrics of a tree. In phylogenetic trees, lengths of branches are measured in units of evolutionary time.
  • 20. Example of phylogenetic tree: VP1 gene for FMDV
  • 21. Genes vs. Species • Relationships calculated from sequence data represent the relationships between genes, this is not necessarily the same as relationships between species. • Your sequence data may not have the same phylogenetic history as the species from which they were isolated. • Different genes evolve at different speeds, and there is always the possibility of horizontal gene transfer (hybridization, vector mediated DNA movement, or direct uptake of DNA).
  • 22. Cladistic vs. Phenetic Within the field of taxonomy there are two different methods and philosophies of building phylogenetic trees: cladistic and phenetic – Phenetic methods construct trees (phenograms) by considering the current states of characters without regard to the evolutionary history that brought the species to their current phenotypes. – Cladistic methods rely on assumptions about ancestral relationships as well as on current data.
  • 23. Phenetic Methods • Computer algorithms based on the phenetic model rely on Distance Methods to build of trees from sequence data. • Phenetic methods count each base of sequence difference equally, so a single event that creates a large change in sequence (insertion/deletion or recombination) will move two sequences far apart on the final tree. • Phenetic approaches generally lead to faster algorithms and they often have nicer statistical properties for molecular data. • The phenetic approach is popular with molecular evolutionists because it relies heavily on objective character data (such as sequences) and it requires relatively few assumptions.
  • 24. Cladistic Methods • For character data about the physical traits of organisms (such as morphology of organs etc.) and for deeper levels of taxonomy, the cladistic approach is almost certainly superior. • Cladistic methods are often difficult to implement with molecular data because all of the assumptions are generally not satisfied.
  • 25. Distances Measurements • It is often useful to measure the genetic distance between two species, between two populations, or even between two individuals. • The entire concept of numerical taxonomy is based on computing phylogenies from a table of distances. • In the case of sequence data, pairwise distances must be calculated between all sequences that will be used to build the tree - thus creating a distance matrix. • Distance methods give a single measurement of the amount of evolutionary change between two sequences since divergence from a common ancestor.
  • 26. DNA Distances • Distances between pairs of DNA sequences are relatively simple to compute as the sum of all base pair differences between the two sequences. – this type of algorithm can only work for pairs of sequences that are similar enough to be aligned • Generally all base changes are considered equal • Insertion/deletions are generally given a larger weight than replacements (gap penalties). • It is also possible to correct for multiple substitutions at a single site, which is common in distant relationships and for rapidly evolving sites.
  • 27.
  • 28. Amino Acid Distances • Distances between amino acid sequences are a bit more complicated to calculate. • Some amino acids can replace one another with relatively little effect on the structure and function of the final protein while other replacements can be functionally devastating. • From the standpoint of the genetic code, some amino acid changes can be made by a single DNA mutation while others require two or even three changes in the DNA sequence. • In practice, what has been done is to calculate tables of frequencies of all amino acid replacements within families of related protein sequences in the databanks: i.e. PAM and BLOSSUM
  • 29. The PAM 250 scoring matrix A R N D C Q E G H I L K M F P S T W Y V A 2 R -2 6 N 0 0 2 D 0 -1 2 4 C -2 -4 4 -5 4 Q 0 1 1 2 -5 4 E 0 -1 1 3 -5 2 4 G 1 -3 0 1 -3 -1 0 5 H -1 2 2 1 -3 3 1 -2 6 I -1 -2 -2 -2 -2 -2 -2 -3 -2 5 L -2 -3 -3 -4 -6 -2 -3 -4 -2 2 6 K -1 3 1 0 -5 1 0 -2 0 -2 -3 5 M -1 0 -2 -3 -5 -1 -2 -3 -2 2 4 0 6 F -4 -4 -4 -6 -4 -5 -5 -5 -2 1 2 -5 0 9 P 1 0 -1 -1 -3 0 -1 -1 0 -2 -3 -1 -2 -5 6 S 1 0 1 0 0 -1 0 1 -1 -1 -3 0 -2 -3 1 3 T 1 -1 0 0 -2 -1 0 0 -1 0 -2 0 -1 -2 0 1 3 W -6 2 -4 -7 -8 -5 -7 -7 -3 -5 -2 -3 -4 0 -6 -2 -5 17 Y -3 -4 -2 -4 0 -4 -4 -5 0 -1 -1 -4 -2 7 -5 -3 -3 0 10 V 0 -2 -2 -2 -2 -2 -2 -1 -2 4 2 -2 2 -1 -1 -1 0 -6 -2 4 Dayhoff, M, Schwartz, RM, Orcutt, BC (1978) A model of evolutionary change in proteins. in Atlas of Protein Sequence and Structure, vol 5, sup. 3, pp 345-352. M. Dayhoff ed., National Biomedical Research Foundation, Silver Spring, MD.
  • 30. Clustering Algorithms Clustering algorithms use distances to calculate phylogenetic trees. These trees are based solely on the relative numbers of similarities and differences between a set of sequences. – Start with a matrix of pairwise distances – Cluster methods construct a tree by linking the least distant pairs of taxa, followed by successively more distant taxa.
  • 31. UPGMA • The simplest of the distance methods is the UPGMA (Unweighted Pair Group Method using Arithmetic averages) • The PHYLIP programs DNADIST and PROTDIST calculate absolute pairwise distances between a group of sequences. Then the GCG program GROWTREE uses UPGMA to build a tree. • Many multiple alignment programs such as PILEUP use a variant of UPGMA to create a dendrogram of DNA sequences which is then used to guide the multiple alignment algorithm.
  • 32. Neighbor Joining • The Neighbor Joining method is the most popular way to build trees from distance measurements (Saitou and Nei 1987, Mol. Biol. Evol. 4:406) – Neighbor Joining corrects the UPGMA method for its (frequently invalid) assumption that the same rate of evolution applies to each branch of a tree. – The distance matrix is adjusted for differences in the rate of evolution of each taxon (branch). – Neighbor Joining has given the best results in simulation studies and it is the most computationally efficient of the distance algorithms (N. Saitou and T. Imanishi, Mol. Biol. Evol. 6:514 (1989)
  • 33. Cladistic methods • Cladistic methods are based on the assumption that a set of sequences evolved from a common ancestor by a process of mutation and selection without mixing (hybridization or other horizontal gene transfers). • These methods work best if a specific tree, or at least an ancestral sequence, is already known so that comparisons can be made between a finite number of alternate trees rather than calculating all possible trees for a given set of sequences.
  • 34. Parsimony • Parsimony is the most popular method for reconstructing ancestral relationships. • Parsimony allows the use of all known evolutionary information in building a tree – In contrast, distance methods compress all of the differences between pairs of sequences into a single number
  • 35. Building Trees with Parsimony • Parsimony involves evaluating all possible trees and giving each a score based on the number of evolutionary changes that are needed to explain the observed data. • The best tree is the one that requires the fewest base changes for all sequences to derive from a common ancestor.
  • 36. Parsimony Example • Consider four sequences: ATCG, TTCG, ATCC, and TCCG • Imagine a tree that branches at the first position, grouping ATCG and ATCC on one branch, TTCG and TCCG on the other branch. • Then each branch splits, for a total of 3 nodes on the tree (Tree #1)
  • 37. Compare Tree #1 with one that first divides ATCC on its own branch, then splits off ATCG, and finally divides TTCG from TCCG (Tree #2). Trees #1 and #2 both have three nodes, but when all of the distances back to the root (# of nodes crossed) are summed, the total is equal to 8 for Tree #1 and 9 for Tree #2. Tree Tree #1 #2
  • 38. Maximum Likelihood • The method of Maximum Likelihood attempts to reconstruct a phylogeny using an explicit model of evolution. • This method works best when it is used to test (or improve) an existing tree. • Even with simple models of evolutionary change, the computational task is enormous, making this the slowest of all phylogenetic methods.
  • 39. Assumptions for Maximum Likelihood • The frequencies of DNA transitions (C<->T,A<->G) and transversions (C or T<->A or G). • The assumptions for protein sequence changes are taken from the PAM matrix - and are quite likely to be violated in “real” data. • Since each nucleotide site evolves independently, the tree is calculated separately for each site. The product of the likelihood's for each site provides the overall likelihood of the observed data.
  • 40. Computer Software for Phylogenetics Due to the lack of consensus among evolutionary biologists about basic principles for phylogenetic analysis, it is not surprising that there is a wide array of computer software available for this purpose. – PHYLIP is a free package that includes 30 programs that compute various phylogenetic algorithms on different kinds of data. – The GCG package (available at most research institutions) contains a full set of programs for phylogenetic analysis including simple distance-based clustering and the complex cladistic analysis program PAUP (Phylogenetic Analysis Using Parsimony) – CLUSTALX is a multiple alignment program that includes the ability to create trees based on Neighbor Joining. – DNAStar – MacClade is a well designed cladistics program that allows the user to explore possible trees for a data set.
  • 41. Phylogenetics on the Web • There are several phylogenetics servers available on the Web – some of these will change or disappear in the near future – these programs can be very slow so keep your sample sets small • The Institut Pasteur, Paris has a PHYLIP server at: http://bioweb.pasteur.fr/seqanal/phylogeny/phylip-uk.html • Louxin Zhang at the Natl. University of Singapore has a WebPhylip server: http://sdmc.krdl.org.sg:8080/~lxzhang/phylip/ • The Belozersky Institute at Moscow State University has their own "GeneBee" phylogenetics server: http://www.genebee.msu.su/services/phtree_reduced.html • The Phylodendron website is a tree drawing program with a nice user interface and a lot of options, however, the output is limited to gifs at 72 dpi - not publication quality. http://iubio.bio.indiana.edu/treeapp/treeprint-form.html
  • 42. Other Web Resources • Joseph Felsenstein (author of PHYLIP) maintains a comprehensive list of Phylogeny programs at: http://evolution.genetics.washington.edu/phylip /software.html • Introduction to Phylogenetic Systematics, Peter H. Weston & Michael D. Crisp, Society of Australian Systematic Biologists http://www.science.uts.edu.au/sasb/WestonCrisp.html • University of California, Berkeley Museum of Paleontology (UCMP) http://www.ucmp.berkeley.edu/clad/clad4.html
  • 43. Software Hazards • There are a variety of programs for Macs and PCs, but you can easily tie up your machine for many hours with even moderately sized data sets (i.e. fifty 300 bp sequences) • Moving sequences into different programs can be a major hassle due to incompatible file formats. • Just because a program can perform a given computation on a set of data does not mean that that is the appropriate algorithm for that type of data.
  • 44. Conclusions Given the huge variety of methods for computing phylogenies, how can the biologist determine what is the best method for analyzing a given data set? – Published papers that address phylogenetic issues generally make use of several different algorithms and data sets in order to support their conclusions. – In some cases different methods of analysis can work synergistically • Neighbor Joining methods generally produce just one tree, which can help to validate a tree built with the parsimony or maximum likelihood method – Using several alternate methods can give an indication of the robustness of a given conclusion.