bpp-phyl  2.2.0
bpp::RNonHomogeneousMixedTreeLikelihood Class Referenceabstract

#include <Bpp/Phyl/Likelihood/RNonHomogeneousMixedTreeLikelihood.h>

+ Inheritance diagram for bpp::RNonHomogeneousMixedTreeLikelihood:
+ Collaboration diagram for bpp::RNonHomogeneousMixedTreeLikelihood:

Public Member Functions

 RNonHomogeneousMixedTreeLikelihood (const Tree &tree, MixedSubstitutionModelSet *modelSet, DiscreteDistribution *rDist, bool verbose=true, bool usePatterns=true) throw (Exception)
 Build a new RNonHomogeneousMixeTreeLikelihood object without data. More...
 
 RNonHomogeneousMixedTreeLikelihood (const Tree &tree, const SiteContainer &data, MixedSubstitutionModelSet *modelSet, DiscreteDistribution *rDist, bool verbose=true, bool usePatterns=true) throw (Exception)
 Build a new RNonHomogeneousMixedTreeLikelihood object and compute the corresponding likelihood. More...
 
 RNonHomogeneousMixedTreeLikelihood (const RNonHomogeneousMixedTreeLikelihood &lik)
 
RNonHomogeneousMixedTreeLikelihoodoperator= (const RNonHomogeneousMixedTreeLikelihood &lik)
 
virtual ~RNonHomogeneousMixedTreeLikelihood ()
 
RNonHomogeneousMixedTreeLikelihoodclone () const
 
void setParameters (const ParameterList &parameters) throw (ParameterNotFoundException, ConstraintException)
 Implements the Function interface. More...
 
double getValue () const throw (Exception)
 
DRASRTreeLikelihoodDatagetLikelihoodData ()
 
const DRASRTreeLikelihoodDatagetLikelihoodData () const
 
virtual void computeTreeLikelihood ()
 
virtual double getDLikelihoodForASiteForARateClass (size_t site, size_t rateClass) const
 
virtual double getDLikelihoodForASite (size_t site) const
 
virtual double getDLogLikelihoodForASite (size_t site) const
 
virtual double getDLogLikelihood () const
 
virtual double getD2LikelihoodForASiteForARateClass (size_t site, size_t rateClass) const
 
virtual double getD2LikelihoodForASite (size_t site) const
 
virtual double getD2LogLikelihoodForASite (size_t site) const
 
virtual double getD2LogLikelihood () const
 
virtual void initParameters ()
 This builds the parameters list from all parametrizable objects, i.e. substitution model, rate distribution and tree. More...
 
virtual void applyParameters () throw (Exception)
 All parameters are stored in a parameter list. This function apply these parameters to the substitution model, to the rate distribution and to the branch lengths. More...
 
virtual void initBranchLengthsParameters ()
 
virtual void setMinimumBranchLength (double minimum) throw (Exception)
 
virtual void setMaximumBranchLength (double maximum) throw (Exception)
 
virtual double getMinimumBranchLength () const
 
virtual double getMaximumBranchLength () const
 
const SubstitutionModelgetSubstitutionModel (int nodeId, size_t siteIndex) const throw (NodeNotFoundException)
 Get the substitution model associated to a given node and alignment column. More...
 
SubstitutionModelgetSubstitutionModel (int nodeId, size_t siteIndex) throw (NodeNotFoundException)
 Get the substitution model associated to a given node and alignment column. More...
 
virtual const SiteContainer * getData () const =0
 Get the dataset for which the likelihood must be evaluated. More...
 
virtual bool isInitialized () const =0
 
virtual double getLikelihoodForASiteForAState (size_t site, int state) const =0
 Get the likelihood for a site and for a state. More...
 
virtual double getLogLikelihoodForASiteForAState (size_t site, int state) const =0
 Get the logarithm of the likelihood for a site and for a state. More...
 
virtual Vdouble getLikelihoodForEachSite () const =0
 Get the likelihood for each site. More...
 
virtual Vdouble getLogLikelihoodForEachSite () const =0
 Get the logarithm of the likelihood for each site. More...
 
virtual VVdouble getLikelihoodForEachSiteForEachState () const =0
 Get the likelihood for each site and for each state. More...
 
virtual VVdouble getLogLikelihoodForEachSiteForEachState () const =0
 Get the logarithm of the likelihood for each site and for each state. More...
 
virtual const TreegetTree () const =0
 Get the tree (topology and branch lengths). More...
 
virtual size_t getNumberOfSites () const =0
 Get the number of sites in the dataset. More...
 
virtual const Alphabet * getAlphabet () const =0
 Get the alphabet associated to the dataset. More...
 
virtual void enableDerivatives (bool yn)=0
 Tell if derivatives must be computed. More...
 
virtual ParameterList getDerivableParameters () const =0
 All derivable parameters. More...
 
virtual ParameterList getNonDerivableParameters () const =0
 All non derivable parameters. More...
 
The TreeLikelihood interface.

Other methods are implemented in the AbstractHomogeneousTreeLikelihood class.

double getLikelihood () const
 Get the likelihood for the whole dataset. More...
 
double getLogLikelihood () const
 Get the logarithm of the likelihood for the whole dataset. More...
 
double getLikelihoodForASite (size_t site) const
 Get the likelihood for a site. More...
 
double getLogLikelihoodForASite (size_t site) const
 Get the logarithm of the likelihood for a site. More...
 
size_t getSiteIndex (size_t site) const throw (IndexOutOfBoundsException)
 Get the index (used for inner computations) of a given site (original alignment column). More...
 
The DiscreteRatesAcrossSites interface implementation:
double getLikelihoodForASiteForARateClass (size_t site, size_t rateClass) const
 Get the likelihood for a site knowing its rate class. More...
 
double getLogLikelihoodForASiteForARateClass (size_t site, size_t rateClass) const
 Get the logarithm of the likelihood for a site knowing its rate class. More...
 
double getLikelihoodForASiteForARateClassForAState (size_t site, size_t rateClass, int state) const
 Get the likelihood for a site knowing its rate class and its ancestral state. More...
 
double getLogLikelihoodForASiteForARateClassForAState (size_t site, size_t rateClass, int state) const
 Get the logarithm of the likelihood for a site knowing its rate class and its ancestral state. More...
 
DerivableFirstOrder interface.
double getFirstOrderDerivative (const std::string &variable) const throw (Exception)
 
DerivableSecondOrder interface.
double getSecondOrderDerivative (const std::string &variable) const throw (Exception)
 
double getSecondOrderDerivative (const std::string &variable1, const std::string &variable2) const throw (Exception)
 
The TreeLikelihood interface.

Other methods are implemented in the AbstractTreeLikelihood class.

size_t getNumberOfStates () const
 
const std::vector< int > & getAlphabetStates () const
 
int getAlphabetStateAsInt (size_t i) const
 
std::string getAlphabetStateAsChar (size_t i) const
 
ParameterList getBranchLengthsParameters () const
 Get the branch lengths parameters. More...
 
ParameterList getSubstitutionModelParameters () const
 Get the parameters associated to substitution model(s). More...
 
ParameterList getRateDistributionParameters () const
 Get the parameters associated to the rate distirbution. More...
 
const SubstitutionModelgetSubstitutionModelForNode (int nodeId) const throw (NodeNotFoundException)
 Get the substitution model associated to a given node. More...
 
SubstitutionModelgetSubstitutionModelForNode (int nodeId) throw (NodeNotFoundException)
 Get the substitution model associated to a given node. More...
 
const std::vector< double > & getRootFrequencies (size_t siteIndex) const
 Get the values of the frequencies for each state in the alphabet at the root node. More...
 
VVVdouble getTransitionProbabilitiesPerRateClass (int nodeId, size_t siteIndex) const
 Retrieves all Pij(t) for a particular branch, defined by the upper node. More...
 
ConstBranchModelIteratorgetNewBranchModelIterator (int nodeId) const
 
ConstSiteModelIteratorgetNewSiteModelIterator (size_t siteIndex) const
 
The NonHomogeneousTreeLikelihood interface.

Other methods are implemented in the AbstractTreeLikelihood class.

const SubstitutionModelSetgetSubstitutionModelSet () const
 
SubstitutionModelSetgetSubstitutionModelSet ()
 
void setSubstitutionModelSet (SubstitutionModelSet *modelSet) throw (Exception)
 
ParameterList getRootFrequenciesParameters () const
 
The TreeLikelihood interface.
const SiteContainer * getData () const
 Get the dataset for which the likelihood must be evaluated. More...
 
bool isInitialized () const
 
Vdouble getLikelihoodForEachSite () const
 Get the likelihood for each site. More...
 
Vdouble getLogLikelihoodForEachSite () const
 Get the logarithm of the likelihood for each site. More...
 
VVdouble getLikelihoodForEachSiteForEachState () const
 Get the likelihood for each site and for each state. More...
 
VVdouble getLogLikelihoodForEachSiteForEachState () const
 Get the logarithm of the likelihood for each site and for each state. More...
 
const TreegetTree () const
 Get the tree (topology and branch lengths). More...
 
size_t getNumberOfSites () const
 Get the number of sites in the dataset. More...
 
const Alphabet * getAlphabet () const
 Get the alphabet associated to the dataset. More...
 
void enableDerivatives (bool yn)
 Tell if derivatives must be computed. More...
 
void enableFirstOrderDerivatives (bool yn)
 
bool enableFirstOrderDerivatives () const
 
void enableSecondOrderDerivatives (bool yn)
 
bool enableSecondOrderDerivatives () const
 
The TreeLikelihood interface.

Other methods are implemented in the AbstractTreeLikelihood class.

double getLikelihoodForASiteForAState (size_t site, int state) const
 Get the likelihood for a site and for a state. More...
 
double getLogLikelihoodForASiteForAState (size_t site, int state) const
 Get the logarithm of the likelihood for a site and for a state. More...
 
VVdouble getTransitionProbabilities (int nodeId, size_t siteIndex) const
 Retrieves all Pij(t) for a particular branch, defined by the upper node and site. More...
 
ParameterList getDerivableParameters () const
 All derivable parameters. More...
 
ParameterList getNonDerivableParameters () const
 All non derivable parameters. More...
 
Retrieve some particular parameters subsets.
virtual VVdouble getTransitionProbabilities (int nodeId, size_t siteIndex) const =0
 Retrieves all Pij(t) for a particular branch, defined by the upper node and site. More...
 
The DiscreteRatesAcrossSites interface implementation:
const DiscreteDistribution * getRateDistribution () const
 Get the rate distribution used for the computation. More...
 
DiscreteDistribution * getRateDistribution ()
 Get the rate distribution used for the computation. More...
 
size_t getNumberOfClasses () const
 Get the number of classes. More...
 
VVdouble getLikelihoodForEachSiteForEachRateClass () const
 Get the likelihood for each site and each rate class. More...
 
VVdouble getLogLikelihoodForEachSiteForEachRateClass () const
 Get the logarithm of the likelihood for each site and each rate class. More...
 
VVVdouble getLikelihoodForEachSiteForEachRateClassForEachState () const
 Get the likelihood for each site and each rate class and each state. More...
 
VVVdouble getLogLikelihoodForEachSiteForEachRateClassForEachState () const
 Get the logarithm of the likelihood for each site and each rate class and each state. More...
 
VVdouble getPosteriorProbabilitiesOfEachRate () const
 Get the posterior probability for each site of belonging to a particular rate class. More...
 
Vdouble getRateWithMaxPostProbOfEachSite () const
 Get the posterior rate (the one with maximum posterior probability) for each site. More...
 
std::vector< size_t > getRateClassWithMaxPostProbOfEachSite () const
 Get the posterior rate class (the one with maximum posterior probability) for each site. More...
 
Vdouble getPosteriorRateOfEachSite () const
 Get the posterior rate, i.e. averaged over all classes and weighted with posterior probabilities, for each site. More...
 

Static Public Member Functions

Generic tools to deal with likelihood arrays
static void resetLikelihoodArray (VVVdouble &likelihoodArray)
 Set all conditional likelihoods to 1. More...
 
static void displayLikelihoodArray (const VVVdouble &likelihoodArray)
 Print the likelihood array to terminal (debugging tool). More...
 

Protected Member Functions

virtual void displayLikelihood (const Node *node)
 This method is mainly for debugging purpose. More...
 
virtual void computeAllTransitionProbabilities ()
 Fill the pxy_, dpxy_ and d2pxy_ arrays for all nodes. More...
 

Protected Attributes

SubstitutionModelSetmodelSet_
 
ParameterList brLenParameters_
 
std::map< int, VVVdouble > pxy_
 
std::map< int, VVVdouble > dpxy_
 
std::map< int, VVVdouble > d2pxy_
 
std::vector< double > rootFreqs_
 
std::vector< Node * > nodes_
 Pointer toward all nodes in the tree. More...
 
std::map< int, const Node * > idToNode_
 An index linking nodes to their id, for faster access than the getNode() method. More...
 
size_t nbSites_
 
size_t nbDistinctSites_
 
size_t nbClasses_
 
size_t nbStates_
 
size_t nbNodes_
 
bool verbose_
 
double minimumBrLen_
 
double maximumBrLen_
 
std::auto_ptr< Constraint > brLenConstraint_
 
bool reparametrizeRoot_
 
int root1_
 
int root2_
 
DiscreteDistribution * rateDistribution_
 
const SiteContainer * data_
 
TreeTemplate< Node > * tree_
 
bool computeFirstOrderDerivatives_
 
bool computeSecondOrderDerivatives_
 
bool initialized_
 

Private Member Functions

 RNonHomogeneousMixedTreeLikelihood (const Tree &tree, MixedSubstitutionModelSet *modelSet, const MixedSubstitutionModelSet::HyperNode &hyperNode, int upperNode, DiscreteDistribution *rDist, bool verbose, bool usePatterns)
 Build a new RNonHomogeneousMixeTreeLikelihood object without data. More...
 
 RNonHomogeneousMixedTreeLikelihood (const Tree &tree, const SiteContainer &data, MixedSubstitutionModelSet *modelSet, const MixedSubstitutionModelSet::HyperNode &hyperNode, int upperNode, DiscreteDistribution *rDist, bool verbose, bool usePatterns)
 Build a new RNonHomogeneousMixeTreeLikelihood object with data. More...
 
void init (bool usePatterns)
 

Private Attributes

map< int, vector< RNonHomogeneousMixedTreeLikelihood * > > mvTreeLikelihoods_
 the map of the branch numbers to the vectors of the TreeLikelihoods for the expanded model on this branch. More...
 
MixedSubstitutionModelSet::HyperNode hyperNode_
 A specific HyperNode in which the computation is processed. If the probability of this HyperNode is -1, it means that it should not be used, and the HyperNodes are all in the MixedSubstitutionModelSet object. More...
 
int upperNode_
 the number of the node under which tree the Treelikelihood is computed. More...
 
bool main_
 a flag to say if this object is the head of the hierarchy More...
 

The TreeLikelihood interface.

Other methods are implemented in the AbstractHomogeneousTreeLikelihood class.

void setData (const SiteContainer &sites) throw (Exception)
 Set the dataset for which the likelihood must be evaluated. More...
 
void initialize () throw (Exception)
 Init the likelihood object. More...
 
void computeTreeDLikelihood (const string &variable)
 
void computeTreeD2Likelihood (const string &variable)
 
double getProbability () const
 returns the probability of this object in the hierarchy More...
 
void setProbability (double x)
 sets the probability of this object in the hierarchy More...
 
const MixedSubstitutionModelSet::HyperNodegetHyperNode ()
 returns the HyperNode describing the owned submodels. More...
 
virtual void computeSubtreeLikelihood (const Node *node)
 Compute the likelihood for a subtree defined by the Tree::Node node. More...
 
virtual void computeDownSubtreeDLikelihood (const Node *)
 
virtual void computeDownSubtreeD2Likelihood (const Node *)
 
void fireParameterChanged (const ParameterList &params)
 
void computeTransitionProbabilitiesForNode (const Node *node)
 Fill the pxy_, dpxy_ and d2pxy_ arrays for one node. More...
 

Detailed Description

@ brief A class to compute the average of several RNonHomogeneousTreeLikelihood defined from a Mixed Substitution Model.

This class is made recursively. At each node, we test if an expansion of a mixed model is necessary. This is the case when this model points towards different subtrees under this node, or towards a son of this node and a branch under it. If an expansion is necessary, a vector of RNonHomogeneousMixedLikelihood* is built with all the submodels combinations.

Note that this approach is not the most efficient, since a graph based one would avoid some computations, but it seems much more difficult to do it in the extant hierarchy.

Definition at line 69 of file RNonHomogeneousMixedTreeLikelihood.h.

Constructor & Destructor Documentation

◆ RNonHomogeneousMixedTreeLikelihood() [1/5]

RNonHomogeneousMixedTreeLikelihood::RNonHomogeneousMixedTreeLikelihood ( const Tree tree,
MixedSubstitutionModelSet modelSet,
const MixedSubstitutionModelSet::HyperNode hyperNode,
int  upperNode,
DiscreteDistribution *  rDist,
bool  verbose,
bool  usePatterns 
)
private

Build a new RNonHomogeneousMixeTreeLikelihood object without data.

This constructor only initialize the parameters. To compute a likelihood, you will need to call the setData() and the computeTreeLikelihood() methods.

Parameters
treeThe tree to use.
modelSetThe set of substitution models to use.
hyperNodean hypernode of the numbers of the submodels used in the mixed models.
upperNodethe number of the node under which the treelikelihood is computed.
rDistThe rate across sites distribution to use. If true, any rooted tree will be unrooted before likelihood computation.
verboseShould I display some info?
usePatternsTell if recursive site compression should be performed.
Exceptions
Exceptionin an error occured.

Definition at line 103 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References init(), and bpp::SubstitutionModelSet::isFullySetUpFor().

Referenced by init(), operator=(), and RNonHomogeneousMixedTreeLikelihood().

◆ RNonHomogeneousMixedTreeLikelihood() [2/5]

RNonHomogeneousMixedTreeLikelihood::RNonHomogeneousMixedTreeLikelihood ( const Tree tree,
const SiteContainer &  data,
MixedSubstitutionModelSet modelSet,
const MixedSubstitutionModelSet::HyperNode hyperNode,
int  upperNode,
DiscreteDistribution *  rDist,
bool  verbose,
bool  usePatterns 
)
private

Build a new RNonHomogeneousMixeTreeLikelihood object with data.

This constructor only initialize the parameters. To compute a likelihood, you will need to call the setData() and the computeTreeLikelihood() methods.

Parameters
treeThe tree to use.
dataSequences to use.
modelSetThe set of substitution models to use.
hyperNodean hypernode of the numbers of the submodels used in the mixed models.
upperNodethe number of the node under which the treelikelihood is computed.
rDistThe rate across sites distribution to use. If true, any rooted tree will be unrooted before likelihood computation.
verboseShould I display some info?
usePatternsTell if recursive site compression should be performed.
Exceptions
Exceptionin an error occured.

Definition at line 124 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References init(), and bpp::SubstitutionModelSet::isFullySetUpFor().

◆ RNonHomogeneousMixedTreeLikelihood() [3/5]

RNonHomogeneousMixedTreeLikelihood::RNonHomogeneousMixedTreeLikelihood ( const Tree tree,
MixedSubstitutionModelSet modelSet,
DiscreteDistribution *  rDist,
bool  verbose = true,
bool  usePatterns = true 
)
throw (Exception
)

Build a new RNonHomogeneousMixeTreeLikelihood object without data.

This constructor only initialize the parameters. To compute a likelihood, you will need to call the setData() and the computeTreeLikelihood() methods.

Parameters
treeThe tree to use.
modelSetThe set of substitution models to use.
rDistThe rate across sites distribution to use. If true, any rooted tree will be unrooted before likelihood computation.
verboseShould I display some info?
usePatternsTell if recursive site compression should be performed.
Exceptions
Exceptionin an error occured.

Definition at line 58 of file RNonHomogeneousMixedTreeLikelihood.cpp.

◆ RNonHomogeneousMixedTreeLikelihood() [4/5]

RNonHomogeneousMixedTreeLikelihood::RNonHomogeneousMixedTreeLikelihood ( const Tree tree,
const SiteContainer &  data,
MixedSubstitutionModelSet modelSet,
DiscreteDistribution *  rDist,
bool  verbose = true,
bool  usePatterns = true 
)
throw (Exception
)

Build a new RNonHomogeneousMixedTreeLikelihood object and compute the corresponding likelihood.

This constructor initializes all parameters, data, and likelihood arrays.

Parameters
treeThe tree to use.
dataSequences to use.
modelSetThe set of substitution models to use.
rDistThe rate across sites distribution to use.
verboseShould I display some info?
usePatternsTell if recursive site compression should be performed.
Exceptions
Exceptionin an error occured.

Definition at line 81 of file RNonHomogeneousMixedTreeLikelihood.cpp.

◆ RNonHomogeneousMixedTreeLikelihood() [5/5]

RNonHomogeneousMixedTreeLikelihood::RNonHomogeneousMixedTreeLikelihood ( const RNonHomogeneousMixedTreeLikelihood lik)

◆ ~RNonHomogeneousMixedTreeLikelihood()

RNonHomogeneousMixedTreeLikelihood::~RNonHomogeneousMixedTreeLikelihood ( )
virtual

Definition at line 301 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References mvTreeLikelihoods_.

Member Function Documentation

◆ applyParameters()

◆ clone()

RNonHomogeneousMixedTreeLikelihood* bpp::RNonHomogeneousMixedTreeLikelihood::clone ( ) const
inlinevirtual

◆ computeAllTransitionProbabilities()

◆ computeDownSubtreeD2Likelihood()

void RNonHomogeneousMixedTreeLikelihood::computeDownSubtreeD2Likelihood ( const Node node)
protectedvirtual

◆ computeDownSubtreeDLikelihood()

void RNonHomogeneousMixedTreeLikelihood::computeDownSubtreeDLikelihood ( const Node node)
protectedvirtual

◆ computeSubtreeLikelihood()

void RNonHomogeneousMixedTreeLikelihood::computeSubtreeLikelihood ( const Node node)
protectedvirtual

◆ computeTransitionProbabilitiesForNode()

◆ computeTreeD2Likelihood()

◆ computeTreeDLikelihood()

◆ computeTreeLikelihood()

void RNonHomogeneousTreeLikelihood::computeTreeLikelihood ( )
virtualinherited

◆ displayLikelihood()

void RNonHomogeneousTreeLikelihood::displayLikelihood ( const Node node)
protectedvirtualinherited

This method is mainly for debugging purpose.

Parameters
nodeThe node at which likelihood values must be displayed.

Definition at line 1359 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::displayLikelihoodArray(), bpp::Node::getId(), bpp::DRASRTreeLikelihoodData::getLikelihoodArray(), bpp::Node::getName(), and bpp::RNonHomogeneousTreeLikelihood::likelihoodData_.

◆ displayLikelihoodArray()

void AbstractDiscreteRatesAcrossSitesTreeLikelihood::displayLikelihoodArray ( const VVVdouble &  likelihoodArray)
staticinherited

◆ enableDerivatives() [1/2]

void bpp::AbstractTreeLikelihood::enableDerivatives ( bool  yn)
inlinevirtualinherited

Tell if derivatives must be computed.

This methods calls the enableFirstOrderDerivatives and enableSecondOrderDerivatives.

Parameters
ynYes or no.

Implements bpp::TreeLikelihood.

Definition at line 292 of file AbstractTreeLikelihood.h.

References bpp::AbstractTreeLikelihood::computeFirstOrderDerivatives_, and bpp::AbstractTreeLikelihood::computeSecondOrderDerivatives_.

Referenced by bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::AbstractDiscreteRatesAcrossSitesTreeLikelihood(), and bpp::DistanceEstimation::computeMatrix().

◆ enableDerivatives() [2/2]

virtual void bpp::TreeLikelihood::enableDerivatives ( bool  yn)
pure virtualinherited

Tell if derivatives must be computed.

This methods calls the enableFirstOrderDerivatives and enableSecondOrderDerivatives.

Parameters
ynYes or no.

Implemented in bpp::AbstractTreeLikelihood.

◆ enableFirstOrderDerivatives() [1/2]

void bpp::AbstractTreeLikelihood::enableFirstOrderDerivatives ( bool  yn)
inlineinherited

◆ enableFirstOrderDerivatives() [2/2]

bool bpp::AbstractTreeLikelihood::enableFirstOrderDerivatives ( ) const
inlineinherited

◆ enableSecondOrderDerivatives() [1/2]

void bpp::AbstractTreeLikelihood::enableSecondOrderDerivatives ( bool  yn)
inlineinherited

◆ enableSecondOrderDerivatives() [2/2]

bool bpp::AbstractTreeLikelihood::enableSecondOrderDerivatives ( ) const
inlineinherited

◆ fireParameterChanged()

◆ getAlphabet() [1/2]

const Alphabet* bpp::AbstractTreeLikelihood::getAlphabet ( ) const
inlinevirtualinherited

Get the alphabet associated to the dataset.

Returns
the alphabet associated to the dataset.

Implements bpp::TreeLikelihood.

Definition at line 285 of file AbstractTreeLikelihood.h.

References bpp::AbstractTreeLikelihood::data_.

◆ getAlphabet() [2/2]

virtual const Alphabet* bpp::TreeLikelihood::getAlphabet ( ) const
pure virtualinherited

Get the alphabet associated to the dataset.

Returns
the alphabet associated to the dataset.

Implemented in bpp::AbstractTreeLikelihood.

◆ getAlphabetStateAsChar()

std::string bpp::AbstractNonHomogeneousTreeLikelihood::getAlphabetStateAsChar ( size_t  i) const
inlinevirtualinherited
Returns
the alphabet state corresponding to the given model state.

Implements bpp::TreeLikelihood.

Definition at line 183 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getAlphabetStateAsChar(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getAlphabetStateAsInt()

int bpp::AbstractNonHomogeneousTreeLikelihood::getAlphabetStateAsInt ( size_t  i) const
inlinevirtualinherited
Returns
the alphabet state corresponding to the given model state.

Implements bpp::TreeLikelihood.

Definition at line 181 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getAlphabetStateAsInt(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getAlphabetStates()

const std::vector<int>& bpp::AbstractNonHomogeneousTreeLikelihood::getAlphabetStates ( ) const
inlinevirtualinherited
Returns
the alphabet states corresponding to all model states.

Implements bpp::TreeLikelihood.

Definition at line 179 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getAlphabetStates(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getBranchLengthsParameters()

ParameterList AbstractNonHomogeneousTreeLikelihood::getBranchLengthsParameters ( ) const
virtualinherited

Get the branch lengths parameters.

Returns
A ParameterList with all branch lengths.

Implements bpp::TreeLikelihood.

Definition at line 280 of file AbstractNonHomogeneousTreeLikelihood.cpp.

References bpp::AbstractNonHomogeneousTreeLikelihood::brLenParameters_, and bpp::AbstractTreeLikelihood::initialized_.

◆ getD2LikelihoodForASite()

◆ getD2LikelihoodForASiteForARateClass()

◆ getD2LogLikelihood()

double RNonHomogeneousTreeLikelihood::getD2LogLikelihood ( ) const
virtualinherited

◆ getD2LogLikelihoodForASite()

◆ getData() [1/2]

virtual const SiteContainer* bpp::TreeLikelihood::getData ( ) const
pure virtualinherited

Get the dataset for which the likelihood must be evaluated.

Returns
A pointer toward the site container where the sequences are stored.

Implemented in bpp::AbstractTreeLikelihood.

◆ getData() [2/2]

const SiteContainer* bpp::AbstractTreeLikelihood::getData ( ) const
inlinevirtualinherited

Get the dataset for which the likelihood must be evaluated.

Returns
A pointer toward the site container where the sequences are stored.

Implements bpp::TreeLikelihood.

Definition at line 284 of file AbstractTreeLikelihood.h.

References bpp::AbstractTreeLikelihood::data_.

Referenced by init().

◆ getDerivableParameters() [1/2]

ParameterList AbstractDiscreteRatesAcrossSitesTreeLikelihood::getDerivableParameters ( ) const
virtualinherited

All derivable parameters.

Usually, this contains all branch lengths parameters.

Returns
A ParameterList.

Implements bpp::TreeLikelihood.

Reimplemented in bpp::RHomogeneousClockTreeLikelihood.

Definition at line 73 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getDerivableParameters() [2/2]

virtual ParameterList bpp::TreeLikelihood::getDerivableParameters ( ) const
pure virtualinherited

All derivable parameters.

Usually, this contains all branch lengths parameters.

Returns
A ParameterList.

Implemented in bpp::RHomogeneousClockTreeLikelihood, and bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

◆ getDLikelihoodForASite()

◆ getDLikelihoodForASiteForARateClass()

◆ getDLogLikelihood()

double RNonHomogeneousTreeLikelihood::getDLogLikelihood ( ) const
virtualinherited

◆ getDLogLikelihoodForASite()

double RNonHomogeneousTreeLikelihood::getDLogLikelihoodForASite ( size_t  site) const
virtualinherited

◆ getFirstOrderDerivative()

double RNonHomogeneousTreeLikelihood::getFirstOrderDerivative ( const std::string &  variable) const
throw (Exception
)
inherited

Definition at line 376 of file RNonHomogeneousTreeLikelihood.cpp.

◆ getHyperNode()

const MixedSubstitutionModelSet::HyperNode& bpp::RNonHomogeneousMixedTreeLikelihood::getHyperNode ( )
inline

returns the HyperNode describing the owned submodels.

Definition at line 271 of file RNonHomogeneousMixedTreeLikelihood.h.

◆ getLikelihood()

double RNonHomogeneousTreeLikelihood::getLikelihood ( ) const
virtualinherited

Get the likelihood for the whole dataset.

Returns
The likelihood of the dataset.

Implements bpp::TreeLikelihood.

Definition at line 158 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::RNonHomogeneousTreeLikelihood::getLikelihoodForASite(), and bpp::AbstractNonHomogeneousTreeLikelihood::nbSites_.

◆ getLikelihoodData() [1/2]

DRASRTreeLikelihoodData* bpp::RNonHomogeneousTreeLikelihood::getLikelihoodData ( )
inlinevirtualinherited
Returns
The underlying likelihood data structure.

Implements bpp::TreeLikelihood.

Definition at line 222 of file RNonHomogeneousTreeLikelihood.h.

References bpp::RNonHomogeneousTreeLikelihood::likelihoodData_.

◆ getLikelihoodData() [2/2]

const DRASRTreeLikelihoodData* bpp::RNonHomogeneousTreeLikelihood::getLikelihoodData ( ) const
inlinevirtualinherited
Returns
The underlying likelihood data structure.

Implements bpp::TreeLikelihood.

Definition at line 223 of file RNonHomogeneousTreeLikelihood.h.

References bpp::RNonHomogeneousTreeLikelihood::likelihoodData_.

◆ getLikelihoodForASite()

double RNonHomogeneousTreeLikelihood::getLikelihoodForASite ( size_t  site) const
virtualinherited

◆ getLikelihoodForASiteForARateClass()

double RNonHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClass ( size_t  site,
size_t  rateClass 
) const
virtualinherited

◆ getLikelihoodForASiteForARateClassForAState()

double RNonHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClassForAState ( size_t  site,
size_t  rateClass,
int  state 
) const
virtualinherited

Get the likelihood for a site knowing its rate class and its ancestral state.

Parameters
siteThe site index.
rateClassThe rate class index.
stateThe ancestral state.
Returns
The likelihood for the specified site and rate class and ancestral state.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 240 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::DRASRTreeLikelihoodData::getLikelihoodArray(), bpp::DRASRTreeLikelihoodData::getRootArrayPosition(), bpp::RNonHomogeneousTreeLikelihood::likelihoodData_, and bpp::AbstractTreeLikelihood::tree_.

◆ getLikelihoodForASiteForAState() [1/2]

double AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLikelihoodForASiteForAState ( size_t  site,
int  state 
) const
virtualinherited

Get the likelihood for a site and for a state.

Parameters
siteThe site index to analyse.
stateThe state to consider.
Returns
The likelihood for site site and state state.

Implements bpp::TreeLikelihood.

Definition at line 111 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLikelihoodForASiteForAState() [2/2]

virtual double bpp::TreeLikelihood::getLikelihoodForASiteForAState ( size_t  site,
int  state 
) const
pure virtualinherited

Get the likelihood for a site and for a state.

Parameters
siteThe site index to analyse.
stateThe state to consider.
Returns
The likelihood for site site and state state.

Implemented in bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

Referenced by bpp::AbstractTreeLikelihood::getLikelihoodForEachSiteForEachState().

◆ getLikelihoodForEachSite() [1/2]

virtual Vdouble bpp::TreeLikelihood::getLikelihoodForEachSite ( ) const
pure virtualinherited

Get the likelihood for each site.

Returns
A vector with all likelihoods for each site.

Implemented in bpp::AbstractTreeLikelihood.

◆ getLikelihoodForEachSite() [2/2]

Vdouble AbstractTreeLikelihood::getLikelihoodForEachSite ( ) const
virtualinherited

Get the likelihood for each site.

Returns
A vector with all likelihoods for each site.

Implements bpp::TreeLikelihood.

Definition at line 46 of file AbstractTreeLikelihood.cpp.

References bpp::TreeLikelihood::getLikelihoodForASite(), and bpp::AbstractTreeLikelihood::getNumberOfSites().

◆ getLikelihoodForEachSiteForEachRateClass()

VVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLikelihoodForEachSiteForEachRateClass ( ) const
virtualinherited

Get the likelihood for each site and each rate class.

Returns
A two-dimension vector with all likelihoods.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 93 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLikelihoodForEachSiteForEachRateClassForEachState()

VVVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLikelihoodForEachSiteForEachRateClassForEachState ( ) const
virtualinherited

Get the likelihood for each site and each rate class and each state.

Returns
A three-dimension vector with all likelihoods.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 156 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLikelihoodForEachSiteForEachState() [1/2]

virtual VVdouble bpp::TreeLikelihood::getLikelihoodForEachSiteForEachState ( ) const
pure virtualinherited

Get the likelihood for each site and for each state.

Returns
A 2d vector with all likelihoods for each site and for each state.

Implemented in bpp::AbstractTreeLikelihood.

◆ getLikelihoodForEachSiteForEachState() [2/2]

VVdouble AbstractTreeLikelihood::getLikelihoodForEachSiteForEachState ( ) const
virtualinherited

Get the likelihood for each site and for each state.

Returns
A 2d vector with all likelihoods for each site and for each state.

Implements bpp::TreeLikelihood.

Definition at line 64 of file AbstractTreeLikelihood.cpp.

References bpp::TreeLikelihood::getLikelihoodForASiteForAState(), bpp::AbstractTreeLikelihood::getNumberOfSites(), and bpp::TreeLikelihood::getNumberOfStates().

◆ getLogLikelihood()

double RNonHomogeneousTreeLikelihood::getLogLikelihood ( ) const
virtualinherited

Get the logarithm of the likelihood for the whole dataset.

Returns
The logarithm of the likelihood of the dataset.

Implements bpp::TreeLikelihood.

Definition at line 170 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::RNonHomogeneousTreeLikelihood::getLogLikelihoodForASite(), and bpp::AbstractNonHomogeneousTreeLikelihood::nbSites_.

Referenced by bpp::RNonHomogeneousTreeLikelihood::fireParameterChanged(), and fireParameterChanged().

◆ getLogLikelihoodForASite()

double RNonHomogeneousTreeLikelihood::getLogLikelihoodForASite ( size_t  site) const
virtualinherited

Get the logarithm of the likelihood for a site.

Parameters
siteThe site index to analyse.
Returns
The logarithm of the likelihood for site site.

Implements bpp::TreeLikelihood.

Definition at line 200 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::RNonHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClass(), bpp::AbstractNonHomogeneousTreeLikelihood::nbClasses_, and bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::rateDistribution_.

Referenced by bpp::RNonHomogeneousTreeLikelihood::getLogLikelihood().

◆ getLogLikelihoodForASiteForARateClass()

double RNonHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClass ( size_t  site,
size_t  rateClass 
) const
virtualinherited

Get the logarithm of the likelihood for a site knowing its rate class.

Parameters
siteThe site index.
rateClassThe rate class index.
Returns
The logarithm of the likelihood for the specified site and rate class.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 227 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::DRASRTreeLikelihoodData::getLikelihoodArray(), bpp::DRASRTreeLikelihoodData::getRootArrayPosition(), bpp::RNonHomogeneousTreeLikelihood::likelihoodData_, bpp::AbstractNonHomogeneousTreeLikelihood::nbStates_, bpp::AbstractNonHomogeneousTreeLikelihood::rootFreqs_, and bpp::AbstractTreeLikelihood::tree_.

◆ getLogLikelihoodForASiteForARateClassForAState()

double RNonHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClassForAState ( size_t  site,
size_t  rateClass,
int  state 
) const
virtualinherited

Get the logarithm of the likelihood for a site knowing its rate class and its ancestral state.

Parameters
siteThe site index.
rateClassThe rate class index.
stateThe ancestral state.
Returns
The logarithm of the likelihood for the specified site and rate class and ancestral state..

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 247 of file RNonHomogeneousTreeLikelihood.cpp.

References bpp::DRASRTreeLikelihoodData::getLikelihoodArray(), bpp::DRASRTreeLikelihoodData::getRootArrayPosition(), bpp::RNonHomogeneousTreeLikelihood::likelihoodData_, and bpp::AbstractTreeLikelihood::tree_.

◆ getLogLikelihoodForASiteForAState() [1/2]

double AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLogLikelihoodForASiteForAState ( size_t  site,
int  state 
) const
virtualinherited

Get the logarithm of the likelihood for a site and for a state.

Parameters
siteThe site index to analyse.
stateThe state to consider.
Returns
The logarithm of the likelihood for site site and state state.

Implements bpp::TreeLikelihood.

Definition at line 124 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLogLikelihoodForASiteForAState() [2/2]

virtual double bpp::TreeLikelihood::getLogLikelihoodForASiteForAState ( size_t  site,
int  state 
) const
pure virtualinherited

Get the logarithm of the likelihood for a site and for a state.

Parameters
siteThe site index to analyse.
stateThe state to consider.
Returns
The logarithm of the likelihood for site site and state state.

Implemented in bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

Referenced by bpp::AbstractTreeLikelihood::getLogLikelihoodForEachSiteForEachState().

◆ getLogLikelihoodForEachSite() [1/2]

virtual Vdouble bpp::TreeLikelihood::getLogLikelihoodForEachSite ( ) const
pure virtualinherited

Get the logarithm of the likelihood for each site.

Returns
A vector with all log likelihoods for each site.

Implemented in bpp::AbstractTreeLikelihood.

◆ getLogLikelihoodForEachSite() [2/2]

Vdouble AbstractTreeLikelihood::getLogLikelihoodForEachSite ( ) const
virtualinherited

Get the logarithm of the likelihood for each site.

Returns
A vector with all log likelihoods for each site.

Implements bpp::TreeLikelihood.

Definition at line 55 of file AbstractTreeLikelihood.cpp.

References bpp::TreeLikelihood::getLogLikelihoodForASite(), and bpp::AbstractTreeLikelihood::getNumberOfSites().

◆ getLogLikelihoodForEachSiteForEachRateClass()

VVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLogLikelihoodForEachSiteForEachRateClass ( ) const
virtualinherited

Get the logarithm of the likelihood for each site and each rate class.

Returns
A two-dimension vector with all log likelihoods: V[i][j] = likelihood of site i and rate class j.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 138 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLogLikelihoodForEachSiteForEachRateClassForEachState()

VVVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getLogLikelihoodForEachSiteForEachRateClassForEachState ( ) const
virtualinherited

Get the logarithm of the likelihood for each site and each rate class and each state.

Returns
A three-dimension vector with all log likelihoods: V[i][j][k} = likelihood of site i and rate class j and state k.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 179 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getLogLikelihoodForEachSiteForEachState() [1/2]

virtual VVdouble bpp::TreeLikelihood::getLogLikelihoodForEachSiteForEachState ( ) const
pure virtualinherited

Get the logarithm of the likelihood for each site and for each state.

Returns
A 2d vector with all log likelihoods for each site and for each state.

Implemented in bpp::AbstractTreeLikelihood.

◆ getLogLikelihoodForEachSiteForEachState() [2/2]

VVdouble AbstractTreeLikelihood::getLogLikelihoodForEachSiteForEachState ( ) const
virtualinherited

Get the logarithm of the likelihood for each site and for each state.

Returns
A 2d vector with all log likelihoods for each site and for each state.

Implements bpp::TreeLikelihood.

Definition at line 81 of file AbstractTreeLikelihood.cpp.

References bpp::TreeLikelihood::getLogLikelihoodForASiteForAState(), bpp::AbstractTreeLikelihood::getNumberOfSites(), and bpp::TreeLikelihood::getNumberOfStates().

◆ getMaximumBranchLength()

virtual double bpp::AbstractNonHomogeneousTreeLikelihood::getMaximumBranchLength ( ) const
inlinevirtualinherited

◆ getMinimumBranchLength()

virtual double bpp::AbstractNonHomogeneousTreeLikelihood::getMinimumBranchLength ( ) const
inlinevirtualinherited

◆ getNewBranchModelIterator()

ConstBranchModelIterator* bpp::AbstractNonHomogeneousTreeLikelihood::getNewBranchModelIterator ( int  nodeId) const
inlinevirtualinherited

◆ getNewSiteModelIterator()

ConstSiteModelIterator* bpp::AbstractNonHomogeneousTreeLikelihood::getNewSiteModelIterator ( size_t  siteIndex) const
inlinevirtualinherited

◆ getNonDerivableParameters() [1/2]

ParameterList AbstractDiscreteRatesAcrossSitesTreeLikelihood::getNonDerivableParameters ( ) const
virtualinherited

All non derivable parameters.

Usually, this contains all substitution model parameters and rate distribution.

Returns
A ParameterList.

Implements bpp::TreeLikelihood.

Reimplemented in bpp::RHomogeneousClockTreeLikelihood.

Definition at line 82 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getNonDerivableParameters() [2/2]

virtual ParameterList bpp::TreeLikelihood::getNonDerivableParameters ( ) const
pure virtualinherited

All non derivable parameters.

Usually, this contains all substitution model parameters and rate distribution.

Returns
A ParameterList.

Implemented in bpp::RHomogeneousClockTreeLikelihood, and bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

◆ getNumberOfClasses()

size_t bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getNumberOfClasses ( ) const
inlinevirtualinherited

Get the number of classes.

Returns
The Number of classes.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 108 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.h.

References bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::rateDistribution_.

◆ getNumberOfSites() [1/2]

size_t bpp::AbstractTreeLikelihood::getNumberOfSites ( ) const
inlinevirtualinherited

◆ getNumberOfSites() [2/2]

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

Get the number of sites in the dataset.

Returns
the number of sites in the dataset.

Implemented in bpp::AbstractTreeLikelihood.

Referenced by bpp::SubstitutionMappingTools::getNormalizationsPerBranch().

◆ getNumberOfStates()

size_t bpp::AbstractNonHomogeneousTreeLikelihood::getNumberOfStates ( ) const
inlinevirtualinherited
Returns
the number of model states of the underlying Markov chain.

Implements bpp::TreeLikelihood.

Definition at line 177 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getNumberOfStates(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getPosteriorProbabilitiesOfEachRate()

VVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getPosteriorProbabilitiesOfEachRate ( ) const
virtualinherited

Get the posterior probability for each site of belonging to a particular rate class.

Returns
A two-dimension vector with all posterior probabilities: V[i][j] = probablity for site i of belonging to rate class j.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 202 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getPosteriorRateOfEachSite()

Vdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getPosteriorRateOfEachSite ( ) const
virtualinherited

Get the posterior rate, i.e. averaged over all classes and weighted with posterior probabilities, for each site.

Returns
A vector with all rates.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 220 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getProbability()

double RNonHomogeneousMixedTreeLikelihood::getProbability ( ) const

returns the probability of this object in the hierarchy

Definition at line 452 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References bpp::MixedSubstitutionModelSet::HyperNode::getProbability(), and hyperNode_.

Referenced by computeSubtreeLikelihood(), computeTreeD2Likelihood(), and computeTreeDLikelihood().

◆ getRateClassWithMaxPostProbOfEachSite()

vector< size_t > AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateClassWithMaxPostProbOfEachSite ( ) const
virtualinherited

Get the posterior rate class (the one with maximum posterior probability) for each site.

Returns
A vector with all rate classes indexes.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 239 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getRateDistribution() [1/2]

const DiscreteDistribution* bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateDistribution ( ) const
inlinevirtualinherited

Get the rate distribution used for the computation.

Returns
A const pointer toward the rate distribution of this instance.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 106 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.h.

References bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::rateDistribution_.

◆ getRateDistribution() [2/2]

DiscreteDistribution* bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateDistribution ( )
inlinevirtualinherited

Get the rate distribution used for the computation.

Returns
A pointer toward the rate distribution of this instance.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 107 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.h.

References bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::rateDistribution_.

◆ getRateDistributionParameters()

ParameterList bpp::AbstractNonHomogeneousTreeLikelihood::getRateDistributionParameters ( ) const
inlinevirtualinherited

Get the parameters associated to the rate distirbution.

Returns
A ParameterList object with all rate distribution parameters.

Reimplemented from bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 191 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateDistributionParameters().

◆ getRateWithMaxPostProbOfEachSite()

Vdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateWithMaxPostProbOfEachSite ( ) const
virtualinherited

Get the posterior rate (the one with maximum posterior probability) for each site.

Returns
A vector with all rate classes indexes.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 253 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getRootFrequencies()

const std::vector<double>& bpp::AbstractNonHomogeneousTreeLikelihood::getRootFrequencies ( size_t  siteIndex) const
inlinevirtualinherited

Get the values of the frequencies for each state in the alphabet at the root node.

For reversible models, these are the equilibrium frequencies. For non-reversible models, these usually are distinct parameters.

For models without site partitioning, the set of frequencies is the same for all positions. For partition models, the frequencies may differ from one site to another.

Parameters
siteIndexThe index of the alignment position.
See also
getSiteIndex
Returns
A vector with ancestral frequencies for each state in the alphabet;

Implements bpp::TreeLikelihood.

Definition at line 206 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::AbstractNonHomogeneousTreeLikelihood::rootFreqs_.

◆ getRootFrequenciesParameters()

ParameterList bpp::AbstractNonHomogeneousTreeLikelihood::getRootFrequenciesParameters ( ) const
inlinevirtualinherited
Returns
The parameters on which the root frequencies depend.

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 235 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getRootFrequenciesParameters(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getSecondOrderDerivative() [1/2]

double RNonHomogeneousTreeLikelihood::getSecondOrderDerivative ( const std::string &  variable) const
throw (Exception
)
inherited

Definition at line 848 of file RNonHomogeneousTreeLikelihood.cpp.

◆ getSecondOrderDerivative() [2/2]

double bpp::RNonHomogeneousTreeLikelihood::getSecondOrderDerivative ( const std::string &  variable1,
const std::string &  variable2 
) const
throw (Exception
)
inlineinherited

Definition at line 217 of file RNonHomogeneousTreeLikelihood.h.

◆ getSiteIndex()

size_t bpp::RNonHomogeneousTreeLikelihood::getSiteIndex ( size_t  site) const
throw (IndexOutOfBoundsException
)
inlinevirtualinherited

Get the index (used for inner computations) of a given site (original alignment column).

Parameters
siteAn alignment position.
Returns
The site index corresponding to the given input alignment position.

Implements bpp::TreeLikelihood.

Definition at line 172 of file RNonHomogeneousTreeLikelihood.h.

References bpp::DRASRTreeLikelihoodData::getRootArrayPosition(), and bpp::RNonHomogeneousTreeLikelihood::likelihoodData_.

◆ getSubstitutionModel() [1/2]

const SubstitutionModel* bpp::NonHomogeneousTreeLikelihood::getSubstitutionModel ( int  nodeId,
size_t  siteIndex 
) const
throw (NodeNotFoundException
)
inlinevirtualinherited

Get the substitution model associated to a given node and alignment column.

Parameters
nodeIdThe id of the request node.
siteIndexThe index of the alignment position.
See also
getSiteIndex
Returns
A pointer toward the corresponding model.
Exceptions
NodeNotFoundExceptionThis exception may be thrown if the node is not found (depending on the implementation).

Implements bpp::TreeLikelihood.

Definition at line 69 of file NonHomogeneousTreeLikelihood.h.

References bpp::NonHomogeneousTreeLikelihood::getSubstitutionModelForNode().

◆ getSubstitutionModel() [2/2]

SubstitutionModel* bpp::NonHomogeneousTreeLikelihood::getSubstitutionModel ( int  nodeId,
size_t  siteIndex 
)
throw (NodeNotFoundException
)
inlinevirtualinherited

Get the substitution model associated to a given node and alignment column.

Parameters
nodeIdThe id of the request node.
siteIndexThe index of the alignment position.
See also
getSiteIndex
Returns
A pointer toward the corresponding model.
Exceptions
NodeNotFoundExceptionThis exception may be thrown if the node is not found (depending on the implementation).

Implements bpp::TreeLikelihood.

Definition at line 74 of file NonHomogeneousTreeLikelihood.h.

References bpp::NonHomogeneousTreeLikelihood::getSubstitutionModelForNode().

◆ getSubstitutionModelForNode() [1/2]

const SubstitutionModel* bpp::AbstractNonHomogeneousTreeLikelihood::getSubstitutionModelForNode ( int  nodeId) const
throw (NodeNotFoundException
)
inlinevirtualinherited

Get the substitution model associated to a given node.

Parameters
nodeIdThe id of the request node.
Returns
A pointer toward the corresponding model.
Exceptions
NodeNotFoundExceptionThis exception may be thrown if the node is not found (depending on the implementation).

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 196 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getModelForNode(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getSubstitutionModelForNode() [2/2]

SubstitutionModel* bpp::AbstractNonHomogeneousTreeLikelihood::getSubstitutionModelForNode ( int  nodeId)
throw (NodeNotFoundException
)
inlinevirtualinherited

Get the substitution model associated to a given node.

Parameters
nodeIdThe id of the request node.
Returns
A pointer toward the corresponding model.
Exceptions
NodeNotFoundExceptionThis exception may be thrown if the node is not found (depending on the implementation).

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 201 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::SubstitutionModelSet::getModelForNode(), and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getSubstitutionModelParameters()

ParameterList AbstractNonHomogeneousTreeLikelihood::getSubstitutionModelParameters ( ) const
virtualinherited

Get the parameters associated to substitution model(s).

Returns
A ParameterList.

Implements bpp::TreeLikelihood.

Definition at line 288 of file AbstractNonHomogeneousTreeLikelihood.cpp.

References bpp::AbstractTreeLikelihood::initialized_, and bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getSubstitutionModelSet() [1/2]

const SubstitutionModelSet* bpp::AbstractNonHomogeneousTreeLikelihood::getSubstitutionModelSet ( ) const
inlinevirtualinherited
Returns
The set of substitution models associated to this instance.

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 229 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getSubstitutionModelSet() [2/2]

SubstitutionModelSet* bpp::AbstractNonHomogeneousTreeLikelihood::getSubstitutionModelSet ( )
inlinevirtualinherited
Returns
The set of substitution models associated to this instance.

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 231 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::AbstractNonHomogeneousTreeLikelihood::modelSet_.

◆ getTransitionProbabilities() [1/2]

VVdouble AbstractDiscreteRatesAcrossSitesTreeLikelihood::getTransitionProbabilities ( int  nodeId,
size_t  siteIndex 
) const
virtualinherited

Retrieves all Pij(t) for a particular branch, defined by the upper node and site.

These intermediate results may be used by other methods.

Parameters
nodeIdThe node defining the branch of interest.
siteIndexThe index of the alignment position.
See also
getSiteIndex
Returns
An array of dimension 2, where a[x][y] is the probability of substituting from x to y.

Implements bpp::TreeLikelihood.

Definition at line 311 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.cpp.

◆ getTransitionProbabilities() [2/2]

virtual VVdouble bpp::TreeLikelihood::getTransitionProbabilities ( int  nodeId,
size_t  siteIndex 
) const
pure virtualinherited

Retrieves all Pij(t) for a particular branch, defined by the upper node and site.

These intermediate results may be used by other methods.

Parameters
nodeIdThe node defining the branch of interest.
siteIndexThe index of the alignment position.
See also
getSiteIndex
Returns
An array of dimension 2, where a[x][y] is the probability of substituting from x to y.

Implemented in bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood.

◆ getTransitionProbabilitiesPerRateClass()

VVVdouble bpp::AbstractNonHomogeneousTreeLikelihood::getTransitionProbabilitiesPerRateClass ( int  nodeId,
size_t  siteIndex 
) const
inlinevirtualinherited

Retrieves all Pij(t) for a particular branch, defined by the upper node.

These intermediate results may be used by other methods.

Parameters
nodeIdThe node defining the branch of interest.
siteIndexThe position in the alignment.
Returns
An array of dimension 3, where a[c][x][y] is the probability of substituting from x to y while being in rate class c.

Implements bpp::DiscreteRatesAcrossSitesTreeLikelihood.

Definition at line 208 of file AbstractNonHomogeneousTreeLikelihood.h.

References bpp::AbstractNonHomogeneousTreeLikelihood::pxy_.

◆ getTree() [1/2]

const Tree& bpp::AbstractTreeLikelihood::getTree ( ) const
inlinevirtualinherited

Get the tree (topology and branch lengths).

Returns
The tree of this TreeLikelihood object.

Implements bpp::TreeLikelihood.

Definition at line 291 of file AbstractTreeLikelihood.h.

References bpp::AbstractTreeLikelihood::tree_.

Referenced by bpp::NNIHomogeneousTreeLikelihood::getTopology(), and init().

◆ getTree() [2/2]

◆ getValue()

double RNonHomogeneousTreeLikelihood::getValue ( ) const
throw (Exception
)
inherited

◆ init()

◆ initBranchLengthsParameters()

◆ initialize()

void RNonHomogeneousMixedTreeLikelihood::initialize ( )
throw (Exception
)
virtual

Init the likelihood object.

This method is used to initialize all parameters. It is typically called after the constructor and the setData method. It contains virtual methods that can't be called in the constructor.

Exceptions
Exceptionif something bad happened, for instance if no data are associated to the likelihood function.

Reimplemented from bpp::AbstractNonHomogeneousTreeLikelihood.

Definition at line 314 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References bpp::AbstractNonHomogeneousTreeLikelihood::brLenParameters_, bpp::AbstractNonHomogeneousTreeLikelihood::initBranchLengthsParameters(), bpp::AbstractNonHomogeneousTreeLikelihood::initialize(), bpp::AbstractNonHomogeneousTreeLikelihood::initParameters(), main_, and mvTreeLikelihoods_.

◆ initParameters()

void AbstractNonHomogeneousTreeLikelihood::initParameters ( )
virtualinherited

◆ isInitialized() [1/2]

virtual bool bpp::TreeLikelihood::isInitialized ( ) const
pure virtualinherited
Returns
'true' is the likelihood function has been initialized.

Implemented in bpp::AbstractTreeLikelihood.

◆ isInitialized() [2/2]

bool bpp::AbstractTreeLikelihood::isInitialized ( ) const
inlinevirtualinherited

◆ operator=()

◆ resetLikelihoodArray()

◆ setData()

void RNonHomogeneousMixedTreeLikelihood::setData ( const SiteContainer &  sites)
throw (Exception
)
virtual

Set the dataset for which the likelihood must be evaluated.

Parameters
sitesThe data set to use.

Implements bpp::TreeLikelihood.

Definition at line 437 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References bpp::RNonHomogeneousTreeLikelihood::setData().

◆ setMaximumBranchLength()

virtual void bpp::AbstractNonHomogeneousTreeLikelihood::setMaximumBranchLength ( double  maximum)
throw (Exception
)
inlinevirtualinherited

◆ setMinimumBranchLength()

virtual void bpp::AbstractNonHomogeneousTreeLikelihood::setMinimumBranchLength ( double  minimum)
throw (Exception
)
inlinevirtualinherited

◆ setParameters()

void RNonHomogeneousTreeLikelihood::setParameters ( const ParameterList &  parameters)
throw (ParameterNotFoundException,
ConstraintException
)
inherited

Implements the Function interface.

Update the parameter list and call the applyParameters() method. Then compute the likelihoods at each node (computeLikelihood() method) and call the getLogLikelihood() method.

If a subset of the whole parameter list is passed to the function, only these parameters are updated and the other remain constant (i.e. equal to their last value).

Parameters
parametersThe parameter list to pass to the function.

Definition at line 254 of file RNonHomogeneousTreeLikelihood.cpp.

◆ setProbability()

void RNonHomogeneousMixedTreeLikelihood::setProbability ( double  x)

sets the probability of this object in the hierarchy

Definition at line 458 of file RNonHomogeneousMixedTreeLikelihood.cpp.

References hyperNode_, and bpp::MixedSubstitutionModelSet::HyperNode::setProbability().

Referenced by fireParameterChanged().

◆ setSubstitutionModelSet()

void AbstractNonHomogeneousTreeLikelihood::setSubstitutionModelSet ( SubstitutionModelSet model)
throw (Exception
)
virtualinherited
Returns
Set the substitution models for this instance.
Exceptions
ExceptionIf the model could not be set (for instance, because of a wrong alphabet type).

Implements bpp::NonHomogeneousTreeLikelihood.

Definition at line 195 of file AbstractNonHomogeneousTreeLikelihood.cpp.

References bpp::Node::getId().

Member Data Documentation

◆ brLenConstraint_

◆ brLenParameters_

◆ computeFirstOrderDerivatives_

◆ computeSecondOrderDerivatives_

◆ d2pxy_

◆ data_

◆ dpxy_

◆ hyperNode_

MixedSubstitutionModelSet::HyperNode bpp::RNonHomogeneousMixedTreeLikelihood::hyperNode_
private

A specific HyperNode in which the computation is processed. If the probability of this HyperNode is -1, it means that it should not be used, and the HyperNodes are all in the MixedSubstitutionModelSet object.

This object owns the HyperNode pointers of the owned RNonHomogeneousMixedTreeLikelihood.

Definition at line 92 of file RNonHomogeneousMixedTreeLikelihood.h.

Referenced by computeTransitionProbabilitiesForNode(), getProbability(), init(), operator=(), and setProbability().

◆ idToNode_

std::map<int, const Node*> bpp::AbstractNonHomogeneousTreeLikelihood::idToNode_
mutableprotectedinherited

◆ initialized_

◆ main_

bool bpp::RNonHomogeneousMixedTreeLikelihood::main_
private

a flag to say if this object is the head of the hierarchy

Definition at line 107 of file RNonHomogeneousMixedTreeLikelihood.h.

Referenced by computeSubtreeLikelihood(), computeTreeD2Likelihood(), computeTreeDLikelihood(), fireParameterChanged(), initialize(), and operator=().

◆ maximumBrLen_

◆ minimumBrLen_

◆ modelSet_

◆ mvTreeLikelihoods_

map<int, vector<RNonHomogeneousMixedTreeLikelihood*> > bpp::RNonHomogeneousMixedTreeLikelihood::mvTreeLikelihoods_
private

the map of the branch numbers to the vectors of the TreeLikelihoods for the expanded model on this branch.

Definition at line 80 of file RNonHomogeneousMixedTreeLikelihood.h.

Referenced by computeSubtreeLikelihood(), computeTreeD2Likelihood(), computeTreeDLikelihood(), fireParameterChanged(), init(), initialize(), operator=(), RNonHomogeneousMixedTreeLikelihood(), and ~RNonHomogeneousMixedTreeLikelihood().

◆ nbClasses_

◆ nbDistinctSites_

◆ nbNodes_

◆ nbSites_

◆ nbStates_

◆ nodes_

◆ pxy_

◆ rateDistribution_

DiscreteDistribution* bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::rateDistribution_
protectedinherited

Definition at line 61 of file AbstractDiscreteRatesAcrossSitesTreeLikelihood.h.

Referenced by bpp::AbstractHomogeneousTreeLikelihood::applyParameters(), bpp::AbstractNonHomogeneousTreeLikelihood::applyParameters(), bpp::TwoTreeLikelihood::applyParameters(), bpp::DRHomogeneousTreeLikelihood::computeRootLikelihood(), bpp::DRNonHomogeneousTreeLikelihood::computeRootLikelihood(), bpp::AbstractHomogeneousTreeLikelihood::computeTransitionProbabilitiesForNode(), computeTransitionProbabilitiesForNode(), bpp::AbstractNonHomogeneousTreeLikelihood::computeTransitionProbabilitiesForNode(), bpp::TwoTreeLikelihood::computeTreeD2Likelihood(), bpp::DRHomogeneousTreeLikelihood::computeTreeD2LikelihoodAtNode(), bpp::DRNonHomogeneousTreeLikelihood::computeTreeD2LikelihoodAtNode(), bpp::TwoTreeLikelihood::computeTreeDLikelihood(), bpp::DRHomogeneousTreeLikelihood::computeTreeDLikelihoodAtNode(), bpp::DRNonHomogeneousTreeLikelihood::computeTreeDLikelihoodAtNode(), bpp::TwoTreeLikelihood::computeTreeLikelihood(), bpp::DRHomogeneousTreeLikelihood::fireParameterChanged(), bpp::DRNonHomogeneousTreeLikelihood::fireParameterChanged(), bpp::RHomogeneousTreeLikelihood::fireParameterChanged(), bpp::RNonHomogeneousTreeLikelihood::fireParameterChanged(), bpp::TwoTreeLikelihood::fireParameterChanged(), fireParameterChanged(), bpp::RNonHomogeneousTreeLikelihood::getD2LikelihoodForASite(), bpp::RHomogeneousTreeLikelihood::getD2LikelihoodForASite(), bpp::RNonHomogeneousTreeLikelihood::getDLikelihoodForASite(), bpp::RHomogeneousTreeLikelihood::getDLikelihoodForASite(), bpp::RHomogeneousTreeLikelihood::getLikelihoodForASite(), bpp::RNonHomogeneousTreeLikelihood::getLikelihoodForASite(), bpp::RHomogeneousTreeLikelihood::getLogLikelihoodForASite(), bpp::RNonHomogeneousTreeLikelihood::getLogLikelihoodForASite(), bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getNumberOfClasses(), bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::getRateDistribution(), init(), bpp::AbstractHomogeneousTreeLikelihood::initParameters(), bpp::AbstractNonHomogeneousTreeLikelihood::initParameters(), bpp::TwoTreeLikelihood::initParameters(), and bpp::AbstractDiscreteRatesAcrossSitesTreeLikelihood::operator=().

◆ reparametrizeRoot_

◆ root1_

◆ root2_

◆ rootFreqs_

◆ tree_

TreeTemplate<Node>* bpp::AbstractTreeLikelihood::tree_
mutableprotectedinherited

Definition at line 226 of file AbstractTreeLikelihood.h.

Referenced by bpp::AbstractHomogeneousTreeLikelihood::AbstractHomogeneousTreeLikelihood(), bpp::AbstractNonHomogeneousTreeLikelihood::AbstractNonHomogeneousTreeLikelihood(), bpp::AbstractTreeLikelihood::AbstractTreeLikelihood(), bpp::DRHomogeneousTreeLikelihood::computeLikelihoodAtNode(), bpp::DRNonHomogeneousTreeLikelihood::computeLikelihoodAtNode(), bpp::DRHomogeneousTreeLikelihood::computeRootLikelihood(), bpp::DRNonHomogeneousTreeLikelihood::computeRootLikelihood(), bpp::RNonHomogeneousTreeLikelihood::computeTreeD2Likelihood(), computeTreeD2Likelihood(), bpp::RNonHomogeneousTreeLikelihood::computeTreeDLikelihood(), computeTreeDLikelihood(), bpp::DRHomogeneousTreeLikelihood::computeTreeLikelihood(), bpp::DRNonHomogeneousTreeLikelihood::computeTreeLikelihood(), bpp::RNonHomogeneousTreeLikelihood::computeTreeLikelihood(), bpp::RHomogeneousTreeLikelihood::computeTreeLikelihood(), bpp::DRHomogeneousTreeLikelihood::DRHomogeneousTreeLikelihood(), bpp::DRNonHomogeneousTreeLikelihood::DRNonHomogeneousTreeLikelihood(), bpp::DRNonHomogeneousTreeLikelihood::fireParameterChanged(), bpp::RNonHomogeneousTreeLikelihood::fireParameterChanged(), fireParameterChanged(), bpp::RNonHomogeneousTreeLikelihood::getD2LikelihoodForASiteForARateClass(), bpp::RHomogeneousTreeLikelihood::getD2LikelihoodForASiteForARateClass(), bpp::RNonHomogeneousTreeLikelihood::getDLikelihoodForASiteForARateClass(), bpp::RHomogeneousTreeLikelihood::getDLikelihoodForASiteForARateClass(), bpp::RHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClass(), bpp::RNonHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClass(), bpp::RHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClassForAState(), bpp::RNonHomogeneousTreeLikelihood::getLikelihoodForASiteForARateClassForAState(), bpp::RHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClass(), bpp::RNonHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClass(), bpp::RHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClassForAState(), bpp::RNonHomogeneousTreeLikelihood::getLogLikelihoodForASiteForARateClassForAState(), bpp::AbstractHomogeneousTreeLikelihood::getNewSiteModelIterator(), bpp::AbstractTreeLikelihood::getTree(), bpp::DRHomogeneousTreeLikelihood::operator=(), bpp::DRNonHomogeneousTreeLikelihood::operator=(), bpp::AbstractHomogeneousTreeLikelihood::operator=(), bpp::RHomogeneousTreeLikelihood::operator=(), bpp::RNonHomogeneousTreeLikelihood::operator=(), bpp::AbstractNonHomogeneousTreeLikelihood::operator=(), bpp::AbstractTreeLikelihood::operator=(), bpp::RHomogeneousTreeLikelihood::RHomogeneousTreeLikelihood(), bpp::RNonHomogeneousTreeLikelihood::RNonHomogeneousTreeLikelihood(), and bpp::AbstractTreeLikelihood::~AbstractTreeLikelihood().

◆ upperNode_

int bpp::RNonHomogeneousMixedTreeLikelihood::upperNode_
private

◆ verbose_

bool bpp::AbstractNonHomogeneousTreeLikelihood::verbose_
protectedinherited

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