Learn R Programming

DDD (version 1.9)

dd_KI_ML: Maximization of the loglikelihood under a diversity-dependent diversification model with decoupling of a subclade's diversication dynamics from the main clade's dynamics

Description

This function computes the maximum likelihood estimates of the parameters of a diversity-dependent diversification model with decoupling of the diversification dynamics of a subclade from the dynamics of the main clade for a given set of phylogenetic branching times of main clade and subclade and the time of splitting of the lineage that will form the subclade. It also outputs the corresponding loglikelihood that can be used in model comparisons.

Usage

dd_KI_ML(brtsM, brtsS, tsplit, initparsopt = c(0.5, 0.1, 2 * (1 + length(brtsM) + 
    missnumspec[1]), 2 * (1 + length(brtsS) + missnumspec[length(missnumspec)]), 
    (tsplit + max(brtsS))/2), parsfix = NULL, idparsopt = c(1:3, 6:7), idparsfix = NULL,
    idparsnoshift = (1:7)[c(-idparsopt, (-1)^(length(idparsfix) != 0) * idparsfix)],
    res = 10 * (1 + length(c(brtsM, brtsS)) + sum(missnumspec)), ddmodel = 1, 
    missnumspec = 0, cond = TRUE, tol = c(1E-3,1E-4,1E-6), maxiter = 1000 * 
    round((1.25)^length(idparsopt)))

Arguments

brtsM
A set of branching times of the main clade in a phylogeny, all positive
brtsS
A set of branching times of the subclade in a phylogeny, all positive
tsplit
The branching time at which the lineage forming the subclade branches off, positive
initparsopt
The initial values of the parameters that must be optimized
parsfix
The values of the parameters that should not be optimized
idparsopt
The ids of the parameters that must be optimized, e.g. 1:7 for all parameters. The ids are defined as follows: id == 1 corresponds to lambda_M (speciation rate) of the main clade id == 2 corresponds to mu_M (extinction rate) of the main clade id ==
idparsfix
The ids of the parameters that should not be optimized, e.g. c(1,3,4,6) if lambda and K should not be optimized, but only mu. In that case idparsopt must be c(2,5,7). The default is to fix all parameters not specified in idparsopt.
idparsnoshift
The ids of the parameters that should not shift; This can only apply to ids 4, 5 and 6, e.g. idparsnoshift = c(4,5) means that lambda and mu have the same values before and after tshift
res
sets the maximum number of species for which a probability must be computed, must be larger than 1 + max(length(brtsM),length(brtsS))
ddmodel
sets the model of diversity-dependence: ddmodel == 1 : linear dependence in speciation rate ddmodel == 2 : exponential dependence in speciation rate ddmodel == 3 : linear dependence in extinction rate ddmodel == 4 : exponential dependence in extinctio
missnumspec
The number of species that are in the clade but missing in the phylogeny. One can specify the sum of the missing species in main clade and subclade or a vector c(missnumspec_M,missnumspec_S) with missing species in main clade and subclade respectively.
cond
Conditioning on non-extinction of the phylogeny (TRUE or FALSE)
tol
Sets the tolerances in the optimization. Consists of: reltolx = relative tolerance of parameter values in optimization reltolf = relative tolerance of function value in optimization abstolx = absolute tolerance of parameter values in optimization
maxiter
Sets the maximum number of iterations in the optimization

Value

  • lambda_Mgives the maximum likelihood estimate of lambda of the main clade
  • mu_Mgives the maximum likelihood estimate of mu of the main clade
  • K_Mgives the maximum likelihood estimate of K of the main clade
  • lambda_2gives the maximum likelihood estimate of lambda of the subclade
  • mu_Sgives the maximum likelihood estimate of mu of the subclade
  • K_Sgives the maximum likelihood estimate of K of the subclade
  • t_dgives the time of the decoupling event
  • loglikgives the maximum loglikelihood
  • dfgives the number of estimated parameters, i.e. degrees of feedom
  • convgives a message on convergence of optimization; conv = 0 means convergence

Details

The output is a dataframe containing estimated parameters and maximum loglikelihood. The computed loglikelihood contains the factor q! m!/(q + m)! where q is the number of species in the phylogeny and m is the number of missing species, as explained in the supplementary material to Etienne et al. 2012.

References

- Etienne et al. 2012, Proc. Roy. Soc. B 279: 1300-1309, doi: 10.1098/rspb.2011.1439 - Etienne & Haegeman 2012. Am. Nat. 180: E75-E89, doi: 10.1086/667574

See Also

dd_KI_loglik, dd_ML, dd_SR_ML,

Examples

Run this code
cat("Estimating parameters for two sets of branching times brtsM, brtsS with the default settings:")
brtsM = 1:20
brtsS = seq(0.1,3.9,0.5)
t_split = 5;
dd_KI_ML(brtsM,brtsS,tsplit)

Run the code above in your browser using DataLab