mixed.solve(rrBLUP)
mixed.solve()所属R语言包:rrBLUP
Mixed-model solver
混合模型求解
译者:生物统计家园网 机器人LoveR
描述----------Description----------
Calculates maximum-likelihood (ML/REML) solutions for mixed models of the form
计算最大似然(ML / REML)解决方案的混合模型的形式
where β is a vector of fixed effects and u is a vector of random effects with Var[u] = K σ^2_u. The residual variance is Var[\varepsilon] = I σ^2_e. This class of mixed models, in which there is a single variance component other than the residual error, has a close relationship with ridge regression (ridge parameter λ = σ_e^2 / σ^2_u).
其中β是一个向量,固定效应和u是一个向量,随机效应的Var[u] = K σ^2_u。的残余的方差是Var[\varepsilon] = I σ^2_e。这一类的混合模型,其中有一个单以外的残余误差的方差分量,岭回归(岭参数λ = σ_e^2 / σ^2_u)有着密切的关系。
用法----------Usage----------
mixed.solve(y, Z=NULL, K=NULL, X=NULL, method="REML",
bounds=c(1e-09, 1e+09), SE=FALSE, return.Hinv=FALSE)
参数----------Arguments----------
参数:y
Vector (n \times 1) of observations. Missing values (NA) are omitted, along with the corresponding rows of X and Z.
观测向量(n \times 1)。缺失值(NA)被省略,以及与X和Z的相应行
参数:Z
Design matrix (n \times m) for the random effects. If not passed, assumed to be the identity matrix.
设计矩阵(n \times m)的随机效应。如果不通过,假设是单位矩阵。
参数:K
Covariance matrix (m \times m) for random effects; must be positive semi-definite. If not passed, assumed to be the identity matrix.
协方差矩阵(m \times m)随机效应,必须是半正定。如果不通过,假设是单位矩阵。
参数:X
Design matrix (n \times p) for the fixed effects. If not passed, a vector of 1's is used to model the intercept.
设计矩阵(n \times p)的固定效果。如果不通过,一个向量的1的用于建模的截距。
参数:method
Specifies whether the full ("ML") or restricted ("REML") maximum-likelihood method is used.
使用指定是否已满(“ML”)或限制(REML“)最大似然法。
参数:bounds
Array with two elements specifying the lower and upper bound for the ridge parameter.
有两个元素的指定上限和下限的脊参数的数组。
参数:SE
If TRUE, standard errors are calculated.
如果是TRUE,标准差的计算方法。
参数:return.Hinv
If TRUE, the function returns the inverse of H = Z K Z' + λ I. This is useful for GWA.
如果是TRUE,该函数返回的逆H = Z K Z' + λ I。这是有用的GWA。
Details
详细信息----------Details----------
This function can be used to predict marker effects or breeding values (see examples). The numerical method is based on the spectral decomposition of Z K Z' and S Z K Z' S, where S = I - X (X' X)^{-1} X' is the projection operator for the nullspace of X (Kang et al., 2008). For marker effects where K = I, the function will run faster if K is not passed than if the user passes the identity matrix.
这个功能可以被用来预测标记效应或育种值(参见示例)。数值计算方法,根据谱分解Z K Z'和S Z K Z' S,其中S = I - X (X' X)^{-1} X'是投影算子的零空间X(康等,2008)。标记效果,K = I,则该函数将运行得更快,如果k不是通过比,如果用户通过了身份矩阵。
值----------Value----------
If SE=FALSE, the function returns a list containing
如果SE = FALSE,函数返回一个列表,其中包含
$Vu estimator for σ^2_u
武估计为σ^2_u
$Ve estimator for σ^2_e
VE估计为σ^2_e
$beta estimator for β
测试估计为β
$u BLUP(u)
$ U BLUP(u)
$LL maximized log-likelihood (full or restricted, depending on method)
LL最大化对数似然(全部或受限制的,根据方法)
If SE=TRUE, the list also contains
如果SE = TRUE,该列表还包含
$beta.SE standard error for β
beta.SE标准错误β
$u.SE standard error for BLUP(u) - u
u.SE标准错误BLUP(u)- u
If return.Hinv=TRUE, the list also contains
如果return.Hinv = TRUE,该列表还包含
$Hinv the inverse of H
$ Hinv的逆H
参考文献----------References----------
Genetics 178:1709-1723.
实例----------Examples----------
#random population of 200 lines with 1000 markers[随机人口200线1000标记]
G <- matrix(rep(0,200*1000),200,1000)
for (i in 1:200) {
G[i,] <- ifelse(runif(1000)<0.5,-1,1)
}
#random phenotypes[随机表型]
u <- rnorm(1000)
g <- as.vector(crossprod(t(G),u))
h2 <- 0.5 #heritability[遗传]
y <- g + rnorm(200,mean=0,sd=sqrt((1-h2)/h2*var(g)))
#predict marker effects[预测标记效应]
ans <- mixed.solve(y,Z=G) #By default K = I[默认情况下,K = I]
accuracy <- cor(u,ans$u)
#predict breeding values[预测育种值]
ans <- mixed.solve(y,K=A.mat(G))
accuracy <- cor(g,ans$u)
转载请注明:出自 生物统计家园网(http://www.biostatistic.net)。
注:
注1:为了方便大家学习,本文档为生物统计家园网机器人LoveR翻译而成,仅供个人R语言学习参考使用,生物统计家园保留版权。
注2:由于是机器人自动翻译,难免有不准确之处,使用时仔细对照中、英文内容进行反复理解,可以帮助R语言的学习。
注3:如遇到不准确之处,请在本贴的后面进行回帖,我们会逐渐进行修订。
|