bpp-phyl3  3.0.0
bpp::OneProcessSequencePhyloLikelihood Class Referenceabstract

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 ()
 
LikelihoodCalculationlikelihoodCalculation () const override
 
std::shared_ptr< LikelihoodCalculationgetLikelihoodCalculation () const override
 
AlignedLikelihoodCalculationalignedLikelihoodCalculation () const override
 
std::shared_ptr< AlignedLikelihoodCalculationgetAlignedLikelihoodCalculation () const override
 
LikelihoodCalculationSingleProcesslikelihoodCalculationSingleProcess () const
 
std::shared_ptr< LikelihoodCalculationSingleProcessgetLikelihoodCalculationSingleProcess () const
 
ValueRef< RowLikgetFirstOrderDerivativeVector (const std::string &variable) const
 
ValueRef< RowLikfirstOrderDerivativeVector (const std::string &variable) const
 
ValueRef< RowLikgetSecondOrderDerivativeVector (const std::string &variable) const
 
ValueRef< RowLikgetSecondOrderDerivativeVector (const std::string &variable1, const std::string &variable2) const
 
ValueRef< RowLiksecondOrderDerivativeVector (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 SequenceEvolutionsequenceEvolution () const override
 The Sequence Evolution. More...
 
std::shared_ptr< const SequenceEvolutiongetSequenceEvolution () 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 Contextcontext () const override
 
Contextcontext () override
 
ValueRef< DataLikgetLikelihoodNode () 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 &parameters)
 
virtual double d2f (const std::string &variable1, const std::string &variable2, const ParameterList &parameters)
 
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 &parameters)
 
virtual void setParameters (const ParameterList &parameters)=0
 
void setParameters (const ParameterList &parameters) override
 
virtual double getValue () const=0
 
double getValue () const override
 
virtual double f (const ParameterList &parameters)
 
virtual bool hasParameter (const std::string &name) const=0
 
bool hasParameter (const std::string &name) const override
 
virtual const ParameterListgetParameters () const=0
 
const ParameterListgetParameters () const override
 
virtual const Parameterparameter (const std::string &name) const=0
 
const Parameterparameter (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 &parameters)=0
 
void setAllParametersValues (const ParameterList &parameters) 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 &parameters)=0
 
void setParametersValues (const ParameterList &parameters) override
 
virtual bool matchParametersValues (const ParameterList &parameters)=0
 
bool matchParametersValues (const ParameterList &parameters) 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< DataLikfirstOrderDerivativeNode (const std::string &variable) const
 
ValueRef< DataLiksecondOrderDerivativeNode (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 AlignmentDataInterfacegetData () const override
 return a pointer to the compressed data. More...
 
std::shared_ptr< const AlphabetgetAlphabet () const override
 Get the alphabet associated to the dataset. More...
 
Handling of substitution process
const SubstitutionProcessInterfacesubstitutionProcess () const
 Get the ParametrizablePhyloTree. More...
 
std::shared_ptr< const SubstitutionProcessInterfacegetSubstitutionProcess () const
 
size_t getNumberOfClasses () const
 Get the number of model classes. More...
 
std::shared_ptr< const ParametrizablePhyloTreetree () 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 Contextcontext () const =0
 
virtual Contextcontext ()=0
 
The likelihood functions.
virtual ValueRef< DataLikgetLikelihoodNode () const =0
 
double getLogLikelihood () const
 Get the logarithm of the likelihood for the whole dataset. More...
 

Protected Member Functions

 OneProcessSequencePhyloLikelihood (const OneProcessSequencePhyloLikelihood &lik)
 
OneProcessSequencePhyloLikelihoodoperator= (const OneProcessSequencePhyloLikelihood &lik)
 
OneProcessSequencePhyloLikelihoodclone () const override
 
virtual void fireParameterChanged (const ParameterList &parameters) override
 
virtual ParameterListgetParameters_ ()=0
 
ParameterListgetParameters_ () override
 
void setNumberOfSites (size_t nbSites)
 
Node_DFaccessVariableNode (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 &parameters)
 
virtual void shareParameter_ (const std::shared_ptr< Parameter > &parameter)
 
virtual void shareParameters_ (const ParameterList &parameters)
 
virtual void includeParameters_ (const ParameterList &parameters)
 
virtual void deleteParameter_ (size_t index)
 
virtual void deleteParameter_ (std::string &name)
 
virtual void deleteParameters_ (const std::vector< std::string > &names)
 
void resetParameters_ ()
 
ParametergetParameter_ (const std::string &name)
 
ParametergetParameter_ (size_t index)
 
const ParametergetParameter_ (size_t index) const
 
ParametergetParameterWithNamespace_ (const std::string &name)
 
const ParametergetParameterWithNamespace_ (const std::string &name) const
 

Static Protected Member Functions

static Node_DFaccessVariableNode (const Parameter &param)
 

Protected Attributes

std::shared_ptr< LikelihoodCalculationSingleProcesslikCal_
 
std::shared_ptr< SequenceEvolutionseqEvol_
 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_
 
Contextcontext_
 
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 >, StringPairHashsecondOrderDerivativeNodes_
 

Private Attributes

std::shared_ptr< OneProcessSequenceEvolutionmSeqEvol_
 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 >, StringPairHashsecondOrderDerivativeVectors_
 
ParameterList parameters_
 
std::string prefix_
 

Detailed Description

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.

Constructor & Destructor Documentation

◆ OneProcessSequencePhyloLikelihood() [1/4]

OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood ( Context context,
std::shared_ptr< OneProcessSequenceEvolution evol,
size_t  nSeqEvol = 0 
)

◆ OneProcessSequencePhyloLikelihood() [2/4]

OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood ( Context context,
std::shared_ptr< const AlignmentDataInterface data,
std::shared_ptr< OneProcessSequenceEvolution evol,
size_t  nSeqEvol = 0,
size_t  nData = 0 
)

◆ OneProcessSequencePhyloLikelihood() [3/4]

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 
)

◆ OneProcessSequencePhyloLikelihood() [4/4]

bpp::OneProcessSequencePhyloLikelihood::OneProcessSequencePhyloLikelihood ( const OneProcessSequencePhyloLikelihood lik)
inlineprotected

Definition at line 79 of file OneProcessSequencePhyloLikelihood.h.

◆ ~OneProcessSequencePhyloLikelihood()

virtual bpp::OneProcessSequencePhyloLikelihood::~OneProcessSequencePhyloLikelihood ( )
inlinevirtual

Definition at line 104 of file OneProcessSequencePhyloLikelihood.h.

Member Function Documentation

◆ accessVariableNode() [1/2]

◆ accessVariableNode() [2/2]

Node_DF& bpp::AbstractPhyloLikelihood::accessVariableNode ( const std::string &  name) const
inlineprotectedinherited

◆ alignedLikelihoodCalculation()

AlignedLikelihoodCalculation& bpp::OneProcessSequencePhyloLikelihood::alignedLikelihoodCalculation ( ) const
inlineoverridevirtual
Returns
The LikelihoodCalculation.

Implements bpp::AlignedPhyloLikelihoodInterface.

Definition at line 187 of file OneProcessSequencePhyloLikelihood.h.

References likCal_.

◆ clone()

OneProcessSequencePhyloLikelihood* bpp::OneProcessSequencePhyloLikelihood::clone ( ) const
inlineoverrideprotectedvirtual

◆ context() [1/4]

virtual const Context& bpp::PhyloLikelihoodInterface::context ( ) const
pure virtualinherited

◆ context() [2/4]

◆ context() [3/4]

Context& bpp::AbstractPhyloLikelihood::context ( )
inlineoverridevirtualinherited

◆ context() [4/4]

virtual Context& bpp::PhyloLikelihoodInterface::context ( )
pure virtualinherited

◆ enableFirstOrderDerivatives() [1/2]

bool bpp::AbstractPhyloLikelihood::enableFirstOrderDerivatives ( ) const
inlineoverridevirtualinherited

Implements bpp::SecondOrderDerivable.

Definition at line 115 of file AbstractPhyloLikelihood.h.

◆ enableFirstOrderDerivatives() [2/2]

virtual void bpp::AbstractPhyloLikelihood::enableFirstOrderDerivatives ( bool  yn)
inlineoverridevirtualinherited

Tell if derivatives must be computed: for Function inheritance.

Implements bpp::SecondOrderDerivable.

Definition at line 113 of file AbstractPhyloLikelihood.h.

◆ enableSecondOrderDerivatives() [1/2]

bool bpp::AbstractPhyloLikelihood::enableSecondOrderDerivatives ( ) const
inlineoverridevirtualinherited

Implements bpp::SecondOrderDerivable.

Definition at line 116 of file AbstractPhyloLikelihood.h.

◆ enableSecondOrderDerivatives() [2/2]

virtual void bpp::AbstractPhyloLikelihood::enableSecondOrderDerivatives ( bool  yn)
inlineoverridevirtualinherited

Implements bpp::SecondOrderDerivable.

Definition at line 114 of file AbstractPhyloLikelihood.h.

◆ fireParameterChanged()

virtual void bpp::AbstractParametrizableSequencePhyloLikelihood::fireParameterChanged ( const ParameterList parameters)
inlineoverrideprotectedvirtualinherited

◆ firstOrderDerivativeNode()

◆ firstOrderDerivativeVector()

ValueRef<RowLik> bpp::OneProcessSequencePhyloLikelihood::firstOrderDerivativeVector ( const std::string &  variable) const
inline

◆ getAlignedLikelihoodCalculation()

std::shared_ptr<AlignedLikelihoodCalculation> bpp::OneProcessSequencePhyloLikelihood::getAlignedLikelihoodCalculation ( ) const
inlineoverridevirtual
Returns
A shared pointer toward the LikelihoodCalculation.

Implements bpp::AlignedPhyloLikelihoodInterface.

Definition at line 192 of file OneProcessSequencePhyloLikelihood.h.

References likCal_.

◆ getAlphabet()

std::shared_ptr<const Alphabet> bpp::OneProcessSequencePhyloLikelihood::getAlphabet ( ) const
inlineoverridevirtual

Get the alphabet associated to the dataset.

Returns
the alphabet associated to the dataset.

Implements bpp::SingleDataPhyloLikelihoodInterface.

Definition at line 131 of file OneProcessSequencePhyloLikelihood.h.

References getLikelihoodCalculationSingleProcess().

◆ getBranchLengthParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getBranchLengthParameters ( ) const
inlineoverridevirtualinherited

Get the independent branch lengths parameters.

Returns
A ParameterList with all branch lengths.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 184 of file SequencePhyloLikelihood.h.

References bpp::AbstractSequencePhyloLikelihood::seqEvol_.

◆ getClassWithMaxPostProbPerSite()

vector< size_t > OneProcessSequencePhyloLikelihood::getClassWithMaxPostProbPerSite ( ) const

◆ getData()

std::shared_ptr<const AlignmentDataInterface> bpp::OneProcessSequencePhyloLikelihood::getData ( ) const
inlineoverridevirtual

return a pointer to the compressed data.

Implements bpp::SingleDataPhyloLikelihoodInterface.

Definition at line 126 of file OneProcessSequencePhyloLikelihood.h.

References getLikelihoodCalculationSingleProcess().

◆ getDerivableParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getDerivableParameters ( ) const
inlineoverridevirtualinherited

◆ getFirstOrderDerivative()

double bpp::AbstractPhyloLikelihood::getFirstOrderDerivative ( const std::string &  variable) const
inlineoverridevirtualinherited

◆ getFirstOrderDerivativeVector()

ValueRef<RowLik> bpp::OneProcessSequencePhyloLikelihood::getFirstOrderDerivativeVector ( const std::string &  variable) const
inline

Definition at line 209 of file OneProcessSequencePhyloLikelihood.h.

References firstOrderDerivativeVector().

◆ getLikelihoodCalculation()

std::shared_ptr<LikelihoodCalculation> bpp::OneProcessSequencePhyloLikelihood::getLikelihoodCalculation ( ) const
inlineoverridevirtual
Returns
A shared pointer toward the LikelihoodCalculation.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 182 of file OneProcessSequencePhyloLikelihood.h.

References likCal_.

◆ getLikelihoodCalculationSingleProcess()

std::shared_ptr<LikelihoodCalculationSingleProcess> bpp::OneProcessSequencePhyloLikelihood::getLikelihoodCalculationSingleProcess ( ) const
inline

◆ getLikelihoodForASite() [1/2]

DataLik bpp::AbstractAlignedPhyloLikelihood::getLikelihoodForASite ( size_t  site) const
inlinevirtualinherited

Get the likelihood for a site (on uncompressed data)

Parameters
siteThe site index to analyse.
Returns
The likelihood for site site.

Implements bpp::AlignedPhyloLikelihoodInterface.

Definition at line 143 of file AlignedPhyloLikelihood.h.

References bpp::AlignedPhyloLikelihoodInterface::alignedLikelihoodCalculation(), and bpp::AlignedLikelihoodCalculation::getLikelihoodForASite().

◆ getLikelihoodForASite() [2/2]

virtual DataLik bpp::AlignedPhyloLikelihoodInterface::getLikelihoodForASite ( size_t  site) const
pure virtualinherited

Get the likelihood for a site.

Parameters
siteThe site index to analyse.
Returns
The likelihood for site site.

Implemented in bpp::AbstractAlignedPhyloLikelihood.

Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::getLikelihoodForASiteForAPhyloLikelihood().

◆ getLikelihoodNode() [1/2]

virtual ValueRef<DataLik> bpp::PhyloLikelihoodInterface::getLikelihoodNode ( ) const
pure virtualinherited
Returns
the LikDF node where the Likelihood is computed.

Implemented in bpp::AbstractPhyloLikelihood.

◆ getLikelihoodNode() [2/2]

ValueRef<DataLik> bpp::AbstractPhyloLikelihood::getLikelihoodNode ( ) const
inlineoverridevirtualinherited

◆ getLikelihoodPerSite() [1/2]

VDataLik bpp::AbstractAlignedPhyloLikelihood::getLikelihoodPerSite ( ) const
inlinevirtualinherited

◆ getLikelihoodPerSite() [2/2]

virtual VDataLik bpp::AlignedPhyloLikelihoodInterface::getLikelihoodPerSite ( ) const
pure virtualinherited

Get the likelihood for each site.

Returns
A vector with all site likelihoods.

Implemented in bpp::AbstractAlignedPhyloLikelihood.

◆ getLikelihoodPerSitePerClass()

VVdouble OneProcessSequencePhyloLikelihood::getLikelihoodPerSitePerClass ( ) const

◆ getLogLikelihood()

double bpp::PhyloLikelihoodInterface::getLogLikelihood ( ) const
inlineinherited

Get the logarithm of the likelihood for the whole dataset.

Returns
The logarithm of the likelihood of the dataset.

Definition at line 66 of file PhyloLikelihood.h.

References bpp::SecondOrderDerivable::getValue().

◆ getLogLikelihoodForASite() [1/2]

double bpp::AbstractAlignedPhyloLikelihood::getLogLikelihoodForASite ( size_t  site) const
inlinevirtualinherited

Get the log likelihood for a site, and its derivatives.

Parameters
siteThe site index to analyse.
Returns
The (D)log likelihood for site site.

Implements bpp::AlignedPhyloLikelihoodInterface.

Definition at line 154 of file AlignedPhyloLikelihood.h.

References bpp::convert(), and bpp::AlignedPhyloLikelihoodInterface::getAlignedLikelihoodCalculation().

◆ getLogLikelihoodForASite() [2/2]

virtual double bpp::AlignedPhyloLikelihoodInterface::getLogLikelihoodForASite ( size_t  site) const
pure virtualinherited

Get the log likelihood for a site, and its derivatives.

Parameters
siteThe site index to analyse.
Returns
The (D)log likelihood for site site.

Implemented in bpp::AbstractAlignedPhyloLikelihood.

Referenced by bpp::AbstractAlignedPhyloLikelihoodSet::getLogLikelihoodForASiteForAPhyloLikelihood(), and bpp::PhylogeneticsApplicationTools::printAnalysisInformation().

◆ getNData() [1/2]

size_t bpp::AbstractSingleDataPhyloLikelihood::getNData ( ) const
inlinevirtualinherited

Get the number of dataset concerned.

Implements bpp::SingleDataPhyloLikelihoodInterface.

Definition at line 126 of file SingleDataPhyloLikelihood.h.

References bpp::AbstractSingleDataPhyloLikelihood::nData_.

◆ getNData() [2/2]

virtual size_t bpp::SingleDataPhyloLikelihoodInterface::getNData ( ) const
pure virtualinherited

Get the number of dataset concerned.

Implemented in bpp::AbstractSingleDataPhyloLikelihood.

Referenced by bpp::PhylogeneticsApplicationTools::printParameters().

◆ getNonDerivableParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getNonDerivableParameters ( ) const
inlineoverridevirtualinherited

◆ getNumberOfClasses()

size_t bpp::OneProcessSequencePhyloLikelihood::getNumberOfClasses ( ) const
inline

Get the number of model classes.

Definition at line 157 of file OneProcessSequencePhyloLikelihood.h.

References mSeqEvol_.

Referenced by getPosteriorRatePerSite().

◆ getNumberOfSites() [1/2]

◆ getNumberOfSites() [2/2]

virtual size_t bpp::AlignedPhyloLikelihoodInterface::getNumberOfSites ( ) const
pure virtualinherited

◆ getNumberOfStates() [1/2]

size_t bpp::AbstractSingleDataPhyloLikelihood::getNumberOfStates ( ) const
inlinevirtualinherited

Get the number the states.

Implements bpp::SingleDataPhyloLikelihoodInterface.

Definition at line 136 of file SingleDataPhyloLikelihood.h.

References bpp::AbstractSingleDataPhyloLikelihood::nbStates_.

◆ getNumberOfStates() [2/2]

virtual size_t bpp::SingleDataPhyloLikelihoodInterface::getNumberOfStates ( ) const
pure virtualinherited

Get the number the states.

Implemented in bpp::AbstractSingleDataPhyloLikelihood.

◆ getPosteriorProbabilitiesForSitePerClass()

Vdouble OneProcessSequencePhyloLikelihood::getPosteriorProbabilitiesForSitePerClass ( size_t  pos) const

◆ getPosteriorProbabilitiesPerSitePerClass()

VVdouble OneProcessSequencePhyloLikelihood::getPosteriorProbabilitiesPerSitePerClass ( ) const

◆ getPosteriorRatePerSite()

◆ getPosteriorStateFrequencies()

◆ getRateDistributionParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getRateDistributionParameters ( ) const
inlineoverridevirtualinherited

Get the independent parameters associated to the rate distribution(s).

Returns
A ParameterList.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 194 of file SequencePhyloLikelihood.h.

References bpp::AbstractSequencePhyloLikelihood::seqEvol_.

◆ getRootFrequenciesParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getRootFrequenciesParameters ( ) const
inlineoverridevirtualinherited

Get the independent parameters associated to the root frequencies(s).

Returns
A ParameterList.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 189 of file SequencePhyloLikelihood.h.

References bpp::AbstractSequencePhyloLikelihood::seqEvol_.

◆ getSecondOrderDerivative() [1/2]

double bpp::AbstractPhyloLikelihood::getSecondOrderDerivative ( const std::string &  variable) const
inlineoverridevirtualinherited

Implements bpp::SecondOrderDerivable.

Definition at line 155 of file AbstractPhyloLikelihood.h.

◆ getSecondOrderDerivative() [2/2]

double bpp::AbstractPhyloLikelihood::getSecondOrderDerivative ( const std::string &  variable1,
const std::string &  variable2 
) const
inlineoverridevirtualinherited

◆ getSecondOrderDerivativeVector() [1/2]

ValueRef<RowLik> bpp::OneProcessSequencePhyloLikelihood::getSecondOrderDerivativeVector ( const std::string &  variable) const
inline

Definition at line 229 of file OneProcessSequencePhyloLikelihood.h.

◆ getSecondOrderDerivativeVector() [2/2]

ValueRef<RowLik> bpp::OneProcessSequencePhyloLikelihood::getSecondOrderDerivativeVector ( const std::string &  variable1,
const std::string &  variable2 
) const
inline

◆ getSequenceEvolution()

std::shared_ptr<const SequenceEvolution> bpp::AbstractSequencePhyloLikelihood::getSequenceEvolution ( ) const
inlineoverridevirtualinherited

◆ getSequenceEvolutionNumber()

const size_t bpp::AbstractSequencePhyloLikelihood::getSequenceEvolutionNumber ( ) const
inlineoverridevirtualinherited

◆ getSubstitutionModelParameters()

ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getSubstitutionModelParameters ( ) const
inlineoverridevirtualinherited

Get the independent parameters associated to substitution model(s).

Returns
A ParameterList.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 199 of file SequencePhyloLikelihood.h.

References bpp::AbstractSequencePhyloLikelihood::seqEvol_.

◆ getSubstitutionProcess()

std::shared_ptr<const SubstitutionProcessInterface> bpp::OneProcessSequencePhyloLikelihood::getSubstitutionProcess ( ) const
inline

Definition at line 152 of file OneProcessSequencePhyloLikelihood.h.

References mSeqEvol_.

◆ getSubstitutionProcessParameters()

virtual ParameterList bpp::AbstractParametrizableSequencePhyloLikelihood::getSubstitutionProcessParameters ( ) const
inlinevirtualinherited

◆ getValue()

double bpp::AbstractPhyloLikelihood::getValue ( ) const
inlineoverridevirtualinherited

◆ isInitialized()

bool bpp::OneProcessSequencePhyloLikelihood::isInitialized ( ) const
inlineoverridevirtual

Sets the computeLikelihoods_ to true.

Reimplemented from bpp::AbstractPhyloLikelihood.

Definition at line 118 of file OneProcessSequencePhyloLikelihood.h.

References bpp::LikelihoodCalculation::isInitialized(), and likelihoodCalculationSingleProcess().

◆ likelihoodCalculation()

LikelihoodCalculation& bpp::OneProcessSequencePhyloLikelihood::likelihoodCalculation ( ) const
inlineoverridevirtual
Returns
The underlying likelihood computation structure.

Implements bpp::PhyloLikelihoodInterface.

Definition at line 177 of file OneProcessSequencePhyloLikelihood.h.

References likCal_.

◆ likelihoodCalculationSingleProcess()

LikelihoodCalculationSingleProcess& bpp::OneProcessSequencePhyloLikelihood::likelihoodCalculationSingleProcess ( ) const
inline

Definition at line 197 of file OneProcessSequencePhyloLikelihood.h.

References likCal_.

Referenced by getPosteriorRatePerSite(), isInitialized(), and setData().

◆ operator=()

OneProcessSequencePhyloLikelihood& bpp::OneProcessSequencePhyloLikelihood::operator= ( const OneProcessSequencePhyloLikelihood lik)
inlineprotected

◆ secondOrderDerivativeNode()

ValueRef<DataLik> bpp::AbstractPhyloLikelihood::secondOrderDerivativeNode ( const std::string &  variable1,
const std::string &  variable2 
) const
inlineinherited

◆ secondOrderDerivativeVector()

ValueRef<RowLik> bpp::OneProcessSequencePhyloLikelihood::secondOrderDerivativeVector ( const std::string &  variable1,
const std::string &  variable2 
) const
inline

◆ sequenceEvolution()

const SequenceEvolution& bpp::AbstractSequencePhyloLikelihood::sequenceEvolution ( ) const
inlineoverridevirtualinherited

◆ setData()

void bpp::OneProcessSequencePhyloLikelihood::setData ( std::shared_ptr< const AlignmentDataInterface sites,
size_t  nData = 0 
)
inlineoverridevirtual

Set the dataset for which the likelihood must be evaluated.

Parameters
sitesThe data set to use.
nDatathe 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().

◆ setNamespace()

void bpp::AbstractParametrizableSequencePhyloLikelihood::setNamespace ( const std::string &  nameSpace)
inlineoverridevirtualinherited

◆ setNData()

void bpp::AbstractSingleDataPhyloLikelihood::setNData ( size_t  nData)
inlineinherited

◆ setNumberOfSites()

void bpp::AbstractAlignedPhyloLikelihood::setNumberOfSites ( size_t  nbSites)
inlineprotectedinherited

◆ setParameters()

void bpp::AbstractPhyloLikelihood::setParameters ( const ParameterList parameters)
inlineoverridevirtualinherited

◆ shareParameters()

void bpp::AbstractPhyloLikelihood::shareParameters ( const ParameterList variableNodes)
inlineinherited

◆ substitutionProcess()

const SubstitutionProcessInterface& bpp::OneProcessSequencePhyloLikelihood::substitutionProcess ( ) const
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_.

◆ tree()

std::shared_ptr<const ParametrizablePhyloTree> bpp::OneProcessSequencePhyloLikelihood::tree ( ) const
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_.

Member Data Documentation

◆ context_

◆ firstOrderDerivativeNodes_

std::unordered_map<std::string, ValueRef<DataLik> > bpp::AbstractPhyloLikelihood::firstOrderDerivativeNodes_
mutableprotectedinherited

For Dataflow computing.

Definition at line 44 of file AbstractPhyloLikelihood.h.

Referenced by bpp::AbstractPhyloLikelihood::firstOrderDerivativeNode().

◆ firstOrderDerivativeVectors_

std::unordered_map<std::string, ValueRef<RowLik> > bpp::OneProcessSequencePhyloLikelihood::firstOrderDerivativeVectors_
mutableprivate

For Dataflow computing.

Definition at line 49 of file OneProcessSequencePhyloLikelihood.h.

Referenced by firstOrderDerivativeVector().

◆ likCal_

◆ minusLogLik_

DataLik bpp::AbstractPhyloLikelihood::minusLogLik_
mutableprotectedinherited

◆ mSeqEvol_

std::shared_ptr<OneProcessSequenceEvolution> bpp::OneProcessSequencePhyloLikelihood::mSeqEvol_
private

to avoid the dynamic casts

Definition at line 44 of file OneProcessSequencePhyloLikelihood.h.

Referenced by getNumberOfClasses(), getSubstitutionProcess(), operator=(), substitutionProcess(), and tree().

◆ nbSites_

◆ nbStates_

◆ nData_

◆ nSeqEvol_

size_t bpp::AbstractSequencePhyloLikelihood::nSeqEvol_
protectedinherited

◆ secondOrderDerivativeNodes_

std::unordered_map<std::pair<std::string, std::string>, ValueRef<DataLik>, StringPairHash> bpp::AbstractPhyloLikelihood::secondOrderDerivativeNodes_
mutableprotectedinherited

◆ secondOrderDerivativeVectors_

std::unordered_map<std::pair<std::string, std::string>, ValueRef<RowLik>, StringPairHash> bpp::OneProcessSequencePhyloLikelihood::secondOrderDerivativeVectors_
mutableprivate

Definition at line 53 of file OneProcessSequencePhyloLikelihood.h.

Referenced by secondOrderDerivativeVector().

◆ seqEvol_


The documentation for this class was generated from the following files: