All Classes Interface Summary Class Summary Exception Summary
Class |
Description |
AbstractAlignment |
abstract base class for any alignment data.
|
AbstractLeafNode |
|
AbstractParentableConstrainedNode |
|
AbstractRateMatrix |
abstract base class for all rate matrices
|
AlgorithmCallback |
|
AlgorithmCallback.Utils |
A Utility class that provides some simple implementations of AlgorithmCallback
that can be used for manipulating callback results
|
Alignment |
interface for any alignment data.
|
AlignmentBuilder |
A class for the gradual construction of an alignment.
|
AlignmentDistanceMatrix |
compute distance matrix (observed and ML) from alignment (SitePattern)
|
AlignmentGenerator |
A AlignmentGenerator is an object that can generate alignments! (most probably replicates for statistical tests)
|
AlignmentGenerator.Utils |
|
AlignmentParseException |
Exception thrown by ReadAlignment
|
AlignmentReaders |
Temporary class for reading alignments...
|
AlignmentReaders.PhylipClustalAlignment |
|
AlignmentReaders.UnalignedAlignment |
|
AlignmentReceiver |
|
AlignmentReceiver.BucketReceiver |
The SingleReceiver only keeps track of one alignment, the last one it received
|
AlignmentReceiver.SingleReceiver |
The SingleReceiver only keeps track of one alignment, the last one it received
|
AlignmentTool |
Simple access for alignment functions.
|
AlignmentUtils |
Helper utilities for alignments.
|
AmbiguousDataType |
Additional interface information for data types which represent ambiguity in
sub types.
|
AminoAcidModel |
base class of rate matrices for amino acids
|
AminoAcidModelID |
interface for IDs of amino acid models
|
AminoAcids |
implements DataType for amino acids
|
AnnotationAlignment |
The AnnotationAlignment interface is designed to provide annotation for an alignment.
|
Assessor |
Title:
|
Attribute |
An immutable attribute has a name and value.
|
AttributeNode |
interface for a node (includes branch) in a binary/non-binary
rooted/unrooted tree.
|
Binomial |
Binomial coefficients
|
BLOSUM62 |
BLOSUM62 model of amino acid evolution
|
BootstrappedAlignment |
generates bootstrapped alignments from a raw alignment
|
BootstrapStatistics |
computation of bootstrap estimators (BIAS, SD, VAR, CI)
given a statistic theta and corresponding bootstrap replicates.
|
BoundsCheckedFunction |
returns a very large number instead of the function value
if arguments are out of bound (useful for minimization with
minimizers that don't check argument boundaries)
|
BranchAccess |
|
BranchAccess.Utils |
|
BranchLimits |
limits for branch lengths
|
CachedRateMatrix |
a cached rate matrix.
|
CharacterAlignment |
This interface is designed to hold quantitative character states.
|
ChiSquareDistribution |
chi-square distribution
(distribution of sum of squares of n uniform random variables)
(Parameter: n; mean: n; variance: 2*n)
The chi-square distribution is a special case of the Gamma distribution
(shape parameter = n/2.0, scale = 2.0).
|
ChiSquareTest |
chi-square test
|
ChiSquareValue |
computes chi-square value of a (parameterized) tree for
its set of parameters (e.g., branch lengths)
and a given distance matrix
|
CircularGraphics |
|
CladeSystem |
data structure for a set of splits
|
ClassDistribution |
|
ClockTree |
provides parameter interface to a clock tree
(parameters are the minimal node height differences
at each internal node)
|
ClusterTree |
|
ClusterTree.ClusteringMethod |
An interface for describing Clustering methods
To be updated to cope with Ward's method and others...
|
CoalescentException |
Exceptions to do with coalescent models et cetera.
|
CoalescentIntervals |
A series of coalescent intervals representing the time
order information contained in a (serial) clock-constrained
tree.
|
CoalescentSimulator |
Simulates a set of coalescent intervals given a demographic model.
|
CoalescentTree |
interface defining a parameterized tree that
includes demographic information.
|
CodonModel |
base class for nucleotide rate matrices
|
Codons |
implements DataType for all Codons (including terminators).
|
CodonTable |
Describes a device for translating Nucleotide triplets
or codon indices into amino acid codes.
|
CodonTableFactory |
Generates CodonTables
|
CodonTableUtils |
Nucleotide Translating Utilities
|
Comparable |
interface for an object that is comparable.
|
ComparableDouble |
This class is unfortunate but necessary to conform to JDK 1.1
|
Comparator |
interface for an object that can compare other objects for the
purposes of ordering them.
|
ConcatenatedAlignment |
concatenates a list of alignments to one single alignment,
increasing the number of sites
|
ConcatenatedAnnotatedAlignment |
This is an annotation version of the ConcatenatedAlignment
Unlike normal ConcatenatedAlignment, it permits for merges with different numbers
of sequences.
|
ConditionalProbabilityStore |
Title: ConditionalProbabilityStore (was ConditionalLikelihoodStore)
|
ConditionalProbabilityStore.ExtraProcessor |
|
ConjugateDirectionSearch |
methods for minimization of a real-valued function of
several variables without using derivatives (Brent's modification
of a conjugate direction search method proposed by Powell)
|
ConjugateGradientSearch |
minimization of a real-valued function of
several variables using a the nonlinear
conjugate gradient method where several variants of the direction
update are available (Fletcher-Reeves, Polak-Ribiere,
Beale-Sorenson, Hestenes-Stiefel) and bounds are respected.
|
ConstantIndependentSingleSplitDistribution |
Title: ConstantIndependentSingleSplitDistribution
|
ConstantMutationRate |
This class models a constant mutation rate
(parameter: mu = mutation rate).
|
ConstantPopulation |
This class models coalescent intervals for a constant population
(parameter: N0=present-day population size).
|
Constants |
Title: Constants
|
ConstExpConst |
This class models a population that grows exponentially from an
initial population size alpha N0 at time y to a size N0
at time x until the present-day.
|
ConstExpGrowth |
This class models a population that grows
exponentially from an inital population size alpha N0 to a present-day size N0.
|
ConstrainedInternalNode |
|
ConstrainedLeafNode |
|
ConstrainedNode |
|
ConstrainedNode.HeightAdjustment |
|
ConstraintModel |
|
ConstraintModel.GroupManager |
|
ContigencyTable |
Class for permuting contigency tables and determining the likelihood of the table.
|
CPREV |
CPREV model of amino acid evolution (J.Adachi et al.
|
DataTranslator |
|
DataType |
interface for sequence data types
History: 21 March 2003, Added gap stuff, to counter frustration and not being
able to differentiat unknowns from gaps.
|
DataType.Utils |
Some useful methods for implmenting classes and for DataType users
|
DataTypeTool |
Simple access for data type functions.
|
Dayhoff |
Dayhoff model for amino acid evolution
Dayhoff, M.O., Schwartz, R.M., Orcutt, B.C.
|
DefaultCache |
|
DeltaModel |
|
DeltaModel.Instance |
|
DeltaModel.Utils |
|
DemographicClockTree |
Provides parameter interface to a clock-like genealogy which is
assumed to have some demographic pattern of theta (diversity) as
well as branch parameters (the minimal node height differences
at each internal node).
|
DemographicLikelihoodValue |
Estimates the likelihood for a tree using a specified
model of sequence evolution and a sequence alignment and
a specific demographic model as a prior on coalescent intervals.
|
DemographicModel |
This abstract class contains methods that are of general use for
modelling coalescent intervals given a demographic model.
|
DemographicTree |
interface defining a parameterized tree that
includes demographic information.
|
DemographicValue |
estimates demographic parameters by maximising the coalescent
prior for a tree with given branch lengths.
|
DifferentialEvolution |
global minimization of a real-valued function of several
variables without using derivatives using a genetic algorithm
(Differential Evolution)
|
DiscreteStatistics |
simple discrete statistics (mean, variance, cumulative probability, quantiles etc.)
|
DistanceMatrix |
storage for pairwise distance matrices.
|
DistanceMatrixAccess |
|
DistanceMatrixAccess.Utils |
|
DistanceMatrixGenerator |
|
DistanceMatrixGenerator.Utils |
|
DistanceMatrixUtils |
Auxillary functions for distance matrices
|
DistanceParseException |
exception thrown by ReadDistanceMatrix
|
DistanceTool |
|
DoubleKey |
|
DoubleKeyCache |
|
ElementFactory |
This class provides static methods for creating DOM Elements from PAL Objects.
|
ElementParser |
This class provides static methods for parsing PAL objects
from DOM Elements.
|
ErrorFunction |
error function and related stuff
|
EvaluationCounter |
A utiltity class that can be used to track the number of evaluations of a
general function
|
ExpandingPopulation |
This class models a population that grows
exponentially from an inital population size alpha N0 to a present-day size N0.
|
ExponentialDistribution |
exponential distribution.
|
ExponentialGrowth |
This class models an exponentially growing (or shrinking) population
(Parameters: N0=present-day population size; r=growth rate).
|
ExternalParameterListener |
Defines objects that listen to exteneral ParameterEvents
|
F81 |
Felsenstein 1981 model of nucleotide evolution
|
F84 |
Felsenstein 1984 (PHYLIP) model of nucleotide evolution
|
FastFourStateLHCalculator |
|
FastLikelihoodCalculator |
Title: Fast Likelihood Calculator
Description: A fast likelihood calculator
Original code by Matthew Goode.
|
FisherExact |
This does a one tail fisher exact test.
|
FixedBSRDTGlobalClockModel |
|
FixedSRDTGlobalClockModel |
|
FormattedInput |
tools to simplify formatted input from an input stream
|
FormattedOutput |
tools to simplify formatted output to a stream
|
FreeBranch |
|
FreeInternalNode |
|
FreeLeafNode |
|
FreeNode |
|
GammaDistribution |
gamma distribution.
|
GammaFunction |
gamma function
|
GammaRates |
discrete Gamma distribution (Z.
|
GapBalanced |
implements a ResidueDataType for GapBalanced notation.
|
GapBalancedAlignment |
Creates a "Gap-Balanced" alignment.
|
GeneralConstraintGroupManager |
|
GeneralConstraintGroupManager.LikelihoodScoreAccess |
|
GeneralConstraintGroupManager.Store |
|
GeneralConstructionTool |
|
GeneralizedDEOptimizer |
Provides an general interface to the DifferentialEvolution class that is not
tied to a certain number of parameters (as DifferentialEvolution is).
|
GeneralLikelihoodCalculator |
Title: General Likelihood Calculator
Description: A General likelihood calculator
This calculates the likelihood of an topologically invariant tree
(on an unchanging alignment) quickly by remembering partial likelihoods of invariant subtrees, and
by essentially generating site patterns for each sub tree.
|
GeneralLikelihoodSearcher |
|
GeneralObjectState |
Title:
|
GeneralOptimisable |
|
GeneralPoissonRateMatrix |
A general rate matrix class for JC69/F81 style rate matrices (but for all data types)
|
GeneralRateDistributionSubstitutionModel |
|
GeneralREVRateMatrix |
A general rate matrix class for REV style rate matrices (GTR but for all data types)
Includes the ability for arbitarily constraints
|
GeneralTopologyPool |
|
GeneralTreeComponent |
|
Genotype |
This class provides from genotype to be constructed from separate but paired
alignments.
|
GlobalClockModel |
|
GroupLeader |
Title: GroupLeader
|
GTR |
GTR (general time reversible) model of nucleotide evolution
Lanave, C., G.
|
HeapSort |
sorts numbers and comparable objects by treating contents of array as a binary tree.
|
HeightInformationUser |
Title: HeightInformationUser
|
HKY |
Hasegawa-Kishino-Yano model of nucleotide evolution
Hasegawa, M., H.
|
Identifier |
An identifier for some sampled data.
|
IdGenerator |
Generates IdGroup objects given certain parameters.
|
IdGroup |
An indexed group of identifiers.
|
IdGroup.Utils |
|
IndelAlignment |
This class extracts indels (insertion/deletion) out of an alignment, and creates
an alignment of indel polymorphisms.
|
IndelAnnotatedAlignment |
an extension of the IndelAlignment that includes annotation.
|
IndividualParameterHandler |
Title:
|
IndividualParameterHandler.Listener |
|
IndividualParameterHandler.Utils |
|
InputSource |
convenience class to open input streams
linked to files, stdin, and strings
|
IntervalsExtractor |
A series of coalescent intervals representing the time
order information contained in a (serial) clock-constrained
tree.
|
InvariableSites |
invariable sites model (two-rate model with mean rate = 1.0)
|
IUPACNucleotides |
implements DataType for nucleotides with ambiguous characters
|
IUPACPenaltyTable |
Implements a table of transition penalties for a DNA states
and IUPAC ambiguous states.
|
JTT |
JTT model of amino acid evolution
Jones, D.
|
JukesCantorDistanceMatrix |
compute jukes-cantor corrected distance matrix
|
JumbledAlignment |
generates jumbled alignments (randomizing input order of sequences)
|
KishinoHasegawaTest |
Kishino-Hasegawa-(Templeton)-Test (1989, 1983) to
compare a set of evolutionary hypotheses
|
LabelDisplayer |
A Label display object displays a label at a particular location on a graphics object.
|
LabelDisplayer.Utils |
|
LabelMapping |
|
LabelMapping.Relabeller |
|
LayoutTracker |
|
LHCalculator |
|
LHCalculator.AbstractExternal |
|
LHCalculator.External |
The External calculator does not maintain any state and is approapriate for
calculation where a store is provided
|
LHCalculator.Factory |
|
LHCalculator.Generator |
|
LHCalculator.Internal |
The Internal calculator may maintain state and is approapriate permanent attachment
to internal nodes of the tree structure
|
LHCalculator.Leaf |
A LHCalculator.Leaf object is attached to each leaf node and can be used to calculated conditional probabilities across the related branch.
|
LikelihoodCalculator |
classes that calculate likelihoods should implement this interface.
|
LikelihoodEvaluator |
|
LikelihoodEvaluator.MLResult |
|
LikelihoodEvaluator.SimpleMLResult |
|
LikelihoodEvaluator.Utils |
|
LikelihoodOptimiser |
|
LikelihoodRatioTest |
Likelihood ratio test based on chi-square statistics
|
LikelihoodSummary |
|
LikelihoodTool |
|
LikelihoodValue |
Computes the likelihood for a tree given a
model of sequence evolution and a sequence alignment;
also optimises tree parameters such as branch lengths
by maximising the likelihood (for optimal performance
special optimisation procedures are
employed for UnconstrainedTree, ClockTree and DatedTipsClockTree;
a general optimisation precedure is used for another
ParameterizedTree).
|
LineFunction |
converts a multivariate function into a univariate function
|
LinkageDisequilibrium |
This class calculates D' and r^2 estimates of linkage disequilibrium.
|
LinkageDisequilibriumComponent |
An AWT Component for displaying information on linkage disequilibrium.
|
LMSSolver |
Title: LMSSolver
|
LMSSolver.Utils |
Title: Utils
|
Local |
Implements LOCAL (Larget and Simon, 1999) and stochastic NNI moves for unrooted trees.
|
Log |
Log provides a mechanism for logging and debugging to the
standard output stream.
|
Logger |
Interface for all objects that provide a logging facility.
|
LogParameterizedTree |
This class logarithmically transforms tree parameters.
|
MachineAccuracy |
determines machine accuracy
|
Markable |
Title: Markable
|
MathUtils |
Handy utility functions which have some Mathematical relavance.
|
Matrix |
Title: Matrix
|
MatrixExponential |
compute matrix exponential and, subsequently, transition probabilities
for a given rate matrix
|
MersenneTwisterFast |
MersenneTwisterFast:
A simulation quality fast random number generator (MT19937)
with the same public methods as java.util.Random.
|
MFWithGradient |
interface for a function of several variables with a gradient
|
MinimiserMonitor |
interface for a classes that wish to monitor the progress of a Minimiser
|
MinimiserMonitor.Utils |
|
ModelParameters |
estimates substitution model parameters from the data
|
ModelSupport |
Computes Akaike weights and expected Akaike weights
(relative evidence, expected relative evidence)
for a set of models and computes corresponding confidence sets
|
MolecularClockLikelihoodModel |
|
MolecularClockLikelihoodModel.External |
The External calculator does not maintain any state and is approapriate for
calculation where a store is provided
|
MolecularClockLikelihoodModel.HeightConverter |
|
MolecularClockLikelihoodModel.Instance |
|
MolecularClockLikelihoodModel.Internal |
The Internal calculator may maintain state and is approapriate permanent attachment
to internal nodes of the tree structure
|
MolecularClockLikelihoodModel.Leaf |
A ConstrainedLHCalculator.Leaf object is attached to each leaf node and can be used to calculated conditional probabilities across the related branch.
|
MolecularClockLikelihoodModel.Simulator |
|
MolecularDataType |
An extension to the generic DataType class for DataTypes
related to genetic residues (by this it is meant Nucleotides,
AminoAcids, and Codons).
|
MolecularDataType.Utils |
Utilities relating to MolecularDataType stuff
|
MRDTGlobalClockModel |
|
MTREV24 |
MTREV24 model of amino acid evolution
|
MultiLocusAnnotatedAlignment |
MultiLocusAnnotatedAlignment is an extension of the SimpleAlignment that includes Annotation, and is designed for multiple
loci.
|
MultiParameterized |
Title: MultiParameterized
|
MultiParameterized.ParameterAccessWatcher |
An interface for classes that wish to find out about particular parameter access
|
MultiRateMatrixHandler |
|
MultivariateFunction |
interface for a function of several variables
|
MultivariateMinimum |
abstract base class for minimisation of a multivariate function
|
MultivariateMinimum.Factory |
A factory interface for MultivariateMinimums (because they aren't statefree)
|
MutableDouble |
|
MutationRateModel |
This abstract class contains methods that are of general use for
modelling mutation rate changes over time.
|
MutationRateModel.Factory |
An interface for objects which generate fresh MutationRAteModels
|
MutationRateModelTree |
Provides parameter interface to any clock-like tree with
serially sampled tips (parameters are the minimal node height differences
at each internal node).
|
Nameable |
interface for classes that can be named.
|
NameColouriser |
|
NamedParameterized |
interface for class with (optimizable) named parameters
|
NeighborJoiningTree |
constructs a neighbor-joining tree from pairwise distances
Saitou, N., and Nei, M., (1987) The neighbor-joining method: A new method for reconstructing phylogenetic trees.
|
NeoParameterized |
interface for class with (optimizable) parameters.
|
NeoRateMatrix |
The new RateMatrix class.
|
NeutralSelectionRateMatrixGroup |
|
NexusParseException |
Exception class for the NexusParser.
|
NexusTokenizer |
Comments
|
Node |
interface for a node (includes branch) in a binary/non-binary
rooted/unrooted tree
|
NodeAccess |
|
NodeFactory |
|
NodeUtils |
Helper routines for dealing with nodes.
|
NormalDistribution |
normal distribution (pdf, cdf, quantile)
|
NucleotideModel |
base class for nucleotide rate matrices
|
NucleotideModelID |
interface for IDs of nucleotide models
|
Nucleotides |
implements DataType for nucleotides
|
NumericalDerivative |
approximates numerically the first and second derivatives of a
function of a single variable and approximates gradient and
diagonal of Hessian for multivariate functions
|
NumericDataType |
This datatype stores numeric values.
|
ObjectState |
Title: Object State
|
OrderEnumerator |
A means for describing odering information, and Utilities for creating such Orderings
|
OrderEnumerator.OEFactory |
|
OrderEnumerator.Utils |
|
OrthogonalHints |
Provides a means for giving an Orthogonal base optimiser (IE, OrthognalMinimum)
hints about the function that may alow it to optimise better.
|
OrthogonalHints.Utils |
|
OrthogonalLineFunction |
converts a multivariate function into a univariate function
by keeping all but one argument constant
|
OrthogonalSearch |
minimization of a real-valued function of
several variables without using derivatives, using the simple
strategy of optimizing variables one by one.
|
OrthogonalSearch.RoundOptimiser |
|
OutputTarget |
convenience class to create output streams linked to
files, stdout, and strings
|
Painter |
An interface for objects which are used for painting themselves in a
general Graphics object
|
PairwiseDistance |
determines the (observed and ML) distance between a pair of sequences
|
PalEventMulticaster |
A utility class for accomodating Pal listeners
|
PalObjectEvent |
An event used by PalObjectListeners
|
PalObjectListener |
Defines objects that monitor certain PalObjects for changes
|
PalObjectListener.EventGenerator |
A base class for classes that fire PalObject events
|
ParameterEvent |
An event used by ExternalParameterListeners
|
Parameterized |
interface for class with (optimizable) parameters
|
Parameterized.Null |
NullParameterized Object
Can be used by subclasses to implement parameterized without actually having paramters
|
Parameterized.ParameterizedBase |
A Utility class for using as the superclass to subclasses which are based on double arrays
|
Parameterized.ParameterizedUser |
A Utility class for using as the superclass to subclasses which work by adding functionality to
a general Parameterized object (the base Parameterized object)
|
Parameterized.Utils |
|
ParameterizedDoubleBundle |
Title: ParameterizedDoubleBundle
|
ParameterizedNeoWrapper |
Title: ParameterizedNeoWrapper
|
ParameterizedTree |
abstract base class for a tree with an Parameterized interface
|
ParameterizedTree.Factory |
Factory interface
|
ParameterizedTree.ParameterizedTreeBase |
For parameterisations that work by adjusting a base tree (that is, they aren't really
tree's themselves...)
|
ParentableConstrainedNode |
|
ParetoDistribution |
Pareto distribution
(scale-free distribution without characteristic length scale).
|
PatternInfo |
Title: PatternInfo
|
PenalizedLikelihood |
Penalized likelihood criteria
|
PivotNode |
|
PositionedNode |
A tree node that has a scalar position for the purposes of drawing the tree.
|
PositiveSelectionRateMatrixGroup |
|
ProbabilityIterator |
A function for obtaining probabilities (that may change over time)
|
ProbabilityIterator.Factory |
|
ProbabilityIterator.Utils |
|
Ranker |
Title: Ranker
Description: Maintains a list of ranked objects
|
RateDistribution |
abstract base class for models of rate variation over sites
employing a discrete rate distribution
|
RateHandler |
|
RateHandler.Utils |
|
RateMatrix |
abstract base class for all rate matrices
|
RateMatrixGroup |
|
RateMatrixHandler |
|
RateMatrixUtils |
|
ReadAlignment |
reads aligned sequence data from plain text files.
|
ReadAlignmentOld |
reads aligned sequence data from plain text files.
|
ReadDistanceMatrix |
reads pairwise distance matrices in PHYLIP format
(full matrix)
|
ReadTree |
constructs a tree reading in a New Hampshire treefile, taking care
for internal labels and branch lengths and binary/nonbinary and
rooted/unrooted trees
|
ReleaseInfo |
release information
|
RELLTopologyPool |
|
ReplicateLikelihoodEvaluator |
|
ReplicateLikelihoodEvaluator.Utils |
|
Report |
interface for classes that can print out a human readable report of itself
|
RootAccess |
|
RootedTreeInterface |
Title: RootedTreeInterface
|
RootedTreeInterface.Instructee |
|
RootedTreeInterface.RBranch |
|
RootedTreeInterface.RNode |
|
RootedTreeInterface.Utils |
|
RootedTreeUtils |
This class contains utility methods.
|
SampleInformation |
Title: SampleInformation
|
SampleInformation.Factory |
|
SaturatedSingleSplitDistribution |
Title: SaturatedSingleSplitDistribution
|
SearchEngine |
A simplistic class (most of the work is done elsewhere) that handles basic search algorithms
|
SearcherUtils |
|
SearchMonitor |
Title: SearchMonitor
|
SearchMonitor.Utils |
|
SequencePairLikelihood |
computation of the (negative) log-likelihood for a pair of sequences
|
SequenceSimulator |
|
SerialCoalescentGenerator |
|
SerialCoalescentGenerator.Results |
A simple wrapper class for containing the results which may either be
a number of trees, or a number of trees and alignments (in parallel arrays)
|
SerialCoalescentSimulator |
Simulates a set of coalescent intervals given a demographic model.
|
ShimodairaHasegawaStatistics |
Title: ShimodairaHasegawaStatistics
|
ShimodairaHasegawaTest |
Shimodaira-Hasegawa-Test (1999) to
compare a set of evolutionary hypotheses
|
SimpleAlignment |
An alignment class that can be efficiently constructed
from an array of strings.
|
SimpleAnnotatedAlignment |
This is the basic implementation of the Annotation interface, which is designed to
provide annotation for an alignment.
|
SimpleCharacterAlignment |
This provides a basic implementation of CharacterAlignment.
|
SimpleDataType |
interface for sequence data types
|
SimpleIdGroup |
Default implementation of IdGroup interface.
|
SimpleLeafCalculator |
|
SimpleLHCalculator |
|
SimpleLikelihoodCalculator |
|
SimpleModelFastFourStateLHCalculator |
|
SimpleMolecularClockLikelihoodModel |
|
SimpleNode |
data structure for a node (includes branch) in a binary/non-binary
rooted/unrooted tree
|
SimpleRateMatrixGroup |
|
SimpleSummarizable |
|
SimpleTree |
data structure for a binary/non-binary rooted/unrooted trees
|
SimpleUnconstrainedLikelihoodModel |
|
SimpleUnconstrainedLikelihoodModel.InternalImpl |
|
SimpleUnconstrainedLikelihoodModel.LeafImpl |
|
SimulatedAlignment |
generates an artificial data set
|
SimulatedAlignment.Factory |
A utility class that can be used to generate Simulated alignments based on
a tree with predefined sequence length and substitution model
|
SingleClassSubstitutionModel |
|
SingleSplitDistribution |
|
SingleSplitMolecularClockLikelihoodModel |
|
SiteDetails |
|
SiteDetails.Utils |
|
SitePattern |
takes an Alignment and determines its site patterns
|
SkylinePlot |
Skyline plot derived from a strictly bifurcating tree
or a coalescent interval.
|
SpecificAminoAcids |
implements a MolecularDataType for amino acids, where we specifiy the Codon Table basis of amino acid by
supplying the CodonTable which is/was used for converting Nucleotide sequences to Amino Acids.
|
SplitSystem |
data structure for a set of splits
|
SplitUtils |
utilities for split systems
|
SRDTGlobalClockModel |
|
StateProvider |
Title:
|
StateRemover |
A standard data type, but with characters removed
|
SteppedMutationRate |
This class models a step-wise mutation rate.
|
StoppingCriteria |
|
StoppingCriteria.Factory |
|
StoppingCriteria.Utils |
|
StrippedAlignment |
takes an alignment and repeatedly removes sites
|
StrippedAnnotatedAlignment |
This is the stripped implementation of the Annotation interface, which is designed to
provide stripped and annotated alignments.
|
SubstitutionModel |
model of sequence substitution (rate matrix + rate variation).
|
SubstitutionModel.Utils |
A small Utility class for things relating to Substitution Models in general
|
SubstitutionTool |
|
Summarizable |
interface for classes that can provide summaries
|
SUPGMABase |
|
SUPGMABase.CISummary |
|
SUPGMABase.PopulationParameters |
|
SUPGMADistanceMatrix |
Corrects distances in a distance matrix such that all tips appear
contemporaneous, given a time/date and rate information for the
taxa.
|
SUPGMATree |
constructs an SUPGMA tree from pairwise distances.
|
TableReport |
interface for classes with data that can be presented in tables
|
TemporalModelChange |
|
TemporalModelChange.Utils |
|
ThetaHandler |
|
ThetaHandler.Utils |
|
ThreeNumberSort |
sorts three numbers (doubles) and choose randomly among the
minimum/maximum values
|
TimeOrderCharacterData |
Character data that expresses an order through time.
|
TimeStamp |
keeps track of program runtime
|
TN |
Tamura-Nei model of nucleotide evolution
Tamura, K.
|
TOCDSampleInformation |
Title: TOCDSampleInformation
|
TopologyTestEngine |
|
TopologyTestEngine.StatisticsHandler |
|
TopologyTestEngine.TestResult |
|
TopologyTestEngine.TopologyPool |
|
TransitionPenaltyTable |
Implements a table of transition penalties for a particular datatype.
|
TransitionProbability |
For objects that represent a source of transition probabilities
TransitionProbability.java,v 1.3 2000/08/08 22:58:29 alexi Exp $
|
Tree |
Interface for a phylogenetic or genealogical tree.
|
Tree.TreeBase |
|
TreeComponent |
An AWT Component for displaying a tree.
|
TreeDistanceMatrix |
computes distance matrix induced by a tree
(needs only O(n^2) time, following algorithm DistanceInTree by
D.Bryant and P.
|
TreeGenerator |
|
TreeGenerator.Utils |
|
TreeIterator |
|
TreeManipulator |
|
TreeManipulator.BranchAccess |
The branch access objects allow specific operations on a particular branch (refered to as connections
internally to confuse and bewilder)
|
TreeManipulator.PALBranchWrapper |
|
TreeManipulator.PALNodeWrapper |
|
TreeOperation |
Title: TreeOperation
|
TreeOperation.Utils |
Utility class
|
TreePainter |
A class that can paint a tree into a Graphics object.
|
TreePainterCircular |
A class that can paint a tree (in a circular fashion) into a Graphics object .
|
TreePainterNormal |
A class that can paint a tree into a Graphics object.
|
TreeParseException |
exception thrown by ReadTree
|
TreeRestricter |
|
TreeSearchTool |
Title: TreeSearchTool
|
TreeTool |
|
TreeUtils |
various utility functions on trees.
|
TwoStateModel |
implements the most general reversible rate matrix for two-state data
|
TwoStates |
implements DataType for two-state data
|
UnconstrainedLikelihoodModel |
|
UnconstrainedLikelihoodModel.External |
The External calculator does not maintain any state and is approapriate for
calculation where a store is provided
|
UnconstrainedLikelihoodModel.Instance |
|
UnconstrainedLikelihoodModel.Internal |
The Internal calculator may maintain state and is approapriate permanent attachment
to internal nodes of the tree structure
|
UnconstrainedLikelihoodModel.Leaf |
A LHCalculator.Leaf object is attached to each leaf node and can be used to calculated conditional probabilities across the related branch.
|
UnconstrainedModel |
|
UnconstrainedTree |
provides parameter interface to an unconstrained tree
(parameters are all available branch lengths)
|
UndoableAction |
|
UndoableAction.Utils |
|
UniformRate |
uniform rate distribution
|
Units |
interface holding unit constants
|
UnitsProvider |
interface for classes that can provide the related Units used, (as
|
UnivariateFunction |
interface for a function of one variable
|
UnivariateMinimum |
minimization of a real-valued function of one variable
without using derivatives.
|
UnrootedMLSearcher |
|
UnrootedMLSearcher.StateObject |
|
UnrootedTreeInterface |
Title: UnrootedTreeInterface
|
UnrootedTreeInterface.BaseBranch |
|
UnrootedTreeInterface.GeneralBranch |
|
UnrootedTreeInterface.Instructee |
|
UnrootedTreeInterface.UBranch |
|
UnrootedTreeInterface.UNode |
|
UnrootedTreeInterface.Utils |
|
UPGMATree |
Deprecated.
|
UrnModel |
class for drawing numbers from an urn with and
without laying back
|
Utils |
Provides some miscellaneous methods.
|
VariableIndependentSingleSplitDistribution |
Title: VariableIndependentSingleSplitDistribution
|
Version |
This class provides a mechanism for returning the version number of the
pal library.
|
VT |
VT (variable time matrix) model of amino acid evolution
Modeling Amino Acid Replacement Mueller, T.
|
WAG |
WAG model of amino acid evolution (S.
|
WindowedMutationRate |
This class models a windowed mutation rate
(parameter: mu = mutation rate).
|
XMLConstants |
constants (strings and numbers) relating to reading and writing XML.
|
XmlParseException |
exception thrown by ElementParser.
|
YangCodonModel |
Yang's model of codon evolution
More advanced codon Substitution Models (of Neilson and Yang) are now included (the M1, and M2 models).
|
YangCodonModel.SimpleNeutralSelection |
A Substitution Model which can be used to implment the Neutral Model (with out continuous rate stuff)
Codon model of [1] which uses the weighted sum of trwo base YangCodon models where
omega=0, omega=1 repectively
[1] Nielsen, R., Yang Z., 1998 Likelihood Models for Detecting Positively Selected Amino Acid Sites and
Applications to the HIV-1 Envelope Gene.
|
YangCodonModel.SimplePositiveSelection |
A Substitution Model which can be used to implment the Postitive Selection (with out continuous rate stuff)
Codon model of [1] which uses the weighted sum of a three base Codon model where
omega=0, omega=1 and omega=free
[1] Nielsen, R., Yang Z., 1998 Likelihood Models for Detecting Positively Selected Amino Acid Sites and
Applications to the HIV-1 Envelope Gene.
|
YangCodonModel.Utils |
A Utility class
|