►Nbpp | Defines the basic types of data flow nodes |
NIntegerTools | |
Nnumeric | |
NTextTools | |
CAncestralStateReconstruction | Interface for ancestral states reconstruction methods |
CBppPhylogeneticsApplication | |
CPhylogeneticsApplicationTools | This class provides some common tools for applications |
CAbstractAgglomerativeDistanceMethod | Partial implementation of the AgglomerativeDistanceMethod interface |
CBioNJ | The BioNJ distance method |
CDistanceEstimation | |
CDistanceMethodInterface | General interface for distance-based phylogenetic reconstruction methods |
CAgglomerativeDistanceMethodInterface | Interface for agglomerative distance methods |
CClusterInfos | |
CHierarchicalClustering | Hierarchical clustering |
CNeighborJoining | The neighbor joining distance method |
CPGMAInfos | Inner data structure for WPGMA and UPGMA distance methods |
CPGMA | Compute WPGMA and UPGMA trees from a distance matrix |
CAbstractDendrogramPlot | Basic implementation of dendrogram plots |
CTreeDrawingNodeInfo | |
CDrawINodeEvent | Event class that uses INode object (more efficient than relying on nodes id, but less generic) |
CDrawIBranchEvent | Event class that uses INode object (more efficient than relying on nodes id, but less generic) |
CAbstractTreeDrawing | Partial implementation of the TreeDrawing interface |
CCladogramDrawBranchEvent | |
CCladogramPlot | Cladogram representation of trees |
CPhylogramDrawBranchEvent | |
CPhylogramPlot | Phylogram representation of trees |
CTreeDrawingSettings | A set of options to tune the display of a TreeDrawing object |
CCursor | Data structure describing a plotting direction |
CDrawNodeEvent | Event class used by TreeDrawing classes |
CDrawBranchEvent | Event class used by TreeDrawing classes |
CDrawTreeEvent | Event class used by TreeDrawing classes |
CTreeDrawing | Basal interface for tree drawing classes |
CTreeDrawingDisplayControler | Easy tune of tree drawings display |
CBasicTreeDrawingDisplayControler | Easy tune of tree drawings display, a basic implementation: |
CTreeDrawingListener | Interface allowing to capture drawing events |
CTreeDrawingListenerAdapter | An empty implementation of the TreeDrawingListener interface |
CNodesIdTreeDrawingListener | A TreeDrawingListener implementation that writes nodes id |
CLeafNamesTreeDrawingListener | A TreeDrawingListener implementation that write leaf names |
CBranchLengthsTreeDrawingListener | A TreeDrawingListener implementation that write the branch lengths of inner nodes |
CBootstrapValuesTreeDrawingListener | A TreeDrawingListener implementation that write the bootstrap values of inner nodes |
CLabelInnerNodesTreeDrawingListener | A TreeDrawingListener implementation that write the names of inner nodes |
CLabelCollapsedNodesTreeDrawingListener | A TreeDrawingListener implementation that label the collapsed nodes |
CBppOBranchModelFormat | Branch model I/O in BppO format |
CBppOFrequencySetFormat | Frequencies set I/O in BppO format |
CBppOMultiTreeReaderFormat | Tree I/O in BppO format |
CBppOMultiTreeWriterFormat | Tree I/O in BppO format |
CBppORateDistributionFormat | Rate Distribution I/O in BppO format |
CBppOSubstitutionModelFormat | Substitution model I/O in BppO format |
CBppOTransitionModelFormat | Transition model I/O in BppO format |
CBppOTreeReaderFormat | Tree I/O in BppO format |
CBppOTreeWriterFormat | Tree I/O in BppO format |
CExtendedNewick | The so-called 'ExtendedNewick' parenthetic format for phylogenetic networks, where hybridization nodes are mandatory tagged and appear several times |
►CIODAG | General interface for DAG I/O |
CElement | |
CIPhyloDAG | General interface for DAG readers |
COPhyloDAG | General interface for DAG writers |
CAbstractIPhyloDAG | Partial implementation of the IDAG interface |
CAbstractOPhyloDAG | Partial implementation of the ODAG interface |
CIMultiPhyloDAG | General interface for multiple trees readers |
COMultiPhyloDAG | General interface for tree writers |
CAbstractIMultiPhyloDAG | Partial implementation of the IMultiDAG interface |
CAbstractOMultiPhyloDAG | Partial implementation of the ODAG interface |
CIoFrequencySet | General interface for model I/O |
CIFrequencySet | General interface for distance matrix readers |
COFrequencySet | General interface for distance matrix writers |
CIOFrequencySetFactory | Utilitary class for creating frequencies set readers and writers |
CIoSubstitutionModel | General interface for model I/O |
CISubstitutionModel | General interface for model readers |
COSubstitutionModel | General interface for distance matrix writers |
CIOSubstitutionModelFactory | Utilitary class for creating substitution model readers and writers |
►CIOTree | General interface for tree I/O |
CElement | |
CITree | General interface for tree readers |
CIPhyloTree | General interface for tree readers |
COTree | General interface for tree writers |
COPhyloTree | General interface for tree writers |
CAbstractITree | Partial implementation of the ITree interface |
CAbstractIPhyloTree | |
CAbstractOTree | Partial implementation of the OTree interface |
CAbstractOPhyloTree | Partial implementation of the OTree interface |
CIMultiTree | General interface for multiple trees readers |
CIMultiPhyloTree | |
COMultiTree | General interface for tree writers |
COMultiPhyloTree | General interface for tree writers |
CAbstractIMultiTree | Partial implementation of the IMultiTree interface |
CAbstractIMultiPhyloTree | Partial implementation of the IMultiTree interface |
CAbstractOMultiTree | Partial implementation of the OTree interface |
CAbstractOMultiPhyloTree | Partial implementation of the OTree interface |
CIOTreeFactory | Utilitary class for creating tree readers and writers |
CNewick | The so-called 'newick' parenthetic format |
CNexusIOTree | Simple parser for reading trees from a Nexus file |
►CNhx | The so-called 'Nhx - New Hampshire eXtended' parenthetic format |
CProperty | |
CLegacyAncestralStateReconstruction | Interface for ancestral states reconstruction methods |
CLegacyPhylogeneticsApplicationTools | This class provides some common tools for applications |
CIOPairedSiteLikelihoods | Base class for I/O on paired-site likelihoods |
CIOTreepuzzlePairedSiteLikelihoods | This class provides I/O for the Tree-Puzzle/RAxML (phylip-like) paired-site likelihoods format |
CIOPhymlPairedSiteLikelihoods | This class provides input for the Phyml paired-site likelihoods format |
CAbstractDiscreteRatesAcrossSitesTreeLikelihood | Partial implementation of the DiscreteRatesAcrossSitesTreeLikelihood interface |
►CAbstractHomogeneousTreeLikelihood | Partial implementation for homogeneous model of the TreeLikelihood interface |
CConstHomogeneousSiteModelIterator | |
►CAbstractNonHomogeneousTreeLikelihood | Partial implementation for branch non-homogeneous models of the TreeLikelihood interface |
CConstNonHomogeneousSiteModelIterator | |
►CAbstractTreeLikelihood | Partial implementation of the TreeLikelihood interface |
CConstNoPartitionBranchModelDescription | |
CConstNoPartitionBranchModelIterator | |
CConstNoPartitionSiteModelDescription | |
CSimpleBranchIterator | A very simple branch iterator |
CSimpleSiteIterator | A very simple site iterator |
CAbstractTreeLikelihoodData | Partial implementation of the TreeLikelihoodData interface |
CDiscreteRatesAcrossSitesTreeLikelihoodInterface | Interface for rate across sites (RAS) implementation |
CDRASDRTreeLikelihoodLeafData | Likelihood data structure for a leaf |
CDRASDRTreeLikelihoodNodeData | Likelihood data structure for a node |
CDRASDRTreeLikelihoodData | Likelihood data structure for rate across sites models, using a double-recursive algorithm |
CDRASRTreeLikelihoodNodeData | Likelihood data structure for a node |
CDRASRTreeLikelihoodData | Discrete Rate Across Sites, (simple) Recursive likelihood data structure |
CDRHomogeneousMixedTreeLikelihood | A class to compute the average of several DRHomogeneousTreeLikelihood defined from a Mixed Substitution Model |
CDRHomogeneousTreeLikelihood | This class implements the likelihood computation for a tree using the double-recursive algorithm |
CDRNonHomogeneousTreeLikelihood | This class implements the likelihood computation for a tree using the double-recursive algorithm, allowing for non-homogeneous models of substitutions |
CDRTreeLikelihoodInterface | Interface for double-recursive (DR) implementation of the likelihood computation |
CDRTreeLikelihoodTools | Utilitary methods dealing with objects implementing the DRTreeLikelihood interface |
CGlobalClockTreeLikelihoodFunctionWrapper | |
CHomogeneousTreeLikelihood | Specialization of the TreeLikelihood interface for the Homogeneous case |
CLegacyMarginalAncestralStateReconstruction | Likelihood ancestral states reconstruction: marginal method |
CBranchLikelihood | Compute likelihood for a 4-tree |
CNNIHomogeneousTreeLikelihood | This class adds support for NNI topology estimation to the DRHomogeneousTreeLikelihood class |
CNonHomogeneousTreeLikelihood | Specialization of the TreeLikelihood interface for the branch non-homogeneous and non-stationary models |
CPairedSiteLikelihoods | A container for paired-site likelihoods (likelihoods over the same sites for different models, especially topologies). An instance of this class is, roughly, a list of models, each of them having a name (stored in the modelNames attribute) and a set of site likelihoods (stored in the logLikelihoods attribute) |
CRASTools | Tools to deal with Rates Across Sites (RAS) models |
CRHomogeneousMixedTreeLikelihood | |
CRHomogeneousTreeLikelihood | This class implement the 'traditional' way of computing likelihood for a tree |
CRNonHomogeneousMixedTreeLikelihood | |
CRNonHomogeneousTreeLikelihood | This class implement the 'traditional' way of computing likelihood for a tree, allowing for non-homogeneous models of substitutions |
CSitePartitionHomogeneousTreeLikelihood | Specialization of the TreeLikelihood interface for partition models, homogeneous case |
►CTreeLikelihoodInterface | The TreeLikelihood interface |
CBranchIterator | An iterator over a set of branches, specified by their node ids |
CConstBranchModelDescription | A pair of SubstitutionModel / SiteIterator |
CConstBranchModelIterator | Iterates through all models used for all sites on a given branch |
CConstSiteModelDescription | A pair of SubstitutionModel / BranchIterator |
CConstSiteModelIterator | Iterates through all models used for all branches on a given site |
CSiteIterator | An iterator over a set of sites, specified by their position |
CTreeLikelihoodNodeData | TreeLikelihood partial data structure |
CTreeLikelihoodData | TreeLikelihood data structure |
CTreeLikelihoodTools | Utilitary methods that work with TreeLikelihood objects |
CLegacyMappingInterface | General interface for storing mapping data |
CLegacyAbstractMapping | Partial implementation of the mapping interface |
CLegacyProbabilisticRewardMapping | Legacy data storage class for probabilistic rewards mappings |
CLegacyProbabilisticSubstitutionMapping | Legacy data storage class for probabilistic substitution mappings |
CLegacyRewardMappingInterface | Legacy interface for storing reward mapping data |
CLegacyAbstractRewardMapping | Partial implementation of the reward mapping interface |
CLegacyRewardMappingTools | Provide methods to compute reward mappings |
CLegacySubstitutionMappingInterface | Legacy interface for storing mapping data |
CLegacyAbstractSubstitutionMapping | Partial implementation of the substitution mapping interface |
CLegacySubstitutionMappingTools | Provide methods to compute substitution mappings |
►CMixedSubstitutionModelSet | Substitution models manager for Mixed Substitution Models. This class inherits from SubstitutionModelSet |
►CHyperNode | |
CNode | |
CSubstitutionModelSet | Substitution models manager for non-homogeneous / non-reversible models of evolution |
CSubstitutionModelSetTools | Tools for automatically creating SubstitutionModelSet objects |
CNNITopologyListener | Listener used internally by the optimizeTreeNNI method |
CNNITopologyListener2 | Listener used internally by the optimizeTreeNNI2 method |
►CLegacyOptimizationTools | Optimization methods for phylogenetic inference |
CScaleFunction | |
CSimData | |
CNonHomogeneousSequenceSimulator | (Legacy) Site and sequences simulation under non-homogeneous models |
CAwareNode | A node class aware of its neighbours |
CNNITopologySearch | NNI topology search method |
CTreeIterator | |
CPostOrderTreeIterator | |
CPreOrderTreeIterator | |
CInOrderTreeIterator | |
CAbstractAutonomousSubstitutionProcess | A partial implementation of the SubstitutionProcess interface |
CAbstractSubstitutionProcess | A partial implementation of the SubstitutionProcess interface |
CAutoCorrelationSequenceEvolution | Sequence evolution framework based on an auto-correlation of substitution processes |
CAutonomousSubstitutionProcessInterface | Interface for SubstitutionProcess objects that own their own ParametrizablePhyloTree & Scenario |
CBackwardLikelihoodTree | |
CCollectionNodes | |
CValue | Abstract Node storing a value of type T |
CNode_DF | Base dataflow Node class |
►CContext | Context for dataflow node construction |
CCachedNodeRef | NodeRef is hashable and comparable as a pointer. CachedNodeRef is hashable and comparable, by comparing the node configuration: |
CCachedNodeRefHash | |
CCWiseFill | |
CCWiseMatching | |
CCWiseCompound | |
►CCWisePattern | |
Cpattern_functor | |
►CCWiseMatching< R, ReductionOf< T > > | |
Cmatching_functor | |
►CCWiseCompound< R, ReductionOf< T > > | |
Ccompound_functor | |
CCWiseAdd | |
CCWiseMean | |
CCWiseSub | |
CCWiseMul | |
CCWiseDiv | |
CMatrixProduct | |
CCWiseNegate | |
CCWiseInverse | |
CCWiseLog | |
CCWiseExp | |
CCWiseConstantPow | |
CScalarProduct | |
CLogSumExp | |
CSumOfLogarithms | |
CShiftDelta | |
CCombineDeltaShifted | |
CCWiseApply | |
CCWiseAdd< R, std::tuple< T0, T1 > > | |
CCWiseSub< R, std::tuple< T0, T1 > > | |
CCWiseAdd< R, ReductionOf< T > > | |
CCWiseMean< R, ReductionOf< T >, ReductionOf< P > > | |
CCWiseMean< R, ReductionOf< T >, P > | |
CCWiseMul< R, std::tuple< T0, T1 > > | |
CCWiseMul< R, ReductionOf< T > > | |
CCWiseDiv< R, std::tuple< T0, T1 > > | |
CNumericalDerivativeConfiguration | Configuration for a numerical derivation: what delta to use, and type of derivation |
CConstantTransitionFunction | |
CNoDimension | Empty type representing no dimensions |
CMatrixDimension | Basic matrix dimension type |
CVectorDimension | |
CRowVectorDimension | |
CDimension | Store a dimension for type T |
CDimension< double > | Specialisation of Dimension<T> for floating point types |
CDimension< uint > | |
CDimension< char > | |
CDimension< std::string > | |
CDimension< size_t > | |
CDimension< float > | |
CDimension< ExtendedFloat > | |
CDimension< Parameter > | |
CDimension< Eigen::Matrix< T, Rows, Cols > > | Specialisation of Dimension<T> for eigen matrix types |
CDimension< ExtendedFloatEigen< R, C, EigenType > > | |
CDimension< TransitionFunction > | |
CReductionOf | |
CConstantZero | R = 0 for each component |
CConstantOne | R = 1 for each component |
CNumericConstant | R = constant_value |
CNumericMutable | R = variable_value |
CConvert | R = convert(f) |
CNumericalDependencyTransform | Template struct used to describe a dependency transformation before compute() |
CTransposed | The T dependency should be transposed before computation |
CNumericalDependencyTransform< Transposed< T > > | Implementation for a dependency transposition |
CIdentity | R = id(f) |
CConfiguredDistribution | Data flow node representing a DiscreteDistribution configured with parameter values |
CProbabilitiesFromDiscreteDistribution | |
CProbabilityFromDiscreteDistribution | |
CCategoryFromDiscreteDistribution | |
CExtendedFloat | |
CExtendedFloatEigenCore | |
CExtendedFloatEigenBase | |
►CExtendedFloatEigen | |
COwnedExtendedFloat | |
CExtendedFloatArrayWrapper | |
CExtendedFloatVectorwiseOp | |
CExtendedFloatNoAlias | |
CExtendedFloatRow | |
CExtendedFloatCol | |
CForwardLikelihoodTree | |
CProbabilityDAG | |
CConfiguredFrequencySet | Data flow node representing a Frequencies Set configured with parameter values |
CFrequenciesFromFrequencySet | |
CLikelihoodCalculation | |
CAlignedLikelihoodCalculation | |
►CLikelihoodCalculationOnABranch | |
CRateCategoryEdge | |
►CLikelihoodCalculationSingleProcess | |
CProcessNodes | DF Nodes used in the process. ProcessTree is used without any rate multiplier |
CRateCategoryTrees | |
CConfiguredModel | Likelihood transition model |
CEquilibriumFrequenciesFromModel | |
CTransitionMatrixFromModel | |
CTransitionFunctionFromModel | |
CProbabilitiesFromMixedModel | |
CProbabilityFromMixedModel | |
CConfiguredParameter | Data flow node representing a parameter |
CShiftParameter | Shift param value = n * delta + x |
CValueFromConfiguredParameter | |
CConfiguredParametrizable | |
CProcessEdge | |
CProcessTree | |
CSequence_DF | Data flow node representing a Sequence as a Value<Eigen::MatrixXd> with a name |
CConfiguredSimplex | Data flow node representing a Frequencies Set configured with parameter values |
CFrequenciesFromSimplex | |
CConfiguredTransitionMatrix | Data flow node representing a TransitionMatrix configured with parameter values |
CEquilibriumFrequenciesFromTransitionMatrix | |
CTransitionMatrixFromTransitionMatrix | |
CHmmEmissionProbabilities_Eigen | Interface for computing emission probabilities in a Hidden Markov Model |
CHmmProcessAlphabet | Hidden states alphabet |
CHmmSequenceEvolution | Sequence evolution framework based on a hmm |
CMarginalAncestralReconstruction | Likelihood ancestral states reconstruction: marginal method |
CMixtureSequenceEvolution | Sequence evolution framework based on a mixture of substitution processes |
►CModelPath | Organization of submodels in mixed substitution models in a path. See class ModelScenario for a thorough description |
CPathNode | A vector<int> where all elements are different and in INCREASING ORDER. So inclusion should be done through dedicated methods |
CModelScenario | Organization of submodels in mixed substitution models as paths |
CMultiProcessSequenceEvolution | Partial implementation of multiple processes of sequences |
CNonHomogeneousSubstitutionProcess | Substitution process manager for non-homogeneous / non-reversible models of evolution |
COneProcessSequenceEvolution | Evolution of a sequence performed by a unique SubstitutionProcess all along the sequence |
CParametrizablePhyloTree | PhyloTree with Parametrizable Phylo Branches. They SHARE their branch length parameters |
CPartitionSequenceEvolution | Sequence evolution framework based on a mixture of substitution processes |
►CAbstractPhyloLikelihood | |
CStringPairHash | |
CAlignedPhyloLikelihoodInterface | The AlignedPhyloLikelihood interface, for phylogenetic likelihood |
CAbstractAlignedPhyloLikelihood | |
CAlignedPhyloLikelihoodAutoCorrelation | Likelihood framework based on a hmm of simple likelihoods |
CAlignedPhyloLikelihoodHmm | Likelihood framework based on a hmm of simple likelihoods |
CAlignedPhyloLikelihoodMixture | Likelihood framework based on a mixture of aligned likelihoods |
CAlignedPhyloLikelihoodProduct | The AlignedPhyloLikelihoodProduct class, for phylogenetic likelihood on several independent data |
CAlignedPhyloLikelihoodSetInterface | Joint interface SetOf+Aligned PhylLikelihood |
CAbstractAlignedPhyloLikelihoodSet | The AlignedPhyloLikelihoodSet abstract class |
CAutoCorrelationProcessPhyloLikelihood | Likelihood framework based on an auto-correlation of simple likelihoods |
CHmmLikelihood_DF | A simple implementation of hidden Markov models recursion, in DataFlow implementation |
CCondLikelihood | |
CForwardHmmLikelihood_DF | |
CForwardHmmDLikelihood_DF | |
CForwardHmmD2Likelihood_DF | |
CBackwardHmmLikelihood_DF | |
CHmmPhyloAlphabet | Hidden states alphabet |
CHmmPhyloEmissionProbabilities | Emission probabilities in the context of DF phylolikeihoods |
CHmmProcessPhyloLikelihood | Likelihood framework based on a hmm of simple likelihoods |
CMixtureProcessPhyloLikelihood | Likelihood framework based on a mixture of simple likelihoods |
CMultiProcessSequencePhyloLikelihood | Partial implementation of the Likelihood interface for multiple processes |
COnABranchPhyloLikelihood | Wraps a dataflow graph as a function: resultNode = f(variableNodes) |
COneProcessSequencePhyloLikelihood | The OneProcessSequencePhyloLikelihood class: phylogenetic likelihood computation with a single process |
CProcPos | Likelihood framework based on a partition of a sequence in simple likelihoods |
CPartitionProcessPhyloLikelihood | |
CPhyloLikelihoodInterface | The PhyloLikelihood interface, for phylogenetic likelihood |
CPhyloLikelihoodContainer | The PhyloLikelihoodContainer, owns and assigns numbers to Phylolikelihoods |
CPhyloLikelihoodFormula | The PhyloLikelihoodFormula class, for phylogenetic likelihood on several independent data |
CPhyloLikelihoodSetInterface | The PhyloLikelihoodSet interface, to manage a subset of PhyloLikelihoods from a given PhyloLikelihoodContainer |
CAbstractPhyloLikelihoodSet | The PhyloLikelihoodSet class, to manage a subset of PhyloLikelihoods from a given PhyloLikelihoodContainer |
CSequencePhyloLikelihoodInterface | PhyloLikelihoods based on Sequence Evolution class, ie for which there is a (set of) processes able to build a sequence |
CAbstractSequencePhyloLikelihood | |
CAbstractParametrizableSequencePhyloLikelihood | |
CSingleDataPhyloLikelihoodInterface | The SingleDataPhyloLikelihood interface, for phylogenetic likelihood |
CAbstractSingleDataPhyloLikelihood | |
CSingleProcessPhyloLikelihood | Wraps a dataflow graph as a function: resultNode = f(variableNodes) |
CProcessComputationNode | Tree Organization of Computing Nodes |
CProcessComputationEdge | |
CProcessComputationTree | |
CRateAcrossSitesSubstitutionProcess | |
CSequenceEvolution | This interface describes the evolution process of a sequence |
CSimpleSubstitutionProcess | Space and time homogeneous substitution process, without mixture |
CSitePartition | This is the interface for classes describing a site partition, each partition being intended to have its own substitution model |
CTrivialSitePartition | Trivial site partition: all sites belong to the same, unique partition |
CSubstitutionProcessInterface | This interface describes the substitution process along the tree and sites of the alignment |
CSubstitutionProcessCollection | Collection of Substitution Process, which owns all the necessary objects: Substitution models, frequencies sets, rate distributions and trees |
►CSubstitutionProcessCollectionMember | |
CDeleter | |
CBranchedModelSet | |
CCategorySubstitutionRegister | The CategorySubstitutionRegisters |
CComprehensiveSubstitutionRegister | Distinguishes all types of substitutions |
CGCSubstitutionRegister | Distinguishes AT<->GC from GC<->AT |
CGCSynonymousSubstitutionRegister | Distinguishes AT->GC vs GC->AT inside synonymous substitutions on third codon position |
CGCPositionSubstitutionRegister | Distinguishes AT->GC vs GC->AT on given codon position (0, 1, or 2) |
CDecompositionMethods | Methods useful for analytical substitution count and rewards using the eigen decomposition method |
CDecompositionReward | Analytical reward using the eigen decomposition method |
CDecompositionSubstitutionCount | Analytical substitution count using the eigen decomposition method |
CLaplaceSubstitutionCount | Laplace estimate of the substitution count |
CMappingInterface | General interface for storing mapping data |
CAbstractMapping | Partial implementation of the mapping interface |
CNaiveSubstitutionCount | Naive substitution count |
CLabelSubstitutionCount | Labelling substitution count |
COneJumpSubstitutionCount | Computes the probability that at least one jump occurred on a branch, given the initial and final state |
CPhyloBranchMapping | |
CPhyloBranchReward | |
CModelBranch | |
CAbstractSinglePhyloSubstitutionMapping | The AbstractSinglePhyloSubstitutionMapping class: substitution mapping linked with a Single Process PhyloLikelihood |
COneProcessSequenceSubstitutionMapping | The OneProcessSequenceSubstitutionMapping class: substitution mapping linked with a OneProcessSequencePhyloLikelihood |
CPhyloSubstitutionMapping | |
CSingleProcessSubstitutionMapping | The SingleProcessSubstitutionMapping class: substitution mapping linked with a SingleProcessPhyloLikelihood |
CProbabilisticRewardMapping | Data storage class for probabilistic rewards mappings |
CProbabilisticSubstitutionMapping | Data storage class for probabilistic substitution mappings |
CReward | The Reward interface |
CAbstractReward | Basic implementation of the the Reward interface |
CRewardMappingInterface | General interface for storing reward mapping data |
CAbstractRewardMapping | Partial implementation of the substitution mapping interface |
CRewardMappingTools | Provide methods to compute reward mappings |
CStochasticMapping | |
CSubstitutionCountInterface | The SubstitutionsCount interface |
CAbstractSubstitutionCount | Partial implementation of the SubstitutionCount interface |
CSubstitutionDistance | Interface allowing for using distances between states in substitution counts |
CAbstractSubstitutionDistance | Partial implementation of the SubstitutionDistance interface |
CSubstitutionMapping | General interface for storing mapping data |
CAbstractSubstitutionMapping | Partial implementation of the substitution mapping interface |
CSubstitutionMappingTools | Provide methods to compute substitution mappings |
CSubstitutionRegisterInterface | The SubstitutionRegister interface |
CAbstractSubstitutionRegister | |
CTotalSubstitutionRegister | Count all substitutions |
CCompleteSubstitutionRegister | Completion of a given substitution register to consider all substitutions. The new substitutions are considered in an additional type |
CVectorOfSubstitutionRegisters | Sets a Register based on a vector of Registers. The categories are intersection of categories of those Registers |
CGeneralSubstitutionRegister | Sets a Register based on a matrix of integers. If M is the matrix, M[i,j] is the number of the substitution type from i to j, or 0 if there is no substitution type from i to j |
CSelectedSubstitutionRegister | Class inheriting from GeneralSubstitutionRegister, this one uses a special constructor which allows it to build a substitution matrix from string input specifying a desired substitutions |
CAAInteriorSubstitutionRegister | Indexes only intra amino-acid substitutions. Every group represents a substitutions for the same amino acid. Met and Trp are not taken into account due their non-degenerescence |
CAAExteriorSubstitutionRegister | Indexes only substitutions between amino-acids. Groups are distinguished by their direction |
CTsTvSubstitutionRegister | Distinguishes transitions from transversions |
CSWSubstitutionRegister | Distinguishes substitutions given the link between the changed nucleotides : S for strong (GC) and W for weak (AT) |
CDnDsSubstitutionRegister | Distinguishes synonymous from non-synonymous substitutions |
CKrKcSubstitutionRegister | Count conservative and radical amino-acid substitutions |
CUniformizationSubstitutionCount | Analytical (weighted) substitution count using the uniformization method |
CWeightedSubstitutionCount | Interface allowing for weighting of substitution counts according to state properties |
CAbstractWeightedSubstitutionCount | Partial implementation of the WeightedSubstitutionCount interface |
CAbstractBiblioMixedTransitionModel | Abstract class for mixture models based on the bibliography |
CAbstractBiblioTransitionModel | Partial implementation of the SubstitutionModel interface for models that are set for matching the bibliography, and are only defined through a link to a "real" model |
CAbstractBiblioSubstitutionModel | |
CAbstractFromSubstitutionModelTransitionModel | Virtual class of a Transition Model related to a given SubstitutionModel |
CAbstractKroneckerWordSubstitutionModel | Abstract Kronecker Word Model |
CAbstractMixedTransitionModel | Partial implementation for Mixed Transition models, defined as a mixture of "simple" substitution models. Each model has a specific probability and rate, with the constraint that the expectation (on the distribution of the models) of the rate of all the models equals one |
CAbstractLkTransitionModel | Partial implementation of the TransitionModel interface, with function for likelihood computations |
CAbstractTransitionModel | Partial implementation of the TransitionModel interface |
CAbstractSubstitutionModel | |
CAbstractReversibleSubstitutionModel | Partial implementation of the ReversibleSubstitutionModel interface |
CModelList | A list of models, for building a WordSubstitutionModel |
CAbstractWordSubstitutionModel | Abstract Basal class for words of substitution models |
CAbstractWrappedModel | Abstract class of Wrapping model class, where all methods are redirected from model() |
CAbstractWrappedTransitionModel | |
CAbstractTotallyWrappedTransitionModel | |
CAbstractWrappedSubstitutionModel | |
CAbstractTotallyWrappedSubstitutionModel | |
CAnonymousSubstitutionModel | |
CBinarySubstitutionModel | The Model on two states |
CAbstractCodonAAFitnessSubstitutionModel | Abstract class for modelling of ratios of substitution rates between codons, whatever they are synonymous or not |
CAbstractCodonAARateSubstitutionModel | Abstract class for modelling of non-synonymous and synonymous substitution rates in codon models, given an amino acid rate matrix (from a shared_ptr model) |
CAbstractCodonBGCSubstitutionModel | Abstract class for modelling of non-synonymous and synonymous substitution rates in codon models, with gBGC |
CAbstractCodonClusterAASubstitutionModel | Abstract class for modelling of non-synonymous and synonymous substitution rates in codon models, with AA clustered |
CAbstractCodonCpGSubstitutionModel | Abstract class for modelling of CpG -> CpA or TpG (symmetric) hypermutability substitution rate inside codons. Note that the neihbouring effects between codons are not considered |
CAbstractCodonDistanceSubstitutionModel | Abstract class for modelling of non-synonymous and synonymous substitution rates in codon models |
CAbstractCodonFitnessSubstitutionModel | Abstract class for modelling of ratios of substitution rates between codons, whatever they are synonymous or not |
CAbstractCodonFrequenciesSubstitutionModel | Abstract Class for substitution models on codons parametrized by frequencies |
CAbstractCodonPhaseFrequenciesSubstitutionModel | Abstract Class for substitution models on codons parametrized by a frequency |
CAbstractCodonSubstitutionModel | Abstract class for substitution models on codons |
CAbstractDFPSubstitutionModel | Class for neutral substitution models on triplets, following the mutation process proposed in Doron-Fagenboim & Pupko, 2006, but without equilibrium frequencies. This model is an extension of Kimura 2-rates substitution model to codons |
CAbstractKroneckerCodonSubstitutionModel | Abstract class for substitution models on codons allowing multiple substitutions |
CCodonAdHocSubstitutionModel | Class for substitution models of codons with several layers of codon models |
CCodonDistanceFrequenciesSubstitutionModel | Class for asynonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic models |
CCodonDistancePhaseFrequenciesSubstitutionModel | Class for asynonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic basic models |
CCodonDistanceSubstitutionModel | Class for substitution models of codons with non-synonymous/synonymous ratios of substitution rates defined through a distance between amino-acids |
CCodonSameAARateSubstitutionModel | Class for modelling of non-synonymous rates in codon models, such that the substitution rates between amino acids are similar to the ones in an amino acid rate matrix (from a shared_ptr model) |
CCoreCodonSubstitutionModelInterface | Interface for codon models |
CCodonSubstitutionModelInterface | |
CCodonReversibleSubstitutionModelInterface | Interface for reversible codon models |
CDFP07 | Class for non-synonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic models, with allowed multiple substitutions as parameterized in DFP model, with correction to mimic AA substitution rates from a given protein substitution model |
CDFPDistanceFrequenciesSubstitutionModel | Class for non-synonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic models, with allowed multiple substitutions as parameterized in DFP model |
CGY94 | The Goldman and Yang (1994) substitution model for codons |
CKCM | The general multiple substitution model for codons, from Zaheri & al, 2014 |
CKroneckerCodonDistanceFrequenciesSubstitutionModel | Class for non-synonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic models, with allowed multiple substitutions |
CKroneckerCodonDistanceSubstitutionModel | Class for non-synonymous substitution models on codons with parameterized nucleotidic models, with allowed multiple substitutions |
CMG94 | The Muse and Gaut (1994) substitution model for codons |
CRELAX | The RELAX (2014) branch-site model for codons |
CSENCA | Class for non-synonymous and synonymous substitution models on codons with parameterized equilibrium frequencies and nucleotidic basic models |
CTripletSubstitutionModel | Class for neutral substitution models on triplets, which correspond to codons that do not have any significance (whether they are STOP or functional) |
CYN98 | The Yang and Nielsen (1998) substitution model for codons |
CYNGP_M | Abstract generic class for The Yang et al (2000) M substitution models for codons. al (2004) |
CYNGP_M1 | The Yang et al (2000) M1 substitution model for codons, with the more realistic modification in Wong & al (2004) |
CYNGP_M10 | The Yang et al (2000) M10 substitution model for codons |
CYNGP_M2 | The Yang et al (2000) M2 substitution model for codons, with the more realistic modification in Wong & al (2004) |
CYNGP_M3 | The Yang et al (2000) M3 substitution model for codons |
CYNGP_M7 | The Yang et al (2000) M7 substitution model for codons |
CYNGP_M8 | The Yang et al (2000) M8 substitution model for codons |
CYNGP_M9 | The Yang et al (2000) M9 substitution model for codons |
CD1WalkSubstitutionModel | The D1Walk substitution model for Integer alphabet [0;N-1]. In this model, substitutions are possible between adjacent states only. The model is defined through an equilibrium distribution, and rates towards a state are proportional to its frequency at equilibrium |
CEquiprobableSubstitutionModel | The EquiprobableSubstitutionModel substitution model for any kind of alphabet. Jukes-Cantor models are specific case of this model, applied to nucleotides or proteins |
CCodonFrequencySetInterface | Parametrize a set of state frequencies for codons |
CFullCodonFrequencySet | A generic FrequencySet for Full Codon alphabets |
CFixedCodonFrequencySet | FrequencySet useful for homogeneous and stationary models, codon implementation |
CUserCodonFrequencySet | |
CFullPerAACodonFrequencySet | FrequencySet integrating ProteinFrequencySet inside CodonFrequencySet. In this case, FrequencieSet defined inside each amino acid is parametrized as a FullFrequencySet. Hence there are 61-20=41 parameters in addition of the parameters of the ProteinFrequencySet |
CCodonFromIndependentFrequencySet | Frequencies in codons are the product of Independent Frequencies in letters with the frequencies of stop codons set to zero |
CCodonFromUniqueFrequencySet | Frequencies in codons are the product of the frequencies for a unique FrequencySet in letters, with the frequencies of stop codons set to zero |
CFrequencySetInterface | Parametrize a set of state frequencies |
CAbstractFrequencySet | Basic implementation of the FrequencySet interface |
CFullFrequencySet | A generic FrequencySet allowing for the estimation of all frequencies |
CFromModelFrequencySet | FrequencySet defined from the equilibrium distribution of a given model |
CMarkovModulatedFrequencySet | FrequencySet to be used with a Markov-modulated substitution model |
CFixedFrequencySet | FrequencySet useful for homogeneous and stationary models |
CUserFrequencySet | FrequencySet to be read in a file. More specifically, a frequency set is read in a column of a given file, which column number is given in argument (default: 1) |
CMvaFrequencySet | A frequencies set used to estimate frequencies at the root with the COaLA model. Frequencies at the root are optimized in the same way than the equlibrium frequencies on branches. Hyperparameters are used, which represent positions along the principal axes obtained from a preliminary Correspondence Analysis. From the optimized positions, the 20 frequencies are calculated |
CNucleotideFrequencySetInterface | Parametrize a set of state frequencies for nucleotides |
CGCFrequencySet | Nucleotide FrequencySet using only one parameter, the GC content |
CFullNucleotideFrequencySet | Nucleotide FrequencySet using three independent parameters (theta, theta1, theta2) to modelize the four frequencies: |
CFixedNucleotideFrequencySet | FrequencySet useful for homogeneous and stationary models, nucleotide implementation |
CUserNucleotideFrequencySet | FrequencySet useful for homogeneous and stationary models, nucleotide implementation |
CProteinFrequencySetInterface | Parametrize a set of state frequencies for proteins |
CFullProteinFrequencySet | Protein FrequencySet using 19 independent parameters to model the 20 frequencies |
CFixedProteinFrequencySet | FrequencySet useful for homogeneous and stationary models, protein implementation |
CUserProteinFrequencySet | FrequencySet from file |
CWordFrequencySetInterface | Frequencies in words computed from the frequencies on letters. The parameters are the parameters of the Frequencies on letters. The WordFrequencySet owns the std::shared_ptr<FrequencySet> it is built on. Interface class |
CAbstractWordFrequencySet | |
CWordFromIndependentFrequencySet | Frequencies in words are the product of Independent Frequencies in letters |
CWordFromUniqueFrequencySet | |
CFromMixtureSubstitutionModel | Model taken from a SubModel of a Mixture of SubstitutionModels |
CG2001 | Galtier's 2001 covarion model |
CInMixedSubstitutionModel | SubModel taken from a MixedTransitionModel, kept in the context of the MixedTransitionModel (see FromMixtureSubstitutionModel for an out of context subModel). So "rate" and "scale" are set for the MixedTransitionModel |
CKroneckerWordSubstitutionModel | Basal class for words of substitution models with multiple substitutions |
CMarkovModulatedSubstitutionModel | Partial implementation of the Markov-modulated class of substitution models |
CMixedTransitionModelInterface | Interface for Transition models, defined as a mixture of "simple" transition models |
CMixtureOfASubstitutionModel | |
CMixtureOfATransitionModel | Transition models defined as a mixture of nested substitution models |
CMixtureOfSubstitutionModels | |
CMixtureOfTransitionModels | Transition models defined as a mixture of several substitution models |
CMultinomialFromTransitionModel | From a model, compute the likelihood of counts given an ancestral state |
CF81 | The Felsenstein (1981) substitution model for nucleotides |
CF84 | The Felsenstein (1984) substitution model for nucleotides |
CgBGC | GBGC model |
CGTR | The General Time-Reversible substitution model for nucleotides |
CHKY85 | The Hasegawa M, Kishino H and Yano T (1985) substitution model for nucleotides |
CJCnuc | The Jukes-Cantor substitution model for nucleotides |
CK80 | The Kimura 2-rates substitution model for nucleotides |
CL95 | The no-strand bias substitution model for nucleotides, from Lobry 1995. The point of this model is that the substitution rate from a nucleotide N towards another M is the same as the rate from the complement of N towards the complement of M. Note that this model is not reversible |
CNucleotideSubstitutionModelInterface | Specialisation interface for nucleotide substitution model |
CNucleotideReversibleSubstitutionModelInterface | Specialisation interface for rversible nucleotide substitution model |
CAbstractNucleotideSubstitutionModel | Specialisation abstract class for nucleotide substitution model |
CAbstractReversibleNucleotideSubstitutionModel | Specialisation abstract class for reversible nucleotide substitution model |
CRN95 | The model described by Rhetsky & Nei, where the only hypothesis is that the transversion rates are only dependent of the target nucleotide. This model is not reversible |
CRN95s | Intersection of models RN95 and L95 |
CSSR | The Strand Symmetric Reversible substitution model for nucleotides |
CT92 | The Tamura (1992) substitution model for nucleotides |
CTN93 | The Tamura and Nei (1993) substitution model for nucleotides |
CYpR | YpR model |
CYpR_Sym | Symmetrical YpR model |
CYpR_Gen | General YpR model |
COneChangeRegisterTransitionModel | From a model, compute transition probabilities given there is at least a change of a category (ie a non null number in a register) in the branch |
COneChangeTransitionModel | From a model, compute transition probabilities given there is at least a change in the branch |
CPOMO | |
CCoala | The Coala branch-heterogeneous amino-acid substitution model |
CCoalaCore | This class is the core class inherited by the Coala class. COaLA is a branch-heterogeneous amino-acid substitution model |
CDSO78 | The Dayhoff, Schwartz and Orcutt substitution model for proteins |
CJCprot | The Jukes-Cantor substitution model for proteins |
CJTT92 | The Jones, Taylor and Thornton substitution model for proteins |
CLG08 | The Le and Gascuel substitution model for proteins |
►CLG10_EX_EHO | The Le and Gascuel (2010) EX_EHO substitution model for proteins |
CEmbeddedModel | |
►CLGL08_CAT | The Le et al (2008) CAT substitution model for proteins |
CEmbeddedModel | |
►CLLG08_EHO | The Le et al (2008) EH0 substitution model for proteins |
CEmbeddedModel | |
►CLLG08_EX2 | The Le et al (2008) EX2 substitution model for proteins |
CEmbeddedModel | |
►CLLG08_EX3 | The Le et al (2008) EX3 substitution model for proteins |
CEmbeddedModel | |
►CLLG08_UL2 | The Le et al (2008) UL2 substitution model for proteins |
CEmbeddedModel | |
►CLLG08_UL3 | The Le et al (2008) UL3 substitution model for proteins |
CEmbeddedModel | |
CProteinSubstitutionModelInterface | Specialized interface for protein substitution model |
CProteinReversibleSubstitutionModelInterface | Specialized interface for protein reversible substitution model |
CAbstractProteinSubstitutionModel | Specialisation abstract class for protein substitution model |
CAbstractReversibleProteinSubstitutionModel | Specialisation abstract class for reversible protein substitution model |
CUserProteinSubstitutionModel | Build an empirical protein substitution model from a file |
CWAG01 | The Whelan and Goldman substitution model for proteins |
CConstantRateDistribution | |
CExponentialDiscreteRateDistribution | |
CGammaDiscreteRateDistribution | |
CGaussianDiscreteRateDistribution | |
CRE08 | The Rivas-Eddy substitution model with gap characters |
CRE08Nucleotide | This is a wrapper class of RE08 for nucleotide substitution models |
CRE08Protein | This is a wrapper class of RE08 for protein substitution models |
CRE08Codon | This is a wrapper class of RE08 for codon substitution models |
CRegisterRatesSubstitutionModel | From a model, substitution rates are set into categories following a given register. Each substitution of a category is then multiplied by a rate parameter specific to this category |
CStateMapInterface | Map the states of a given alphabet which have a model state |
CAbstractStateMap | A convenience partial implementation of the StateMap interface |
CCanonicalStateMap | This class implements a state map where all resolved states are modeled |
CMarkovModulatedStateMap | This class implements a state map for Markov modulated models |
CBranchModelInterface | Interface for all Branch models |
CTransitionModelInterface | Interface for all transition models |
CSubstitutionModelInterface | Interface for all substitution models |
CReversibleSubstitutionModelInterface | Interface for reversible substitution models |
CTransitionFromTransitionModel | From a transition model, compute the transition function probabilities |
CTS98 | Tuffley and Steel's 1998 covarion model |
CTwoParameterBinarySubstitutionModel | The Model on two states |
CWordSubstitutionModel | Basal class for words of substitution models |
CWrappedModelInterface | Wrapping model interface |
CWrappedTransitionModelInterface | |
CWrappedSubstitutionModelInterface | |
CNaNListener | A listener which capture NaN function values and throw an exception in case this happens |
►COptimizationTools | Optimization methods for phylogenetic inference |
COptimizationOptions | |
CAbstractTreeParsimonyData | Partial implementation of the TreeParsimonyData interface |
CAbstractTreeParsimonyScore | Partial implementation of the TreeParsimonyScore interface |
CDRTreeParsimonyNodeData | Parsimony data structure for a node |
CDRTreeParsimonyLeafData | Parsimony data structure for a leaf |
CDRTreeParsimonyData | Parsimony data structure for double-recursive (DR) algorithm |
CDRTreeParsimonyScore | Double recursive implementation of interface TreeParsimonyScore |
CTreeParsimonyNodeDataInterface | TreeParsimonyScore node data structure |
CTreeParsimonyDataInterface | TreeParsimonyScore data structure |
CTreeParsimonyScoreInterface | Compute a parsimony score |
CPatternTools | Utilitary methods to compute site patterns |
CPhyloStatistics | Compute several quantities on a tree simulateously, optimizing the recursions on the tree |
►CPseudoNewtonOptimizer | This Optimizer implements Newton's algorithm for finding a minimum of a function. This is in fact a modified version of the algorithm, as suggested by Nicolas Galtier, for the purpose of optimizing phylogenetic likelihoods |
CPNStopCondition | |
CSiteSimulationResult | Data structure to store the result of a DetailedSiteSimulator |
CRASiteSimulationResult | Data structure to store the result of a DetailedSiteSimulator |
CDetailedSiteSimulatorInterface | This interface adds the dSimulate method to the SiteSimulator interface |
CEvolutionSequenceSimulator | |
CGivenDataSubstitutionProcessSequenceSimulator | Sequences simulation under a unique substitution process, but with site specific posterior probabilities |
CGivenDataSubstitutionProcessSiteSimulator | Site simulation under a unique substitution process, given data |
CMutationPath | This class is used by MutationProcess to store detailed results of simulations |
CMutationProcess | Interface for simulations |
CAbstractMutationProcess | Partial implementation of the MutationProcess interface |
CSimpleMutationProcess | Generally used mutation process model |
CSelfMutationProcess | This class is mainly for testing purpose. It allow "self" mutation of the kind i->i; |
CSequenceSimulationTools | Tools for sites and sequences simulation |
CSequenceSimulatorInterface | The SequenceSimulator interface. SequenceSimulator classes can simulate whole datasets |
CSimpleSubstitutionProcessSequenceSimulator | Sequences simulation under a unique substitution process |
CSimProcessNode | |
CSimProcessEdge | |
CSimpleSubstitutionProcessSiteSimulator | Site simulation under a unique substitution process |
CSiteSimulatorInterface | The SiteSimulator interface. SiteSimulator classes can simulate single sites |
CSubstitutionProcessSequenceSimulator | Sequences simulation under position specific substitution process |
►CSitePatterns | Data structure for site patterns |
CSortableSite | Class used for site pattern sorting |
CTreeTemplate | The phylogenetic tree class |
CBipartitionList | This class deals with the bipartitions defined by trees |
CBipartitionTools | This class provides tools related to the BipartitionList class |
CNNISearchable | Interface for Nearest Neighbor Interchanges algorithms |
CNode | The phylogenetic node class |
CNodeTemplate | The NodeTemplate class |
CPhyloBranch | |
CPhyloBranchParam | |
CNodeEvent | |
CPhyloNode | |
CPhyloTree | |
CPhyloNodeException | General exception thrown when something is wrong with a particular node |
CPhyloNodePException | General exception thrown when something is wrong with a particular node |
CPhyloNodePropertyNotFoundException | General exception thrown if a property could not be found |
CPhyloNodeNotFoundException | Exception thrown when something is wrong with a particular node |
CPhyloBranchException | General exception thrown when something is wrong with a particular branch |
CPhyloBranchPException | General exception thrown when something is wrong with a particular branch |
CPhyloBranchPropertyNotFoundException | General exception thrown if a property could not be found |
CPhyloBranchNotFoundException | Exception thrown when something is wrong with a particular branch |
CPhyloTreeException | General exception thrown when something wrong happened in a tree |
CUnrootedPhyloTreeException | Exception thrown when a tree is expected to be rooted |
►CPhyloTreeTools | Generic utilitary methods dealing with trees |
CMoments_ | |
CTopologyChangeEvent | Class for notifying new toplogy change events |
CTopologyListener | Implement this interface to be notified when the topology of a tree has changed during topology search |
CTopologySearch | Interface for topology search methods |
CTree | Interface for phylogenetic tree objects |
CNodeException | General exception thrown when something is wrong with a particular node |
CNodePException | General exception thrown when something is wrong with a particular node |
CPropertyNotFoundException | General exception thrown if a property could not be found |
CNodeNotFoundException | Exception thrown when something is wrong with a particular node |
CTreeException | General exception thrown when something wrong happened in a tree |
CUnrootedTreeException | Exception thrown when a tree is expected to be rooted |
►CTreeTemplateTools | Utilitary methods working with TreeTemplate and Node objects |
CElement | |
CMoments_ | A structure recording, for a subtree, the sum of root-leaf distances, the sum of their squares, and the number of elements in these sums (ie. the number of leaves) |
COrderTreeData_ | |
►CTreeTools | Generic utilitary methods dealing with trees |
CMoments_ | |
►NEigen | |
CNumTraits< bpp::ExtendedFloat > | |
CScalarBinaryOpTraits< bpp::ExtendedFloat, double, BinaryOp > | |
CScalarBinaryOpTraits< double, bpp::ExtendedFloat, BinaryOp > | |