|
bpp-phyl3 3.0.0
|
The OneProcessSequencePhyloLikelihood class: phylogenetic likelihood computation with a single process. More...
#include <Bpp/Phyl/Likelihood/PhyloLikelihoods/OneProcessSequencePhyloLikelihood.h>
Inheritance diagram for bpp::OneProcessSequencePhyloLikelihood:
Collaboration diagram for bpp::OneProcessSequencePhyloLikelihood:Public Member Functions | |
| OneProcessSequencePhyloLikelihood (Context &context, std::shared_ptr< OneProcessSequenceEvolution > evol, size_t nSeqEvol=0) | |
| OneProcessSequencePhyloLikelihood (Context &context, std::shared_ptr< const AlignmentDataInterface > data, std::shared_ptr< OneProcessSequenceEvolution > evol, size_t nSeqEvol=0, size_t nData=0) | |
| OneProcessSequencePhyloLikelihood (std::shared_ptr< const AlignmentDataInterface > data, std::shared_ptr< OneProcessSequenceEvolution > evol, std::shared_ptr< CollectionNodes > collNodes, size_t nSeqEvol=0, size_t nData=0) | |
| virtual | ~OneProcessSequencePhyloLikelihood () |
| LikelihoodCalculation & | likelihoodCalculation () const override |
| std::shared_ptr< LikelihoodCalculation > | getLikelihoodCalculation () const override |
| AlignedLikelihoodCalculation & | alignedLikelihoodCalculation () const override |
| std::shared_ptr< AlignedLikelihoodCalculation > | getAlignedLikelihoodCalculation () const override |
| LikelihoodCalculationSingleProcess & | likelihoodCalculationSingleProcess () const |
| std::shared_ptr< LikelihoodCalculationSingleProcess > | getLikelihoodCalculationSingleProcess () const |
| ValueRef< RowLik > | getFirstOrderDerivativeVector (const std::string &variable) const |
| ValueRef< RowLik > | firstOrderDerivativeVector (const std::string &variable) const |
| ValueRef< RowLik > | getSecondOrderDerivativeVector (const std::string &variable) const |
| ValueRef< RowLik > | getSecondOrderDerivativeVector (const std::string &variable1, const std::string &variable2) const |
| ValueRef< RowLik > | secondOrderDerivativeVector (const std::string &variable1, const std::string &variable2) const |
| VVdouble | getPosteriorProbabilitiesPerSitePerClass () const |
| Vdouble | getPosteriorProbabilitiesForSitePerClass (size_t pos) const |
| VVdouble | getLikelihoodPerSitePerClass () const |
| std::vector< size_t > | getClassWithMaxPostProbPerSite () const |
| Vdouble | getPosteriorRatePerSite () const |
| Vdouble | getPosteriorStateFrequencies (uint nodeId) |
| void | setNamespace (const std::string &nameSpace) override |
| ParameterList | getNonDerivableParameters () const override |
| ParameterList | getDerivableParameters () const override |
| ParameterList | getBranchLengthParameters () const override |
| Get the independent branch lengths parameters. More... | |
| ParameterList | getRootFrequenciesParameters () const override |
| Get the independent parameters associated to the root frequencies(s). More... | |
| ParameterList | getRateDistributionParameters () const override |
| Get the independent parameters associated to the rate distribution(s). More... | |
| ParameterList | getSubstitutionModelParameters () const override |
| Get the independent parameters associated to substitution model(s). More... | |
| virtual ParameterList | getSubstitutionProcessParameters () const |
| const SequenceEvolution & | sequenceEvolution () const override |
| The Sequence Evolution. More... | |
| std::shared_ptr< const SequenceEvolution > | getSequenceEvolution () const override |
| const size_t | getSequenceEvolutionNumber () const override |
| size_t | getNData () const |
| Get the number of dataset concerned. More... | |
| size_t | getNumberOfStates () const |
| Get the number the states. More... | |
| size_t | getNumberOfSites () const |
| Get the number of sites in the dataset. More... | |
| DataLik | getLikelihoodForASite (size_t site) const |
| Get the likelihood for a site (on uncompressed data) More... | |
| double | getLogLikelihoodForASite (size_t site) const |
| Get the log likelihood for a site, and its derivatives. More... | |
| VDataLik | getLikelihoodPerSite () const |
| Get the likelihood for each site. More... | |
| const Context & | context () const override |
| Context & | context () override |
| ValueRef< DataLik > | getLikelihoodNode () const override |
| virtual void | enableSecondOrderDerivatives (bool yn)=0 |
| virtual bool | enableSecondOrderDerivatives () const=0 |
| virtual void | enableSecondOrderDerivatives (bool yn) override |
| bool | enableSecondOrderDerivatives () const override |
| virtual double | getSecondOrderDerivative (const std::string &variable) const=0 |
| virtual double | getSecondOrderDerivative (const std::string &variable1, const std::string &variable2) const=0 |
| double | getSecondOrderDerivative (const std::string &variable) const override |
| double | getSecondOrderDerivative (const std::string &variable1, const std::string &variable2) const override |
| virtual double | d2f (const std::string &variable, const ParameterList ¶meters) |
| virtual double | d2f (const std::string &variable1, const std::string &variable2, const ParameterList ¶meters) |
| virtual void | enableFirstOrderDerivatives (bool yn)=0 |
| virtual bool | enableFirstOrderDerivatives () const=0 |
| virtual void | enableFirstOrderDerivatives (bool yn) override |
| Tell if derivatives must be computed: for Function inheritance. More... | |
| bool | enableFirstOrderDerivatives () const override |
| virtual double | getFirstOrderDerivative (const std::string &variable) const=0 |
| double | getFirstOrderDerivative (const std::string &variable) const override |
| virtual double | df (const std::string &variable, const ParameterList ¶meters) |
| virtual void | setParameters (const ParameterList ¶meters)=0 |
| void | setParameters (const ParameterList ¶meters) override |
| virtual double | getValue () const=0 |
| double | getValue () const override |
| virtual double | f (const ParameterList ¶meters) |
| virtual bool | hasParameter (const std::string &name) const=0 |
| bool | hasParameter (const std::string &name) const override |
| virtual const ParameterList & | getParameters () const=0 |
| const ParameterList & | getParameters () const override |
| virtual const Parameter & | parameter (const std::string &name) const=0 |
| const Parameter & | parameter (const std::string &name) const override |
| virtual double | getParameterValue (const std::string &name) const=0 |
| double | getParameterValue (const std::string &name) const override |
| virtual void | setAllParametersValues (const ParameterList ¶meters)=0 |
| void | setAllParametersValues (const ParameterList ¶meters) override |
| virtual void | setParameterValue (const std::string &name, double value)=0 |
| void | setParameterValue (const std::string &name, double value) override |
| virtual void | setParametersValues (const ParameterList ¶meters)=0 |
| void | setParametersValues (const ParameterList ¶meters) override |
| virtual bool | matchParametersValues (const ParameterList ¶meters)=0 |
| bool | matchParametersValues (const ParameterList ¶meters) override |
| virtual void | removeConstraint (const std::string &name)=0 |
| void | removeConstraint (const std::string &name) override |
| virtual void | setConstraint (const std::string &name, std::shared_ptr< ConstraintInterface > constraint)=0 |
| void | setConstraint (const std::string &name, std::shared_ptr< ConstraintInterface > constraint) override |
| virtual size_t | getNumberOfParameters () const=0 |
| size_t | getNumberOfParameters () const override |
| virtual std::string | getNamespace () const=0 |
| std::string | getNamespace () const override |
| virtual std::string | getParameterNameWithoutNamespace (const std::string &name) const=0 |
| std::string | getParameterNameWithoutNamespace (const std::string &name) const override |
| void | setNData (size_t nData) |
| void | shareParameters (const ParameterList &variableNodes) |
| Share Parameters, that are DF_parameters. More... | |
| ValueRef< DataLik > | firstOrderDerivativeNode (const std::string &variable) const |
| ValueRef< DataLik > | secondOrderDerivativeNode (const std::string &variable1, const std::string &variable2) const |
| const std::shared_ptr< Parameter > & | getParameter (const std::string &name) const |
Handling of data | |
| void | setData (std::shared_ptr< const AlignmentDataInterface > sites, size_t nData=0) override |
| Set the dataset for which the likelihood must be evaluated. More... | |
| bool | isInitialized () const override |
| Sets the computeLikelihoods_ to true. More... | |
| std::shared_ptr< const AlignmentDataInterface > | getData () const override |
| return a pointer to the compressed data. More... | |
| std::shared_ptr< const Alphabet > | getAlphabet () const override |
| Get the alphabet associated to the dataset. More... | |
Handling of substitution process | |
| const SubstitutionProcessInterface & | substitutionProcess () const |
| Get the ParametrizablePhyloTree. More... | |
| std::shared_ptr< const SubstitutionProcessInterface > | getSubstitutionProcess () const |
| size_t | getNumberOfClasses () const |
| Get the number of model classes. More... | |
| std::shared_ptr< const ParametrizablePhyloTree > | tree () const |
| Return the ref to the SubstitutionProcess used to build the phylolikelihood. More... | |
The data functions | |
| virtual size_t | getNData () const =0 |
| Get the number of dataset concerned. More... | |
| virtual size_t | getNumberOfStates () const =0 |
| Get the number the states. More... | |
The data functions | |
| virtual size_t | getNumberOfSites () const =0 |
| Get the number of sites in the dataset. More... | |
The likelihood functions. | |
| virtual DataLik | getLikelihoodForASite (size_t site) const =0 |
| Get the likelihood for a site. More... | |
| virtual double | getLogLikelihoodForASite (size_t site) const =0 |
| Get the log likelihood for a site, and its derivatives. More... | |
| virtual VDataLik | getLikelihoodPerSite () const =0 |
| Get the likelihood for each site. More... | |
The data functions | |
| virtual const Context & | context () const =0 |
| virtual Context & | context ()=0 |
The likelihood functions. | |
| virtual ValueRef< DataLik > | getLikelihoodNode () const =0 |
| double | getLogLikelihood () const |
| Get the logarithm of the likelihood for the whole dataset. More... | |
Protected Member Functions | |
| OneProcessSequencePhyloLikelihood (const OneProcessSequencePhyloLikelihood &lik) | |
| OneProcessSequencePhyloLikelihood & | operator= (const OneProcessSequencePhyloLikelihood &lik) |
| OneProcessSequencePhyloLikelihood * | clone () const override |
| virtual void | fireParameterChanged (const ParameterList ¶meters) override |
| virtual ParameterList & | getParameters_ ()=0 |
| ParameterList & | getParameters_ () override |
| void | setNumberOfSites (size_t nbSites) |
| Node_DF & | accessVariableNode (const std::string &name) const |
| const std::shared_ptr< Parameter > & | getParameter (size_t i) const |
| std::shared_ptr< Parameter > & | getParameter (size_t i) |
| virtual void | addParameter_ (Parameter *parameter) |
| virtual void | addParameters_ (const ParameterList ¶meters) |
| virtual void | shareParameter_ (const std::shared_ptr< Parameter > ¶meter) |
| virtual void | shareParameters_ (const ParameterList ¶meters) |
| virtual void | includeParameters_ (const ParameterList ¶meters) |
| virtual void | deleteParameter_ (size_t index) |
| virtual void | deleteParameter_ (std::string &name) |
| virtual void | deleteParameters_ (const std::vector< std::string > &names) |
| void | resetParameters_ () |
| Parameter & | getParameter_ (const std::string &name) |
| Parameter & | getParameter_ (size_t index) |
| const Parameter & | getParameter_ (size_t index) const |
| Parameter & | getParameterWithNamespace_ (const std::string &name) |
| const Parameter & | getParameterWithNamespace_ (const std::string &name) const |
Static Protected Member Functions | |
| static Node_DF & | accessVariableNode (const Parameter ¶m) |
Protected Attributes | |
| std::shared_ptr< LikelihoodCalculationSingleProcess > | likCal_ |
| std::shared_ptr< SequenceEvolution > | seqEvol_ |
| the Sequence Evolution More... | |
| size_t | nSeqEvol_ |
| the Sequence Evolution number More... | |
| size_t | nbStates_ |
| size_t | nData_ |
| Number of the concerned data. More... | |
| size_t | nbSites_ |
| Context & | context_ |
| DataLik | minusLogLik_ |
| the value More... | |
| std::unordered_map< std::string, ValueRef< DataLik > > | firstOrderDerivativeNodes_ |
| For Dataflow computing. More... | |
| std::unordered_map< std::pair< std::string, std::string >, ValueRef< DataLik >, StringPairHash > | secondOrderDerivativeNodes_ |
Private Attributes | |
| std::shared_ptr< OneProcessSequenceEvolution > | mSeqEvol_ |
| to avoid the dynamic casts More... | |
| std::unordered_map< std::string, ValueRef< RowLik > > | firstOrderDerivativeVectors_ |
| For Dataflow computing. More... | |
| std::unordered_map< std::pair< std::string, std::string >, ValueRef< RowLik >, StringPairHash > | secondOrderDerivativeVectors_ |
| ParameterList | parameters_ |
| std::string | prefix_ |
The OneProcessSequencePhyloLikelihood class: phylogenetic likelihood computation with a single process.
This class implements likelihood calculation with a single process/tree. It uses a unique LikelihoodTreeCalculation instance, and implements the Function interface, dealing with parameters from the associated SubstitutionProcess.
Definition at line 37 of file OneProcessSequencePhyloLikelihood.h.
| OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood | ( | Context & | context, |
| std::shared_ptr< OneProcessSequenceEvolution > | evol, | ||
| size_t | nSeqEvol = 0 |
||
| ) |
Definition at line 13 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::AbstractPhyloLikelihood::context(), likCal_, bpp::AbstractParametrizable::resetParameters_(), and bpp::AbstractParametrizable::shareParameters_().
Referenced by clone().
| OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood | ( | Context & | context, |
| std::shared_ptr< const AlignmentDataInterface > | data, | ||
| std::shared_ptr< OneProcessSequenceEvolution > | evol, | ||
| size_t | nSeqEvol = 0, |
||
| size_t | nData = 0 |
||
| ) |
Definition at line 36 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::AbstractPhyloLikelihood::context(), likCal_, bpp::AbstractParametrizable::resetParameters_(), and bpp::AbstractParametrizable::shareParameters_().
| OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood | ( | std::shared_ptr< const AlignmentDataInterface > | data, |
| std::shared_ptr< OneProcessSequenceEvolution > | evol, | ||
| std::shared_ptr< CollectionNodes > | collNodes, | ||
| size_t | nSeqEvol = 0, |
||
| size_t | nData = 0 |
||
| ) |
Definition at line 60 of file OneProcessSequencePhyloLikelihood.cpp.
References likCal_, bpp::AbstractParametrizable::resetParameters_(), and bpp::AbstractParametrizable::shareParameters_().
|
inlineprotected |
Definition at line 79 of file OneProcessSequencePhyloLikelihood.h.
|
inlinevirtual |
Definition at line 104 of file OneProcessSequencePhyloLikelihood.h.
|
inlinestaticprotectedinherited |
Definition at line 188 of file AbstractPhyloLikelihood.h.
Referenced by bpp::AbstractPhyloLikelihood::accessVariableNode(), bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode(), bpp::OnABranchPhyloLikelihood::firstOrderDerivativeVector(), firstOrderDerivativeVector(), bpp::SingleProcessPhyloLikelihood::firstOrderDerivativeVector(), bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode(), bpp::OnABranchPhyloLikelihood::secondOrderDerivativeVector(), secondOrderDerivativeVector(), and bpp::SingleProcessPhyloLikelihood::secondOrderDerivativeVector().
|
inlineprotectedinherited |
Definition at line 193 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::accessVariableNode(), and bpp::SecondOrderDerivable::parameter().
|
inlineoverridevirtual |
Implements bpp::AlignedPhyloLikelihoodInterface.
Definition at line 187 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
|
inlineoverrideprotectedvirtual |
Implements bpp::AbstractParametrizable.
Definition at line 98 of file OneProcessSequencePhyloLikelihood.h.
References OneProcessSequencePhyloLikelihood().
|
pure virtualinherited |
Implemented in bpp::AbstractPhyloLikelihood.
|
inlineoverridevirtualinherited |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 73 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::context_.
Referenced by bpp::AlignedPhyloLikelihoodMixture::AlignedPhyloLikelihoodMixture(), bpp::AutoCorrelationProcessPhyloLikelihood::AutoCorrelationProcessPhyloLikelihood(), bpp::HmmProcessPhyloLikelihood::HmmProcessPhyloLikelihood(), bpp::PartitionProcessPhyloLikelihood::makeLikCal_(), bpp::MixtureProcessPhyloLikelihood::MixtureProcessPhyloLikelihood(), OneProcessSequencePhyloLikelihood(), and bpp::PartitionProcessPhyloLikelihood::PartitionProcessPhyloLikelihood().
|
inlineoverridevirtualinherited |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 75 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::context_.
|
pure virtualinherited |
Implemented in bpp::AbstractPhyloLikelihood.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 115 of file AbstractPhyloLikelihood.h.
|
inlineoverridevirtualinherited |
Tell if derivatives must be computed: for Function inheritance.
Implements bpp::SecondOrderDerivable.
Definition at line 113 of file AbstractPhyloLikelihood.h.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 116 of file AbstractPhyloLikelihood.h.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 114 of file AbstractPhyloLikelihood.h.
|
inlineoverrideprotectedvirtualinherited |
Reimplemented from bpp::AbstractParametrizable.
Reimplemented in bpp::AutoCorrelationProcessPhyloLikelihood, and bpp::HmmProcessPhyloLikelihood.
Definition at line 157 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
Referenced by bpp::AutoCorrelationProcessPhyloLikelihood::fireParameterChanged(), and bpp::HmmProcessPhyloLikelihood::fireParameterChanged().
|
inlineinherited |
Definition at line 139 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::accessVariableNode(), bpp::AbstractPhyloLikelihood::context_, bpp::AbstractPhyloLikelihood::firstOrderDerivativeNodes_, and bpp::AbstractPhyloLikelihood::getLikelihoodNode().
Referenced by bpp::AbstractPhyloLikelihood::getFirstOrderDerivative(), and bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode().
|
inline |
Definition at line 214 of file OneProcessSequencePhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::accessVariableNode(), bpp::AbstractPhyloLikelihood::context_, firstOrderDerivativeVectors_, and getLikelihoodCalculationSingleProcess().
Referenced by getFirstOrderDerivativeVector(), and secondOrderDerivativeVector().
|
inlineoverridevirtual |
Implements bpp::AlignedPhyloLikelihoodInterface.
Definition at line 192 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
|
inlineoverridevirtual |
Get the alphabet associated to the dataset.
Implements bpp::SingleDataPhyloLikelihoodInterface.
Definition at line 131 of file OneProcessSequencePhyloLikelihood.h.
References getLikelihoodCalculationSingleProcess().
|
inlineoverridevirtualinherited |
Get the independent branch lengths parameters.
Implements bpp::PhyloLikelihoodInterface.
Definition at line 184 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
| vector< size_t > OneProcessSequencePhyloLikelihood::getClassWithMaxPostProbPerSite | ( | ) | const |
Definition at line 156 of file OneProcessSequencePhyloLikelihood.cpp.
References getLikelihoodPerSitePerClass(), and bpp::AbstractAlignedPhyloLikelihood::getNumberOfSites().
|
inlineoverridevirtual |
return a pointer to the compressed data.
Implements bpp::SingleDataPhyloLikelihoodInterface.
Definition at line 126 of file OneProcessSequencePhyloLikelihood.h.
References getLikelihoodCalculationSingleProcess().
|
inlineoverridevirtualinherited |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 179 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 131 of file AbstractPhyloLikelihood.h.
References bpp::convert(), and bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode().
|
inline |
Definition at line 209 of file OneProcessSequencePhyloLikelihood.h.
References firstOrderDerivativeVector().
|
inlineoverridevirtual |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 182 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
|
inline |
Definition at line 202 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
Referenced by firstOrderDerivativeVector(), getAlphabet(), getData(), getLikelihoodPerSitePerClass(), getPosteriorProbabilitiesForSitePerClass(), getPosteriorProbabilitiesPerSitePerClass(), and getPosteriorStateFrequencies().
|
inlinevirtualinherited |
Get the likelihood for a site (on uncompressed data)
| site | The site index to analyse. |
Implements bpp::AlignedPhyloLikelihoodInterface.
Definition at line 143 of file AlignedPhyloLikelihood.h.
References bpp::AlignedPhyloLikelihoodInterface::alignedLikelihoodCalculation(), and bpp::AlignedLikelihoodCalculation::getLikelihoodForASite().
|
pure virtualinherited |
Get the likelihood for a site.
| site | The site index to analyse. |
Implemented in bpp::AbstractAlignedPhyloLikelihood.
Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::getLikelihoodForASiteForAPhyloLikelihood().
|
pure virtualinherited |
Implemented in bpp::AbstractPhyloLikelihood.
|
inlineoverridevirtualinherited |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 100 of file AbstractPhyloLikelihood.h.
References bpp::PhyloLikelihoodInterface::getLikelihoodCalculation().
Referenced by bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode(), and bpp::AbstractPhyloLikelihood::getValue().
|
inlinevirtualinherited |
Get the likelihood for each site.
Implements bpp::AlignedPhyloLikelihoodInterface.
Definition at line 167 of file AlignedPhyloLikelihood.h.
References bpp::AlignedPhyloLikelihoodInterface::getAlignedLikelihoodCalculation().
Referenced by bpp::MixtureProcessPhyloLikelihood::getPosteriorProbabilitiesPerSitePerProcess(), getPosteriorRatePerSite(), and bpp::SingleProcessPhyloLikelihood::getPosteriorRatePerSite().
|
pure virtualinherited |
Get the likelihood for each site.
Implemented in bpp::AbstractAlignedPhyloLikelihood.
| VVdouble OneProcessSequencePhyloLikelihood::getLikelihoodPerSitePerClass | ( | ) | const |
Definition at line 85 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::copyEigenToBpp(), and getLikelihoodCalculationSingleProcess().
Referenced by getClassWithMaxPostProbPerSite(), and getPosteriorRatePerSite().
|
inlineinherited |
Get the logarithm of the likelihood for the whole dataset.
Definition at line 66 of file PhyloLikelihood.h.
References bpp::SecondOrderDerivable::getValue().
|
inlinevirtualinherited |
Get the log likelihood for a site, and its derivatives.
| site | The site index to analyse. |
Implements bpp::AlignedPhyloLikelihoodInterface.
Definition at line 154 of file AlignedPhyloLikelihood.h.
References bpp::convert(), bpp::AlignedPhyloLikelihoodInterface::getAlignedLikelihoodCalculation(), and bpp::AbstractAlignedPhyloLikelihood::getLogLikelihoodForASite().
Referenced by bpp::AbstractAlignedPhyloLikelihood::getLogLikelihoodForASite().
|
pure virtualinherited |
Get the log likelihood for a site, and its derivatives.
| site | The site index to analyse. |
Implemented in bpp::AbstractAlignedPhyloLikelihood.
Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::getLogLikelihoodForASiteForAPhyloLikelihood(), and bpp::PhylogeneticsApplicationTools::printAnalysisInformation().
|
inlinevirtualinherited |
Get the number of dataset concerned.
Implements bpp::SingleDataPhyloLikelihoodInterface.
Definition at line 126 of file SingleDataPhyloLikelihood.h.
References bpp::AbstractSingleDataPhyloLikelihood::nData_.
|
pure virtualinherited |
Get the number of dataset concerned.
Implemented in bpp::AbstractSingleDataPhyloLikelihood.
Referenced by bpp::PhylogeneticsApplicationTools::printParameters().
|
inlineoverridevirtualinherited |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 174 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inline |
Get the number of model classes.
Definition at line 157 of file OneProcessSequencePhyloLikelihood.h.
References mSeqEvol_.
Referenced by getPosteriorRatePerSite().
|
inlinevirtualinherited |
Get the number of sites in the dataset.
Implements bpp::AlignedPhyloLikelihoodInterface.
Reimplemented in bpp::OnABranchPhyloLikelihood, bpp::PartitionProcessPhyloLikelihood, and bpp::SingleProcessPhyloLikelihood.
Definition at line 135 of file AlignedPhyloLikelihood.h.
References bpp::AbstractAlignedPhyloLikelihood::nbSites_.
Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::AbstractAlignedPhyloLikelihoodSet(), bpp::AbstractAlignedPhyloLikelihoodSet::addPhyloLikelihood(), getClassWithMaxPostProbPerSite(), bpp::MultiProcessSequencePhyloLikelihood::getLikelihoodPerSitePerProcess(), getPosteriorRatePerSite(), and getPosteriorStateFrequencies().
|
pure virtualinherited |
Get the number of sites in the dataset.
Implemented in bpp::AbstractAlignedPhyloLikelihood, bpp::OnABranchPhyloLikelihood, bpp::PartitionProcessPhyloLikelihood, and bpp::SingleProcessPhyloLikelihood.
Referenced by bpp::HmmPhyloAlphabet::HmmPhyloAlphabet(), and bpp::PhylogeneticsApplicationTools::printAnalysisInformation().
|
inlinevirtualinherited |
Get the number the states.
Implements bpp::SingleDataPhyloLikelihoodInterface.
Definition at line 136 of file SingleDataPhyloLikelihood.h.
References bpp::AbstractSingleDataPhyloLikelihood::nbStates_.
|
pure virtualinherited |
Get the number the states.
Implemented in bpp::AbstractSingleDataPhyloLikelihood.
| Vdouble OneProcessSequencePhyloLikelihood::getPosteriorProbabilitiesForSitePerClass | ( | size_t | pos | ) | const |
Definition at line 95 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::convert(), getLikelihoodCalculationSingleProcess(), and bpp::VectorTools::sum().
| VVdouble OneProcessSequencePhyloLikelihood::getPosteriorProbabilitiesPerSitePerClass | ( | ) | const |
Utilities
Definition at line 123 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::copyBppToEigen(), bpp::copyEigenToBpp(), bpp::numeric::cwise(), getLikelihoodCalculationSingleProcess(), and bpp::ExtendedFloatEigen< R, C, EigenType >::sum().
| Vdouble OneProcessSequencePhyloLikelihood::getPosteriorRatePerSite | ( | ) | const |
Definition at line 171 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::convert(), bpp::DiscreteDistributionInterface::getCategories(), bpp::AbstractAlignedPhyloLikelihood::getLikelihoodPerSite(), getLikelihoodPerSitePerClass(), getNumberOfClasses(), bpp::AbstractAlignedPhyloLikelihood::getNumberOfSites(), bpp::DiscreteDistributionInterface::getProbabilities(), likelihoodCalculationSingleProcess(), bpp::SubstitutionProcessInterface::rateDistribution(), and bpp::LikelihoodCalculationSingleProcess::substitutionProcess().
| Vdouble OneProcessSequencePhyloLikelihood::getPosteriorStateFrequencies | ( | uint | nodeId | ) |
Definition at line 194 of file OneProcessSequencePhyloLikelihood.cpp.
References bpp::copyEigenToBpp(), getLikelihoodCalculationSingleProcess(), bpp::AbstractAlignedPhyloLikelihood::getNumberOfSites(), and bpp::AbstractSingleDataPhyloLikelihood::nbStates_.
|
inlineoverridevirtualinherited |
Get the independent parameters associated to the rate distribution(s).
Implements bpp::PhyloLikelihoodInterface.
Definition at line 194 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtualinherited |
Get the independent parameters associated to the root frequencies(s).
Implements bpp::PhyloLikelihoodInterface.
Definition at line 189 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 155 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::getSecondOrderDerivative().
Referenced by bpp::AbstractPhyloLikelihood::getSecondOrderDerivative().
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 160 of file AbstractPhyloLikelihood.h.
References bpp::convert(), and bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode().
|
inline |
Definition at line 229 of file OneProcessSequencePhyloLikelihood.h.
References getSecondOrderDerivativeVector().
Referenced by getSecondOrderDerivativeVector().
|
inline |
Definition at line 234 of file OneProcessSequencePhyloLikelihood.h.
References secondOrderDerivativeVector().
|
inlineoverridevirtualinherited |
Implements bpp::SequencePhyloLikelihoodInterface.
Definition at line 102 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtualinherited |
Implements bpp::SequencePhyloLikelihoodInterface.
Definition at line 107 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::nSeqEvol_.
|
inlineoverridevirtualinherited |
Get the independent parameters associated to substitution model(s).
Implements bpp::PhyloLikelihoodInterface.
Definition at line 199 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inline |
Definition at line 152 of file OneProcessSequencePhyloLikelihood.h.
References mSeqEvol_.
|
inlinevirtualinherited |
Definition at line 204 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 124 of file AbstractPhyloLikelihood.h.
References bpp::convert(), bpp::AbstractPhyloLikelihood::getLikelihoodNode(), and bpp::AbstractPhyloLikelihood::minusLogLik_.
|
inlineoverridevirtual |
Sets the computeLikelihoods_ to true.
Reimplemented from bpp::AbstractPhyloLikelihood.
Definition at line 118 of file OneProcessSequencePhyloLikelihood.h.
References bpp::LikelihoodCalculation::isInitialized(), and likelihoodCalculationSingleProcess().
|
inlineoverridevirtual |
Implements bpp::PhyloLikelihoodInterface.
Definition at line 177 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
|
inline |
Definition at line 197 of file OneProcessSequencePhyloLikelihood.h.
References likCal_.
Referenced by getPosteriorRatePerSite(), isInitialized(), and setData().
|
inlineprotected |
Definition at line 90 of file OneProcessSequencePhyloLikelihood.h.
References likCal_, mSeqEvol_, and bpp::AbstractParametrizableSequencePhyloLikelihood::operator=().
|
inlineinherited |
Definition at line 168 of file AbstractPhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::accessVariableNode(), bpp::AbstractPhyloLikelihood::context_, bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode(), and bpp::AbstractPhyloLikelihood::secondOrderDerivativeNodes_.
Referenced by bpp::AbstractPhyloLikelihood::getSecondOrderDerivative().
|
inline |
Definition at line 240 of file OneProcessSequencePhyloLikelihood.h.
References bpp::AbstractPhyloLikelihood::accessVariableNode(), bpp::AbstractPhyloLikelihood::context_, firstOrderDerivativeVector(), and secondOrderDerivativeVectors_.
Referenced by getSecondOrderDerivativeVector().
|
inlineoverridevirtualinherited |
The Sequence Evolution.
Implements bpp::SequencePhyloLikelihoodInterface.
Definition at line 97 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
|
inlineoverridevirtual |
Set the dataset for which the likelihood must be evaluated.
| sites | The data set to use. |
| nData | the number of the data |
Reimplemented from bpp::AbstractSingleDataPhyloLikelihood.
Definition at line 112 of file OneProcessSequencePhyloLikelihood.h.
References likelihoodCalculationSingleProcess(), bpp::LikelihoodCalculationSingleProcess::setData(), and bpp::AbstractSingleDataPhyloLikelihood::setData().
|
inlineoverridevirtualinherited |
Reimplemented from bpp::AbstractParametrizable.
Definition at line 168 of file SequencePhyloLikelihood.h.
References bpp::AbstractSequencePhyloLikelihood::seqEvol_.
Referenced by bpp::AutoCorrelationProcessPhyloLikelihood::setNamespace(), and bpp::HmmProcessPhyloLikelihood::setNamespace().
|
inlineinherited |
Definition at line 131 of file SingleDataPhyloLikelihood.h.
References bpp::AbstractSingleDataPhyloLikelihood::nData_.
|
inlineprotectedinherited |
Definition at line 173 of file AlignedPhyloLikelihood.h.
References bpp::AbstractAlignedPhyloLikelihood::nbSites_.
Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::AbstractAlignedPhyloLikelihoodSet(), bpp::AbstractAlignedPhyloLikelihoodSet::addPhyloLikelihood(), and bpp::AbstractSingleDataPhyloLikelihood::setData().
|
inlineoverridevirtualinherited |
Implements bpp::SecondOrderDerivable.
Definition at line 95 of file AbstractPhyloLikelihood.h.
References bpp::SecondOrderDerivable::setParametersValues().
|
inlineinherited |
Share Parameters, that are DF_parameters.
Definition at line 90 of file AbstractPhyloLikelihood.h.
References bpp::SecondOrderDerivable::getParameters_(), and bpp::ParameterList::shareParameters().
Referenced by bpp::AbstractPhyloLikelihood::AbstractPhyloLikelihood(), and bpp::AbstractPhyloLikelihood::operator=().
|
inline |
Get the ParametrizablePhyloTree.
Warning: the branch lengths may not be up to date with those of the LikelihoodCalculationSingleProcess.
Definition at line 150 of file OneProcessSequencePhyloLikelihood.h.
References mSeqEvol_.
|
inline |
Return the ref to the SubstitutionProcess used to build the phylolikelihood.
Warning; the process parameter values may not be up to date with some of the LikelihoodCalculationSingleProcess
Definition at line 166 of file OneProcessSequencePhyloLikelihood.h.
References mSeqEvol_.
|
protectedinherited |
Definition at line 34 of file AbstractPhyloLikelihood.h.
Referenced by bpp::AbstractPhyloLikelihoodSet::addPhyloLikelihood(), bpp::AbstractPhyloLikelihood::context(), bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode(), bpp::OnABranchPhyloLikelihood::firstOrderDerivativeVector(), firstOrderDerivativeVector(), bpp::SingleProcessPhyloLikelihood::firstOrderDerivativeVector(), bpp::PhyloLikelihoodFormula::makeLikelihoodsFromOperator(), bpp::AbstractPhyloLikelihood::operator=(), bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode(), bpp::OnABranchPhyloLikelihood::secondOrderDerivativeVector(), secondOrderDerivativeVector(), and bpp::SingleProcessPhyloLikelihood::secondOrderDerivativeVector().
|
mutableprotectedinherited |
For Dataflow computing.
Definition at line 44 of file AbstractPhyloLikelihood.h.
Referenced by bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode().
|
mutableprivate |
For Dataflow computing.
Definition at line 49 of file OneProcessSequencePhyloLikelihood.h.
Referenced by firstOrderDerivativeVector().
|
mutableprotected |
Definition at line 56 of file OneProcessSequencePhyloLikelihood.h.
Referenced by alignedLikelihoodCalculation(), getAlignedLikelihoodCalculation(), getLikelihoodCalculation(), getLikelihoodCalculationSingleProcess(), likelihoodCalculation(), likelihoodCalculationSingleProcess(), OneProcessSequencePhyloLikelihood(), and operator=().
|
mutableprotectedinherited |
the value
Definition at line 39 of file AbstractPhyloLikelihood.h.
Referenced by bpp::AbstractPhyloLikelihood::getValue(), and bpp::AbstractPhyloLikelihood::operator=().
|
private |
to avoid the dynamic casts
Definition at line 44 of file OneProcessSequencePhyloLikelihood.h.
Referenced by getNumberOfClasses(), getSubstitutionProcess(), operator=(), substitutionProcess(), and tree().
|
protectedinherited |
Definition at line 111 of file AlignedPhyloLikelihood.h.
Referenced by bpp::AlignedPhyloLikelihoodMixture::AlignedPhyloLikelihoodMixture(), bpp::AbstractAlignedPhyloLikelihood::getNumberOfSites(), bpp::MixtureProcessPhyloLikelihood::getPosteriorProbabilitiesPerSitePerProcess(), bpp::AbstractAlignedPhyloLikelihood::operator=(), and bpp::AbstractAlignedPhyloLikelihood::setNumberOfSites().
|
protectedinherited |
Definition at line 87 of file SingleDataPhyloLikelihood.h.
Referenced by bpp::AbstractSingleDataPhyloLikelihood::getNumberOfStates(), getPosteriorStateFrequencies(), bpp::SingleProcessPhyloLikelihood::getPosteriorStateFrequencies(), bpp::AbstractSingleDataPhyloLikelihood::operator=(), and bpp::AbstractSingleDataPhyloLikelihood::setData().
|
protectedinherited |
Number of the concerned data.
Definition at line 92 of file SingleDataPhyloLikelihood.h.
Referenced by bpp::AbstractSingleDataPhyloLikelihood::getNData(), bpp::AbstractSingleDataPhyloLikelihood::operator=(), bpp::AbstractSingleDataPhyloLikelihood::setData(), and bpp::AbstractSingleDataPhyloLikelihood::setNData().
|
protectedinherited |
the Sequence Evolution number
Definition at line 62 of file SequencePhyloLikelihood.h.
Referenced by bpp::AbstractSequencePhyloLikelihood::getSequenceEvolutionNumber(), and bpp::AbstractSequencePhyloLikelihood::operator=().
|
mutableprotectedinherited |
Definition at line 48 of file AbstractPhyloLikelihood.h.
Referenced by bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode().
|
mutableprivate |
Definition at line 53 of file OneProcessSequencePhyloLikelihood.h.
Referenced by secondOrderDerivativeVector().
|
protectedinherited |
the Sequence Evolution
Definition at line 57 of file SequencePhyloLikelihood.h.
Referenced by bpp::AbstractParametrizableSequencePhyloLikelihood::fireParameterChanged(), bpp::AbstractSequencePhyloLikelihood::getAlphabet(), bpp::AbstractParametrizableSequencePhyloLikelihood::getBranchLengthParameters(), bpp::AbstractParametrizableSequencePhyloLikelihood::getDerivableParameters(), bpp::AbstractParametrizableSequencePhyloLikelihood::getNonDerivableParameters(), bpp::AbstractParametrizableSequencePhyloLikelihood::getRateDistributionParameters(), bpp::AbstractParametrizableSequencePhyloLikelihood::getRootFrequenciesParameters(), bpp::AbstractSequencePhyloLikelihood::getSequenceEvolution(), bpp::AbstractParametrizableSequencePhyloLikelihood::getSubstitutionModelParameters(), bpp::AbstractParametrizableSequencePhyloLikelihood::getSubstitutionProcessParameters(), bpp::AbstractSequencePhyloLikelihood::operator=(), bpp::AbstractSequencePhyloLikelihood::sequenceEvolution(), and bpp::AbstractParametrizableSequencePhyloLikelihood::setNamespace().