X-Git-Url: https://git.donarmstrong.com/?a=blobdiff_plain;f=R%2Face.R;h=c9a45110ca7eb926c0ca406494b30cf9cb9e9553;hb=24fc6c03893f85a3f9ab3d088201b3731f3035b4;hp=3e5d16ff5e036614d7a3cf4321f70f9306e17351;hpb=c827059eeafc8cbe41c812b26979543ab287803e;p=ape.git diff --git a/R/ace.R b/R/ace.R index 3e5d16f..c9a4511 100644 --- a/R/ace.R +++ b/R/ace.R @@ -1,8 +1,8 @@ -## ace.R (2007-12-14) +## ace.R (2009-11-12) -## Ancestral Character Estimation +## Ancestral Character Estimation -## Copyright 2005-2007 Emmanuel Paradis and Ben Bolker +## Copyright 2005-2009 Emmanuel Paradis and Ben Bolker ## This file is part of the R-package `ape'. ## See the file ../COPYING for licensing issues. @@ -11,7 +11,7 @@ ace <- function(x, phy, type = "continuous", method = "ML", CI = TRUE, model = if (type == "continuous") "BM" else "ER", scaled = TRUE, kappa = 1, corStruct = NULL, ip = 0.1) { - if (class(phy) != "phylo") + if (!inherits(phy, "phylo")) stop('object "phy" is not of class "phylo".') if (is.null(phy$edge.length)) stop("tree has no branch lengths") @@ -59,6 +59,7 @@ did not match: the former were ignored in the analysis.') if (model == "BM") { tip <- phy$edge[, 2] <= nb.tip dev.BM <- function(p) { + if (p[1] < 0) return(1e100) # in case sigma² is negative x1 <- p[-1][phy$edge[, 1] - nb.tip] x2 <- numeric(length(x1)) x2[tip] <- x[phy$edge[tip, 2]] @@ -102,7 +103,10 @@ did not match: the former were ignored in the analysis.') V <- corMatrix(Initialize(corStruct, data.frame(x)), corr = FALSE) invV <- solve(V) - obj$ace <- varAY %*% invV %*% x + o <- gls(x ~ 1, data.frame(x), correlation = corStruct) + GM <- o$coefficients + obj$ace <- drop(varAY %*% invV %*% (x - GM) + GM) + names(obj$ace) <- (nb.tip + 1):(nb.tip + nb.node) if (CI) { CI95 <- matrix(NA, nb.node, 2) se <- sqrt((varA - varAY %*% invV %*% t(varAY))[cbind(1:nb.node, 1:nb.node)]) @@ -127,9 +131,10 @@ did not match: the former were ignored in the analysis.') } if (model == "SYM") { np <- nl * (nl - 1)/2 - rate[col(rate) < row(rate)] <- 1:np + sel <- col(rate) < row(rate) + rate[sel] <- 1:np rate <- t(rate) - rate[col(rate) < row(rate)] <- 1:np + rate[sel] <- 1:np } } else { if (ncol(model) != nrow(model)) @@ -141,15 +146,19 @@ as the number of categories in `x'") np <- max(rate) } index.matrix <- rate - index.matrix[cbind(1:nl, 1:nl)] <- NA - rate[cbind(1:nl, 1:nl)] <- 0 - rate[rate == 0] <- np + 1 # to avoid 0's since we will use this an numeric indexing + tmp <- cbind(1:nl, 1:nl) + index.matrix[tmp] <- NA + rate[tmp] <- 0 + rate[rate == 0] <- np + 1 # to avoid 0's since we will use this as numeric indexing liks <- matrix(0, nb.tip + nb.node, nl) - for (i in 1:nb.tip) liks[i, x[i]] <- 1 + TIPS <- 1:nb.tip + liks[cbind(TIPS, x)] <- 1 phy <- reorder(phy, "pruningwise") Q <- matrix(0, nl, nl) + ## from Rich FitzJohn: + comp <- numeric(nb.tip + nb.node) # Storage... dev <- function(p, output.liks = FALSE) { Q[] <- c(p, 0)[rate] diag(Q) <- -rowSums(Q) @@ -158,28 +167,31 @@ as the number of categories in `x'") anc <- phy$edge[i, 1] des1 <- phy$edge[i, 2] des2 <- phy$edge[j, 2] - tmp <- eigen(Q * phy$edge.length[i], symmetric = FALSE) - P1 <- tmp$vectors %*% diag(exp(tmp$values)) %*% solve(tmp$vectors) - tmp <- eigen(Q * phy$edge.length[j], symmetric = FALSE) - P2 <- tmp$vectors %*% diag(exp(tmp$values)) %*% solve(tmp$vectors) - liks[anc, ] <- P1 %*% liks[des1, ] * P2 %*% liks[des2, ] + v.l <- matexpo(Q * phy$edge.length[i]) %*% liks[des1, ] + v.r <- matexpo(Q * phy$edge.length[j]) %*% liks[des2, ] + v <- v.l * v.r + comp[anc] <- sum(v) + liks[anc, ] <- v/comp[anc] } - if (output.liks) return(liks[-(1:nb.tip), ]) - - 2 * log(sum(liks[nb.tip + 1, ])) + if (output.liks) return(liks[-TIPS, ]) + -2 * sum(log(comp[-TIPS])) } - out <- nlm(function(p) dev(p), p = rep(ip, length.out = np), - hessian = TRUE) - obj$loglik <- -out$minimum / 2 - obj$rates <- out$estimate - if (any(out$gradient == 0)) + out <- nlminb(rep(ip, length.out = np), function(p) dev(p), + lower = rep(0, np), upper = rep(Inf, np)) + obj$loglik <- -out$objective/2 + obj$rates <- out$par + oldwarn <- options("warn") + options(warn = -1) + h <- nlm(function(p) dev(p), p = obj$rates, iterlim = 1, + stepmax = 0, hessian = TRUE)$hessian + options(oldwarn) + if (any(h == 0)) warning("The likelihood gradient seems flat in at least one dimension (gradient null):\ncannot compute the standard-errors of the transition rates.\n") - else obj$se <- sqrt(diag(solve(out$hessian))) + else obj$se <- sqrt(diag(solve(h))) obj$index.matrix <- index.matrix if (CI) { - lik.anc <- dev(obj$rates, TRUE) - lik.anc <- lik.anc / rowSums(lik.anc) - colnames(lik.anc) <- lvls - obj$lik.anc <- lik.anc + obj$lik.anc <- dev(obj$rates, TRUE) + colnames(obj$lik.anc) <- lvls } } obj$call <- match.call()