SlideShare a Scribd company logo
1 of 50
Phylogenetics and Sequence Analysis
Fall 2015
Kurt Wollenberg, PhD
Phylogenetics Specialist
Bioinformatics and Computational Biosciences Branch
Office of Cyber Infrastructure and Computational Biology
Course Organization
•Building a clean sequence
•Collecting homologs
•Aligning your sequences
•Building trees
•Further Analysis
Tree building, so far
• Generate a distance tree
• Generate maximum parsimony tree(s)
• Calculate bootstrap support
What’s next?
Statistical Methods for Calculating Trees
•Maximum Likelihood
•Bayesian Phylogenetics
Optimality Criterion: Likelihood
Calculating likelihood
The DataThe Tree
S1: AAG
S2: AAA
S3: GGA
S4: AGA
L(Tree) = Prob(Data|Tree) = ∏iProb(Data(i)|Tree)
Calculating likelihood: Setting parameters
What values do you use for the substitution model?
Run jModelTest (or ProtTest for protein MSAs)
L(Tree) = Prob(Data|Tree) = ∏iProb(Data(i)|Tree)
Optimality Criterion: Likelihood
Calculating likelihood: jModelTest
Optimality Criterion: Likelihood
Calculating likelihood: jModelTest
Optimality Criterion: Likelihood
Calculating likelihood: jModelTest Results
Optimality Criterion: Likelihood
Substitution models
http://www.molecularevolution.org/resources/models/nucleotide
Calculating likelihood: jModelTest Results
Optimality Criterion: Likelihood
Substitution models
http://www.molecularevolution.org/resources/models/nucleotide
Calculating likelihood: jModelTest Results
Optimality Criterion: Likelihood
The Gamma Distribution
Mean = kθ Shape parameter = θ
Coefficient of Variation = 1/√θ
Calculating likelihood: Programs
PAUP* – Commercial, NIH Biowulf, or NIAID HPC
DNA only
PHYLIP – Download, NIH Biowulf, or NIAID HPC
dnaml and proml programs
PAML – Download, NIH Biowulf, or NIAID HPC
RaxML – Download or NIH BioWulf or webserver
PhyML – Download or NIAID HPC or webserver
GARLi – Download or NIAID HPC or webserver
MEGA6 - Download
Generally the user has more flexibility with a local program.
But local programs can hog your computer.
Calculating likelihood: Programs
Input data format:
PHYLIP or nexus SEQUENTIAL
Output files:
filename.best.tree
filename.best.all.tree
filename.*.log – intermediate run output
GARLi – Genetic Algorithm for Rapid Likelihood Inference
Input data format:
PHYLIP or Nexus
SEQUENTIAL
not
INTERLEAVED
and now fasta
Calculating likelihood: GARLi
Specifying input parameters:
garli.conf
www.nescent.org/wg_garli/GARLI_Configuration_Settings
Calculating likelihood: GARLi
Running the program
Calculating likelihood: GARLi
Running the program
Calculating likelihood: GARLi
Running the program
Calculating likelihood: GARLi
0.04
IL1Adog
IL1Acow1
IL1Asheep
IL1Adolphin
IL1Amangabey
IL1Allama
IL1Apig
IL1Amouse
IL1Acat
IL1Arhesus
IL1Arabbit
IL1Ahuman
IL1Ahorse
IL1Agoat
IL1Arat
IL1Awaterbuffalo
The Tree
Calculating likelihood: GARLi
Bootstrap results?
GARLi does not calculate a bootstrap consensus!
You must use another piece of software for this.
Dendropy:sumtrees – a very efficient python package
for summarizing collections of phylogenetic trees
Dendropy – Freely distributed from:
https://pythonhosted.org/DendroPy
sumtrees has also been implemented on the NIAID
HPC
Calculating likelihood: GARLi
Calculating the posterior probability of the
evolutionary parameters
Pr(D|τ, v, θ) × Pr(τ, v, θ)
Pr(D)
Pr (τ, v, θ|Data) =
where:
τ = tree topology
v = branch lengths
θ = substitution parameters
Bayesian Analysis
What is Bayesian Analysis?
 Calculation of the probability of parameters (tree,
substitution model) given the data (sequence
alignment)
 p(q|D) = (Likelihood x Prior) / probability of the data
 p(q|D) = p(D|q)p(q) / p(D)
Exploring the posterior probability distribution
Posterior probabilities of trees and
parameters are approximated using Markov
Chain Monte Carlo (MCMC) sampling
Markov Chain: A statement of the probability
of moving from one state to another
Bayesian Analysis
What is MCMC?
Markov Chain Monte Carlo
Markov chain Monte Carlo
One link in the chain Choosing a link
Markov Chain example: Jukes-Cantor
μt = 0.25
A C G T
A 0.5259 0.158 0.158 0.158
C 0.158 0.5259 0.158 0.158
G 0.158 0.158 0.5259 0.158
T 0.158 0.158 0.158 0.5259
Bayesian Analysis
The posterior probability of a specific tree is
the number of times the Markov Chain visits
that tree
Posterior probability distribution is
summarized by the clade probabilities.
Exploring the posterior probability distribution
Bayesian Analysis
Using MrBayes
• Input format = Nexus
• Choose a substitution model (jModelTest)
• Check for convergence
Using BEAST
• Input format = XML (made using BEAUTi program)
• Choose a substitution model (jModelTest)
• Check for convergence (using Tracer program)
Bayesian Analysis
Running MrBayes: Model parameters
MrBayes> lset nst=6 rates=invgamma
MrBayes> showmodel
MrBayes> mcmc ngen=20000 samplefreq=100
printfreq=100 diagnfreq=100 burninfrac=0.25
Bayesian Analysis
Running MrBayes: Setting the Priors
• Generally, the default priors work well
• These are known as “uninformative “ priors
• For implementing the Jukes-Cantor model,
change statefreqpr to “fixed”
Bayesian Analysis
Amino acid substitution models
• Poisson - equal rates, equal state frequencies
• Blosum62
• Dayhoff
• Mtrev, Mtmamm - mitochondrial models
• mixed - Let MrBayes choose among the many fixed-
rate models
Running MrBayes: Setting the Priors
Bayesian Analysis
Running MrBayes: General
• burnin - initial portion of the run to discard
• Generally, 25% of the samples
• samplefreq - how often to sample the Markov chain
• More frequently for small analyses
• Less frequently for low-complexity data
• printfreq - how often output is sent to the log file(s)
Bayesian Analysis
Running MrBayes: General
#NEXUS
begin mrbayes;
set autoclose=yes nowarn=yes;
execute /pathtodata/InputData.nex;
lset nst=6 rates=invgamma;
mcmc stoprule=yes stopval=0.009;
end;
Bayesian Analysis
Running MrBayes: General
Burn in
Bayesian Analysis
Running MrBayes: Summarizing results
MrBayes> sump (burninfrac=0.25)
MrBayes> sumt (burninfrac=0.25)
Bayesian Analysis
999000 -- (-4886.847) [-4876.966] [...6 remote chains...] -- 0:00:06
Average standard deviation of split frequencies: 0.002371
1000000 -- (-4885.621) [-4889.536] [...6 remote chains...] -- 0:00:00
Average standard deviation of split frequencies: 0.002413
Chain results:
1 -- [-5762.003] (-5753.828) [...6 remote chains...]
1000 -- (-4832.654) (-4844.806) [...6 remote chains...] -- 0:16:39
Average standard deviation of split frequencies: 0.143471
2000 -- (-4748.109) (-4762.679) [...6 remote chains...] -- 0:24:57
*************** [SNIP] ***************
Using MrBayes: Convergence
Bayesian Analysis
Log-probability plot appears stochastic
Overlay plot for both runs:
(1 = Run number 1; 2 = Run number 2; * = Both runs)
+------------------------------------------------------------+ -4879.06
| 2 1 |
| 1 1 11 2 1 |
| 2 1 2 1 1 1 |
| 1 2 1 2 11 1 |
| 2 1 2 * 1 1 2 1 1 * 2 1 22 |
| 1 2 12 * 1222 2 11 22 1 21 1 2|
|2 *21 1 2 221 2 2 211 21 1 1 |
| 1 2 12 2 2 1 1 12 2 2 2 2 1|
| 122 2 2 1 21 1 22 1 1 2 |
|1 1 2 1 2 2 |
| 1 11 2 |
| 1 22 |
| 2 |
| |
| 2 |
+------+-----+-----+-----+-----+-----+-----+-----+-----+-----+ -4882.76
^ ^
100000 1000000
Using MrBayes: Convergence
Bayesian Analysis
Using MrBayes: Convergence
Potential Scale Reduction Factor (PSRF) ~1.000
Estimated Sample Size (ESS) > 100
95% HPD Interval
--------------------
Parameter Mean Variance Lower Upper Median min ESS* avg ESS PSRF+
--------------------------------------------------------------------------------------------------
TL 1.569934 0.002486 1.469170 1.658322 1.571118 557.38 565.69 1.000
r(A<->C) 0.169762 0.000056 0.155400 0.183553 0.169529 390.57 402.28 1.005
r(A<->G) 0.339080 0.000150 0.314176 0.361233 0.339147 223.59 264.91 1.007
r(A<->T) 0.099197 0.000030 0.089226 0.110209 0.098949 473.14 478.79 0.999
r(C<->G) 0.048546 0.000018 0.040465 0.056966 0.048398 377.39 383.60 1.003
r(C<->T) 0.264055 0.000110 0.244343 0.283464 0.263957 260.59 265.08 1.005
r(G<->T) 0.079359 0.000028 0.070214 0.090797 0.079234 423.74 466.87 0.999
pi(A) 0.241458 0.000036 0.230500 0.252766 0.241097 344.85 373.56 1.000
pi(C) 0.264338 0.000040 0.252421 0.276949 0.264253 322.23 359.75 1.004
pi(G) 0.215574 0.000040 0.203251 0.227854 0.215273 359.47 406.56 1.005
pi(T) 0.278630 0.000044 0.264885 0.290797 0.278650 254.72 339.96 1.000
alpha 0.666901 0.005264 0.521789 0.801975 0.663511 387.86 408.38 0.999
pinvar 0.374432 0.000849 0.314571 0.429393 0.375512 356.44 374.84 0.999 --
------------------------------------------------------------------------------------------------
Bayesian Analysis
The Consensus Tree
Bayesian Analysis
The Consensus Tree
Likelihood Analysis
0.03
IL1Amangabey
IL1Awaterbuffalo
IL1Adolphin
IL1Adog
IL1Asheep
IL1Agoat
IL1Acat
IL1Acow1
IL1Ahorse
IL1Arat
IL1Amouse
IL1Allama
IL1Apig
IL1Arhesus
IL1Ahuman
IL1Arabbit
0.97
0.66
11
1
0.61
1
1
1
0.39
0.92
1
0.81
Distance Analysis
The Neighbor-Joining Tree
100
100
100
100
68.2
Parsimony Analysis
The Bootstrap Consensus Tree
Tree Building, in conclusion
 How to generate trees using distance, parsimony, and
likelihood
• How to calculate bootstrap support
 Bayesian exploration of phylogeny posterior
distribution
 Always use more than one tree generation algorithm
 Look for consensus and investigate disagreement
Where have we been? What have we done?
Visualizing Trees
•FigTree
•Dendroscope
REFERENCES
Inferring Phylogenies. J. Felsenstein. 2004
A good general reference written in Professor Felsenstein’s unique style.
The Phylogenetic Handbook. Edited by P. Lemey, et al. 2009
A very thorough exploration of theory and practice.
Biological Sequence Analysis. R. Durbin, et al. 1998.
A good introduction to maximum likelihood and hidden Markov models (HMM).
Phylogenetic Trees Made Easy. B. Hall
1st, 2nd Edition - A PAUP and PHYLIP manual, cookbook style.
3rd Edition - A MEGA4 manual, among other things, cookbook style.
4th Edition - MEGA5 and MrBayes 3.2 manuals, cookbook style.
Seminar Follow-Up Site
 For access to past recordings, handouts, slides visit this site from the
NIH network:
http://collab.niaid.nih.gov/sites/research/SIG/Bioinformatics/
46
1. Select a
Subject Matter
View:
• Seminar Details
• Handout and
Reference Docs
• Relevant Links
• Seminar
Recording Links
2. Select a
Topic
Recommended Browsers:
• IE for Windows,
• Safari for Mac (Firefox on a
Mac is incompatible with
NIH Authentication
technology)
Login
• If prompted to log in use
“NIH” in front of your
username
47
Retrieving Slides/Handouts
This lecture
series
48
Retrieving Slides/Handouts
This lecture
This file
49
Questions?
Taro_vein_chlorosis_virus
Viral_hem
orrhagic_septicem
ia_vi
Beilong_virus
Goose_paramyxovirus_SF02
Spring_viremia_of_carp_virus
Sudan_ebolavirus
Rabies_virus
Menangle_virus
Measles_virus
Zaire_ebolavirus
Pneumonia_virus_murine_J3666
Respiratory_syncytial_virus
snakehead_rhabdovirus
Maize_mosaic_virus
Human_parainfluenza_virus1
Vesicular_stomatitis_Indiana_vi
Mumps_virus
Rinderpest_virus_strain_KabeteSimian_virus_41
Bovine_ephemeral_fever_virus
Simian_parainfluenza_virus5
J_virus
Australia
n_b
at_lyssavirus
Borna_disease_virus
Dolphin_morbillivirus
Human_respiratory_syncytial_vir
European_bat_lyssavirus1
Infectious_hematopoietic_necros
Sonchus_yellow_net_virus
Maize_fine_streak_virus
Orchid_fleck_virus
Northern_cereal_mosaic_virus
Lake_Victoria_marburgvirus
European_bat_lyssavirus2
Siniperca_chuatsi_rhabdovirus
Nipah_virus
Mossman_virus
Hendra_virus
Canine_distemper_virus
Ferdelance_virus
Bovine_respiratory_syncytial_vi
Rice_yellow_stunt_virus
Pestedespetitsrum
inants_virus
Newcastle_disease_virus
Mokola_virus
50
Next
Making Publication-Quality
Phylogenetic Tree Figures
Tuesday, 10 November at 1300

More Related Content

What's hot

RNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingRNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingmikaelhuss
 
Scoring schemes in bioinformatics
Scoring schemes in bioinformaticsScoring schemes in bioinformatics
Scoring schemes in bioinformaticsSumatiHajela
 
Sequence alignment 1
Sequence alignment 1Sequence alignment 1
Sequence alignment 1SumatiHajela
 
BITS: UCSC genome browser - Part 1
BITS: UCSC genome browser - Part 1BITS: UCSC genome browser - Part 1
BITS: UCSC genome browser - Part 1BITS
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignmentharshita agarwal
 
Genotyping by Sequencing
Genotyping by SequencingGenotyping by Sequencing
Genotyping by SequencingSenthil Natesan
 
PAM : Point Accepted Mutation
PAM : Point Accepted MutationPAM : Point Accepted Mutation
PAM : Point Accepted MutationAmit Kyada
 
Lecture 9 slides: Machine learning for Protein Structure ...
Lecture 9 slides: Machine learning for Protein Structure ...Lecture 9 slides: Machine learning for Protein Structure ...
Lecture 9 slides: Machine learning for Protein Structure ...butest
 
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
 

What's hot (20)

RNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingRNA-seq quality control and pre-processing
RNA-seq quality control and pre-processing
 
Scoring schemes in bioinformatics
Scoring schemes in bioinformaticsScoring schemes in bioinformatics
Scoring schemes in bioinformatics
 
Phylogenetics: Tree building
Phylogenetics: Tree buildingPhylogenetics: Tree building
Phylogenetics: Tree building
 
Sequence alignment 1
Sequence alignment 1Sequence alignment 1
Sequence alignment 1
 
BITS: UCSC genome browser - Part 1
BITS: UCSC genome browser - Part 1BITS: UCSC genome browser - Part 1
BITS: UCSC genome browser - Part 1
 
UPGMA
UPGMAUPGMA
UPGMA
 
Clustal X
Clustal XClustal X
Clustal X
 
Genomic Databases-.pptx
Genomic Databases-.pptxGenomic Databases-.pptx
Genomic Databases-.pptx
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
 
Genotyping by Sequencing
Genotyping by SequencingGenotyping by Sequencing
Genotyping by Sequencing
 
PAM : Point Accepted Mutation
PAM : Point Accepted MutationPAM : Point Accepted Mutation
PAM : Point Accepted Mutation
 
Msa
MsaMsa
Msa
 
NGS: Mapping and de novo assembly
NGS: Mapping and de novo assemblyNGS: Mapping and de novo assembly
NGS: Mapping and de novo assembly
 
BEAST: Species phylogeny and phylogeographic analysis
BEAST: Species phylogeny and phylogeographic analysisBEAST: Species phylogeny and phylogeographic analysis
BEAST: Species phylogeny and phylogeographic analysis
 
Hidden markov model ppt
Hidden markov model pptHidden markov model ppt
Hidden markov model ppt
 
Lecture 9 slides: Machine learning for Protein Structure ...
Lecture 9 slides: Machine learning for Protein Structure ...Lecture 9 slides: Machine learning for Protein Structure ...
Lecture 9 slides: Machine learning for Protein Structure ...
 
Homology modelling
Homology modellingHomology modelling
Homology modelling
 
Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-Sequence alig Sequence Alignment Pairwise alignment:-
Sequence alig Sequence Alignment Pairwise alignment:-
 
Genomic selection
Genomic  selectionGenomic  selection
Genomic selection
 
Genome Assembly
Genome AssemblyGenome Assembly
Genome Assembly
 

Viewers also liked

Bottlenecks -- some ramblings and a bit of data from maize PAGXXII
Bottlenecks -- some ramblings and a bit of data from maize PAGXXIIBottlenecks -- some ramblings and a bit of data from maize PAGXXII
Bottlenecks -- some ramblings and a bit of data from maize PAGXXIIjrossibarra
 
Testing for heterogeneity in rates of morphological evolution: discrete chara...
Testing for heterogeneity in rates of morphological evolution: discrete chara...Testing for heterogeneity in rates of morphological evolution: discrete chara...
Testing for heterogeneity in rates of morphological evolution: discrete chara...Graeme Lloyd
 
Rates of evolutionary change and extinctions
Rates of evolutionary change and extinctionsRates of evolutionary change and extinctions
Rates of evolutionary change and extinctionsJessi Dildy
 
Evolutionary Genetics of Complex Genome
Evolutionary Genetics of Complex GenomeEvolutionary Genetics of Complex Genome
Evolutionary Genetics of Complex Genomejrossibarra
 
Effects of ancestral character estimation on methods for estimating rates of ...
Effects of ancestral character estimation on methods for estimating rates of ...Effects of ancestral character estimation on methods for estimating rates of ...
Effects of ancestral character estimation on methods for estimating rates of ...Graeme Lloyd
 
Softwares For Phylogentic Analysis
Softwares For Phylogentic AnalysisSoftwares For Phylogentic Analysis
Softwares For Phylogentic AnalysisPrasanthperceptron
 

Viewers also liked (20)

Phylogenetics: Making publication-quality tree figures
Phylogenetics: Making publication-quality tree figuresPhylogenetics: Making publication-quality tree figures
Phylogenetics: Making publication-quality tree figures
 
Selection analysis using HyPhy
Selection analysis using HyPhySelection analysis using HyPhy
Selection analysis using HyPhy
 
BEAST: Time-stamped data and population dynamics
BEAST: Time-stamped data and population dynamicsBEAST: Time-stamped data and population dynamics
BEAST: Time-stamped data and population dynamics
 
Pathogen phylogenetics using BEAST
Pathogen phylogenetics using BEASTPathogen phylogenetics using BEAST
Pathogen phylogenetics using BEAST
 
Introduction to Bayesian phylogenetics and BEAST
Introduction to Bayesian phylogenetics and BEASTIntroduction to Bayesian phylogenetics and BEAST
Introduction to Bayesian phylogenetics and BEAST
 
3D graphics using VMD
3D graphics using VMD3D graphics using VMD
3D graphics using VMD
 
Sequence assembly
Sequence assemblySequence assembly
Sequence assembly
 
BLAST and sequence alignment
BLAST and sequence alignmentBLAST and sequence alignment
BLAST and sequence alignment
 
Bottlenecks -- some ramblings and a bit of data from maize PAGXXII
Bottlenecks -- some ramblings and a bit of data from maize PAGXXIIBottlenecks -- some ramblings and a bit of data from maize PAGXXII
Bottlenecks -- some ramblings and a bit of data from maize PAGXXII
 
Paml test
Paml testPaml test
Paml test
 
Testing for heterogeneity in rates of morphological evolution: discrete chara...
Testing for heterogeneity in rates of morphological evolution: discrete chara...Testing for heterogeneity in rates of morphological evolution: discrete chara...
Testing for heterogeneity in rates of morphological evolution: discrete chara...
 
Rates of evolutionary change and extinctions
Rates of evolutionary change and extinctionsRates of evolutionary change and extinctions
Rates of evolutionary change and extinctions
 
Evolutionary Genetics of Complex Genome
Evolutionary Genetics of Complex GenomeEvolutionary Genetics of Complex Genome
Evolutionary Genetics of Complex Genome
 
Effects of ancestral character estimation on methods for estimating rates of ...
Effects of ancestral character estimation on methods for estimating rates of ...Effects of ancestral character estimation on methods for estimating rates of ...
Effects of ancestral character estimation on methods for estimating rates of ...
 
About IUCN
About IUCNAbout IUCN
About IUCN
 
Softwares For Phylogentic Analysis
Softwares For Phylogentic AnalysisSoftwares For Phylogentic Analysis
Softwares For Phylogentic Analysis
 
IUCN
IUCNIUCN
IUCN
 
Iucn red list
Iucn red listIucn red list
Iucn red list
 
IUCN General Presentation
IUCN General PresentationIUCN General Presentation
IUCN General Presentation
 
Langebio 2015
Langebio 2015Langebio 2015
Langebio 2015
 

Similar to Tree building 2

Heuristic design of experiments w meta gradient search
Heuristic design of experiments w meta gradient searchHeuristic design of experiments w meta gradient search
Heuristic design of experiments w meta gradient searchGreg Makowski
 
Using Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsUsing Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsScott Clark
 
Using Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsUsing Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsSigOpt
 
Bayesian Optimization for Balancing Metrics in Recommender Systems
Bayesian Optimization for Balancing Metrics in Recommender SystemsBayesian Optimization for Balancing Metrics in Recommender Systems
Bayesian Optimization for Balancing Metrics in Recommender SystemsViral Gupta
 
Scaling out logistic regression with Spark
Scaling out logistic regression with SparkScaling out logistic regression with Spark
Scaling out logistic regression with SparkBarak Gitsis
 
Code instrumentation
Code instrumentationCode instrumentation
Code instrumentationBryan Reinero
 
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016MLconf
 
MLConf 2016 SigOpt Talk by Scott Clark
MLConf 2016 SigOpt Talk by Scott ClarkMLConf 2016 SigOpt Talk by Scott Clark
MLConf 2016 SigOpt Talk by Scott ClarkSigOpt
 
MAtrix Multiplication Parallel.ppsx
MAtrix Multiplication Parallel.ppsxMAtrix Multiplication Parallel.ppsx
MAtrix Multiplication Parallel.ppsxBharathiLakshmiAAssi
 
Machinelearning Spark Hadoop User Group Munich Meetup 2016
Machinelearning Spark Hadoop User Group Munich Meetup 2016Machinelearning Spark Hadoop User Group Munich Meetup 2016
Machinelearning Spark Hadoop User Group Munich Meetup 2016Comsysto Reply GmbH
 
Enhancing the performance of kmeans algorithm
Enhancing the performance of kmeans algorithmEnhancing the performance of kmeans algorithm
Enhancing the performance of kmeans algorithmHadi Fadlallah
 
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...Tarek Gaber
 
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...Exploration of Supervised Machine Learning Techniques for Runtime Selection o...
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...Akihiro Hayashi
 
MuVM: Higher Order Mutation Analysis Virtual Machine for C
MuVM: Higher Order Mutation Analysis Virtual Machine for CMuVM: Higher Order Mutation Analysis Virtual Machine for C
MuVM: Higher Order Mutation Analysis Virtual Machine for CSusumu Tokumoto
 
Ml10 dimensionality reduction-and_advanced_topics
Ml10 dimensionality reduction-and_advanced_topicsMl10 dimensionality reduction-and_advanced_topics
Ml10 dimensionality reduction-and_advanced_topicsankit_ppt
 
Parallelism in a NumPy-based program
Parallelism in a NumPy-based programParallelism in a NumPy-based program
Parallelism in a NumPy-based programRalf Gommers
 
Introduction to R Short course Fall 2016
Introduction to R Short course Fall 2016Introduction to R Short course Fall 2016
Introduction to R Short course Fall 2016Spencer Fox
 

Similar to Tree building 2 (20)

Heuristic design of experiments w meta gradient search
Heuristic design of experiments w meta gradient searchHeuristic design of experiments w meta gradient search
Heuristic design of experiments w meta gradient search
 
Using Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsUsing Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning Models
 
Using Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning ModelsUsing Bayesian Optimization to Tune Machine Learning Models
Using Bayesian Optimization to Tune Machine Learning Models
 
Bayesian Optimization for Balancing Metrics in Recommender Systems
Bayesian Optimization for Balancing Metrics in Recommender SystemsBayesian Optimization for Balancing Metrics in Recommender Systems
Bayesian Optimization for Balancing Metrics in Recommender Systems
 
Scaling out logistic regression with Spark
Scaling out logistic regression with SparkScaling out logistic regression with Spark
Scaling out logistic regression with Spark
 
Code instrumentation
Code instrumentationCode instrumentation
Code instrumentation
 
Introduction to Genetic algorithm and its significance in VLSI design and aut...
Introduction to Genetic algorithm and its significance in VLSI design and aut...Introduction to Genetic algorithm and its significance in VLSI design and aut...
Introduction to Genetic algorithm and its significance in VLSI design and aut...
 
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016
Scott Clark, Co-Founder and CEO, SigOpt at MLconf SF 2016
 
MLConf 2016 SigOpt Talk by Scott Clark
MLConf 2016 SigOpt Talk by Scott ClarkMLConf 2016 SigOpt Talk by Scott Clark
MLConf 2016 SigOpt Talk by Scott Clark
 
MAtrix Multiplication Parallel.ppsx
MAtrix Multiplication Parallel.ppsxMAtrix Multiplication Parallel.ppsx
MAtrix Multiplication Parallel.ppsx
 
matrixmultiplicationparallel.ppsx
matrixmultiplicationparallel.ppsxmatrixmultiplicationparallel.ppsx
matrixmultiplicationparallel.ppsx
 
Machinelearning Spark Hadoop User Group Munich Meetup 2016
Machinelearning Spark Hadoop User Group Munich Meetup 2016Machinelearning Spark Hadoop User Group Munich Meetup 2016
Machinelearning Spark Hadoop User Group Munich Meetup 2016
 
Enhancing the performance of kmeans algorithm
Enhancing the performance of kmeans algorithmEnhancing the performance of kmeans algorithm
Enhancing the performance of kmeans algorithm
 
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...
Feature Selection Method Based on Chaotic Maps and Butterfly Optimization Alg...
 
SQCFramework: SPARQL Query Containment Benchmarks Generation Framework
SQCFramework: SPARQL Query Containment Benchmarks Generation FrameworkSQCFramework: SPARQL Query Containment Benchmarks Generation Framework
SQCFramework: SPARQL Query Containment Benchmarks Generation Framework
 
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...Exploration of Supervised Machine Learning Techniques for Runtime Selection o...
Exploration of Supervised Machine Learning Techniques for Runtime Selection o...
 
MuVM: Higher Order Mutation Analysis Virtual Machine for C
MuVM: Higher Order Mutation Analysis Virtual Machine for CMuVM: Higher Order Mutation Analysis Virtual Machine for C
MuVM: Higher Order Mutation Analysis Virtual Machine for C
 
Ml10 dimensionality reduction-and_advanced_topics
Ml10 dimensionality reduction-and_advanced_topicsMl10 dimensionality reduction-and_advanced_topics
Ml10 dimensionality reduction-and_advanced_topics
 
Parallelism in a NumPy-based program
Parallelism in a NumPy-based programParallelism in a NumPy-based program
Parallelism in a NumPy-based program
 
Introduction to R Short course Fall 2016
Introduction to R Short course Fall 2016Introduction to R Short course Fall 2016
Introduction to R Short course Fall 2016
 

More from Bioinformatics and Computational Biosciences Branch

More from Bioinformatics and Computational Biosciences Branch (20)

Hong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptxHong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptx
 
Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019
 
Nephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele resultsNephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele results
 
Introduction to METAGENOTE
Introduction to METAGENOTE Introduction to METAGENOTE
Introduction to METAGENOTE
 
Intro to homology modeling
Intro to homology modelingIntro to homology modeling
Intro to homology modeling
 
Protein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modelingProtein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modeling
 
Homology modeling: Modeller
Homology modeling: ModellerHomology modeling: Modeller
Homology modeling: Modeller
 
Protein docking
Protein dockingProtein docking
Protein docking
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function prediction
 
Protein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on RosettaProtein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on Rosetta
 
Biological networks
Biological networksBiological networks
Biological networks
 
UNIX Basics and Cluster Computing
UNIX Basics and Cluster ComputingUNIX Basics and Cluster Computing
UNIX Basics and Cluster Computing
 
Statistical applications in GraphPad Prism
Statistical applications in GraphPad PrismStatistical applications in GraphPad Prism
Statistical applications in GraphPad Prism
 
Intro to JMP for statistics
Intro to JMP for statisticsIntro to JMP for statistics
Intro to JMP for statistics
 
Categorical models
Categorical modelsCategorical models
Categorical models
 
Better graphics in R
Better graphics in RBetter graphics in R
Better graphics in R
 
Automating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtoolsAutomating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtools
 
Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)
 
Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)
 
GraphPad Prism: Curve fitting
GraphPad Prism: Curve fittingGraphPad Prism: Curve fitting
GraphPad Prism: Curve fitting
 

Recently uploaded

Radiation physics in Dental Radiology...
Radiation physics in Dental Radiology...Radiation physics in Dental Radiology...
Radiation physics in Dental Radiology...navyadasi1992
 
Pests of safflower_Binomics_Identification_Dr.UPR.pdf
Pests of safflower_Binomics_Identification_Dr.UPR.pdfPests of safflower_Binomics_Identification_Dr.UPR.pdf
Pests of safflower_Binomics_Identification_Dr.UPR.pdfPirithiRaju
 
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingBase editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingNetHelix
 
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubai
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In DubaiDubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubai
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubaikojalkojal131
 
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...lizamodels9
 
FREE NURSING BUNDLE FOR NURSES.PDF by na
FREE NURSING BUNDLE FOR NURSES.PDF by naFREE NURSING BUNDLE FOR NURSES.PDF by na
FREE NURSING BUNDLE FOR NURSES.PDF by naJASISJULIANOELYNV
 
Pests of Bengal gram_Identification_Dr.UPR.pdf
Pests of Bengal gram_Identification_Dr.UPR.pdfPests of Bengal gram_Identification_Dr.UPR.pdf
Pests of Bengal gram_Identification_Dr.UPR.pdfPirithiRaju
 
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXDole Philippines School
 
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPirithiRaju
 
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...Universidade Federal de Sergipe - UFS
 
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...D. B. S. College Kanpur
 
basic entomology with insect anatomy and taxonomy
basic entomology with insect anatomy and taxonomybasic entomology with insect anatomy and taxonomy
basic entomology with insect anatomy and taxonomyDrAnita Sharma
 
The dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxThe dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxEran Akiva Sinbar
 
Servosystem Theory / Cybernetic Theory by Petrovic
Servosystem Theory / Cybernetic Theory by PetrovicServosystem Theory / Cybernetic Theory by Petrovic
Servosystem Theory / Cybernetic Theory by PetrovicAditi Jain
 
trihybrid cross , test cross chi squares
trihybrid cross , test cross chi squarestrihybrid cross , test cross chi squares
trihybrid cross , test cross chi squaresusmanzain586
 
CHROMATOGRAPHY PALLAVI RAWAT.pptx
CHROMATOGRAPHY  PALLAVI RAWAT.pptxCHROMATOGRAPHY  PALLAVI RAWAT.pptx
CHROMATOGRAPHY PALLAVI RAWAT.pptxpallavirawat456
 
Microteaching on terms used in filtration .Pharmaceutical Engineering
Microteaching on terms used in filtration .Pharmaceutical EngineeringMicroteaching on terms used in filtration .Pharmaceutical Engineering
Microteaching on terms used in filtration .Pharmaceutical EngineeringPrajakta Shinde
 
《Queensland毕业文凭-昆士兰大学毕业证成绩单》
《Queensland毕业文凭-昆士兰大学毕业证成绩单》《Queensland毕业文凭-昆士兰大学毕业证成绩单》
《Queensland毕业文凭-昆士兰大学毕业证成绩单》rnrncn29
 
Pests of castor_Binomics_Identification_Dr.UPR.pdf
Pests of castor_Binomics_Identification_Dr.UPR.pdfPests of castor_Binomics_Identification_Dr.UPR.pdf
Pests of castor_Binomics_Identification_Dr.UPR.pdfPirithiRaju
 

Recently uploaded (20)

Radiation physics in Dental Radiology...
Radiation physics in Dental Radiology...Radiation physics in Dental Radiology...
Radiation physics in Dental Radiology...
 
Pests of safflower_Binomics_Identification_Dr.UPR.pdf
Pests of safflower_Binomics_Identification_Dr.UPR.pdfPests of safflower_Binomics_Identification_Dr.UPR.pdf
Pests of safflower_Binomics_Identification_Dr.UPR.pdf
 
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingBase editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
 
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubai
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In DubaiDubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubai
Dubai Calls Girl Lisa O525547819 Lexi Call Girls In Dubai
 
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...
Best Call Girls In Sector 29 Gurgaon❤️8860477959 EscorTs Service In 24/7 Delh...
 
FREE NURSING BUNDLE FOR NURSES.PDF by na
FREE NURSING BUNDLE FOR NURSES.PDF by naFREE NURSING BUNDLE FOR NURSES.PDF by na
FREE NURSING BUNDLE FOR NURSES.PDF by na
 
Pests of Bengal gram_Identification_Dr.UPR.pdf
Pests of Bengal gram_Identification_Dr.UPR.pdfPests of Bengal gram_Identification_Dr.UPR.pdf
Pests of Bengal gram_Identification_Dr.UPR.pdf
 
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
 
Volatile Oils Pharmacognosy And Phytochemistry -I
Volatile Oils Pharmacognosy And Phytochemistry -IVolatile Oils Pharmacognosy And Phytochemistry -I
Volatile Oils Pharmacognosy And Phytochemistry -I
 
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
 
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...
REVISTA DE BIOLOGIA E CIÊNCIAS DA TERRA ISSN 1519-5228 - Artigo_Bioterra_V24_...
 
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...
Fertilization: Sperm and the egg—collectively called the gametes—fuse togethe...
 
basic entomology with insect anatomy and taxonomy
basic entomology with insect anatomy and taxonomybasic entomology with insect anatomy and taxonomy
basic entomology with insect anatomy and taxonomy
 
The dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxThe dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptx
 
Servosystem Theory / Cybernetic Theory by Petrovic
Servosystem Theory / Cybernetic Theory by PetrovicServosystem Theory / Cybernetic Theory by Petrovic
Servosystem Theory / Cybernetic Theory by Petrovic
 
trihybrid cross , test cross chi squares
trihybrid cross , test cross chi squarestrihybrid cross , test cross chi squares
trihybrid cross , test cross chi squares
 
CHROMATOGRAPHY PALLAVI RAWAT.pptx
CHROMATOGRAPHY  PALLAVI RAWAT.pptxCHROMATOGRAPHY  PALLAVI RAWAT.pptx
CHROMATOGRAPHY PALLAVI RAWAT.pptx
 
Microteaching on terms used in filtration .Pharmaceutical Engineering
Microteaching on terms used in filtration .Pharmaceutical EngineeringMicroteaching on terms used in filtration .Pharmaceutical Engineering
Microteaching on terms used in filtration .Pharmaceutical Engineering
 
《Queensland毕业文凭-昆士兰大学毕业证成绩单》
《Queensland毕业文凭-昆士兰大学毕业证成绩单》《Queensland毕业文凭-昆士兰大学毕业证成绩单》
《Queensland毕业文凭-昆士兰大学毕业证成绩单》
 
Pests of castor_Binomics_Identification_Dr.UPR.pdf
Pests of castor_Binomics_Identification_Dr.UPR.pdfPests of castor_Binomics_Identification_Dr.UPR.pdf
Pests of castor_Binomics_Identification_Dr.UPR.pdf
 

Tree building 2

Editor's Notes

  1. Algorithm explained in Felsenstein (2004) Chapter 16.
  2. ratematrix = 1rate, 2rate, 6rate, fixed, custom string > (a b c c b a), etc. for DNA. For protein = dayhoff, jones, wag, mtrev, mtmam ratehetmodel = none, gamma, gammafixed invariantsites = none, estimate, fixed