Type: | Package |
Title: | Linear Mixed Model Solver |
Description: | An efficient and flexible system to solve sparse mixed model equations. Important applications are the use of splines to model spatial or temporal trends as described in Boer (2023). (<doi:10.1177/1471082X231178591>). |
Version: | 1.0.10 |
Date: | 2025-05-14 |
License: | GPL-2 | GPL-3 [expanded from: GPL] |
Encoding: | UTF-8 |
LazyData: | true |
Depends: | R (≥ 3.6) |
Imports: | Matrix, methods, Rcpp (≥ 0.10.4), spam, splines |
LinkingTo: | Rcpp |
RoxygenNote: | 7.3.2 |
Suggests: | rmarkdown, knitr, tinytest, tidyr, agridat, ggplot2, maps, sf |
VignetteBuilder: | knitr |
URL: | https://biometris.github.io/LMMsolver/index.html, https://github.com/Biometris/LMMsolver/ |
BugReports: | https://github.com/Biometris/LMMsolver/issues |
NeedsCompilation: | yes |
Packaged: | 2025-05-14 10:05:01 UTC; rossu027 |
Author: | Martin Boer |
Maintainer: | Bart-Jan van Rossum <bart-jan.vanrossum@wur.nl> |
Repository: | CRAN |
Date/Publication: | 2025-05-14 10:40:02 UTC |
Package LMMsolver
Description
Linear Mixed Model Solver using sparse matrix algebra.
Details
An efficient and flexible system to solve sparse mixed model equations, for models that are often used in statistical genetics. Important applications are the use of splines to model spatial or temporal trends. Another application area is mixed model QTL analysis for multiparental populations, allowing for heterogeneous residual variance and random design matrices with Identity-By-Descent (IBD) probabilities.
Author(s)
Martin Boer martin.boer@wur.nl
Bart-Jan van Rossum bart-jan.vanrossum@wur.nl (maintainer)
References
Martin P. Boer (2023). Tensor product P-splines using a sparse mixed model formulation, Statistical Modelling, 23, p. 465 - 479. doi:10.1177/1471082X231178591
See Also
Useful links:
Report bugs at https://github.com/Biometris/LMMsolver/issues
construct object for Automated Differentiation Cholesky decomposition
Description
Construct object for reverse Automated Differentiation of Cholesky decomposition,
with as input a list of semi-positive symmetric sparse matrices P_i
, each of
dimension q \times q
. The function ADchol
calculates the matrix C
, the sum
the precision matrices P_i
: C = \sum_{i} P_i
. Next, it calculates the Cholesky
Decomposition using the multiple minimum degree (MMD) algorithm
of the spam
package.
Usage
ADchol(lP)
Arguments
lP |
a list of symmetric matrices of class spam, each of dimension |
Value
An object of class ADchol
. This object is used to calculate the partial
partial derivatives of log|C|
in an efficient way.
References
Furrer, R., & Sain, S. R. (2010). spam: A sparse matrix R package with emphasis on MCMC methods for Gaussian Markov random fields. Journal of Statistical Software, 36, 1-25.
Simulated Biomass as function of time using APSIM wheat.
Description
Simulated Biomass as function of time using APSIM wheat.
Usage
APSIMdat
Format
A data.frame with 121 rows and 4 columns.
- env
Environment, Emerald in 1993
- geno
Simulated genotype g001
- das
Days after sowing
- biomass
Simulated biomass using APSIM; medium measurement error added
References
Bustos-Korts et al. (2019) Combining Crop Growth Modeling and Statistical Genetic Modeling to Evaluate Phenotyping Strategies doi:10.3389/FPLS.2019.01491
Construct design matrix for B-Splines
Description
Construct design matrix for B-Splines.
Usage
Bsplines(knots, x, deriv = 0)
Arguments
knots |
A numerical vector of knot positions. |
x |
a numeric vector of values at which to evaluate the B-spline functions or derivatives. |
deriv |
A numerical value. The derivative of the given order is evaluated at the x positions. |
Solve Linear Mixed Models
Description
Solve Linear Mixed Models using REML.
Usage
LMMsolve(
fixed,
random = NULL,
spline = NULL,
group = NULL,
ginverse = NULL,
weights = NULL,
data,
residual = NULL,
family = gaussian(),
offset = 0,
tolerance = 1e-06,
trace = FALSE,
maxit = 250,
theta = NULL,
grpTheta = NULL
)
Arguments
fixed |
A formula for the fixed part of the model. Should be of the form "response ~ pred" |
random |
A formula for the random part of the model. Should be of the form "~ pred". |
spline |
A formula for the spline part of the model. Should be of the form "~ spl1D()", ~ spl2D()" or "~spl3D()". Generalized Additive Models (GAMs) can also be used, for example "~ spl1D() + spl2D()" |
group |
A named list where each component is a numeric vector specifying contiguous fields in data that are to be considered as a single term. |
ginverse |
A named list with each component a symmetric matrix, the precision matrix of a corresponding random term in the model. The row and column order of the precision matrices should match the order of the levels of the corresponding factor in the data. |
weights |
A character string identifying the column of data to use as relative weights in the fit. Default value NULL, weights are all equal to one. |
data |
A data.frame containing the modeling data. |
residual |
A formula for the residual part of the model. Should be of the form "~ pred". |
family |
An object of class |
offset |
An a priori known component to be included in the linear
predictor during fitting. |
tolerance |
A numerical value. The convergence tolerance for the modified Henderson algorithm to estimate the variance components. |
trace |
Should the progress of the algorithm be printed? Default
|
maxit |
A numerical value. The maximum number of iterations for the
algorithm. Default |
theta |
initial values for penalty or precision parameters. Default
|
grpTheta |
a vector to give components the same penalty. Default
|
Details
A Linear Mixed Model (LMM) has the form
y = X \beta + Z u + e, u \sim N(0,G), e \sim N(0,R)
where
y
is a vector of observations, \beta
is a vector with the fixed
effects, u
is a vector with the random effects, and e
a vector of
random residuals. X
and Z
are design matrices.
LMMsolve can fit models where the matrices G^{-1}
and R^{-1}
are
a linear combination of precision matrices Q_{G,i}
and Q_{R,i}
:
G^{-1} = \sum_{i} \psi_i Q_{G,i} \;, R^{-1} = \sum_{i} \phi_i Q_{R,i}
where the precision parameters \psi_i
and \phi_i
are estimated
using REML. For most standard mixed models 1/{\psi_i}
are the variance
components and 1/{\phi_i}
the residual variances. We use a formulation
in terms of precision parameters to allow for non-standard mixed models using
tensor product splines.
Value
An object of class LMMsolve
representing the fitted model.
See LMMsolveObject
for a full description of the components in
this object.
See Also
LMMsolveObject
, spl1D
,
spl2D
, spl3D
Examples
## Fit models on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Fit the same model with genotype as random effect.
LMM1_rand <- LMMsolve(fixed = yield ~ rep,
random = ~gen,
data = john.alpha)
## Fit the model with a 1-dimensional spline at the plot level.
LMM1_spline <- LMMsolve(fixed = yield ~ rep + gen,
spline = ~spl1D(x = plot, nseg = 20),
data = john.alpha)
## Fit models on multipop data included in the package.
data(multipop)
## The residual variances for the two populations can be different.
## Allow for heterogeneous residual variances using the residual argument.
LMM2 <- LMMsolve(fixed = pheno ~ cross,
residual = ~cross,
data = multipop)
## QTL-probabilities are defined by the columns pA, pB, pC.
## They can be included in the random part of the model by specifying the
## group argument and using grp() in the random part.
# Define groups by specifying columns in data corresponding to groups in a list.
# Name used in grp() should match names specified in list.
lGrp <- list(QTL = 3:5)
LMM2_group <- LMMsolve(fixed = pheno ~ cross,
group = lGrp,
random = ~grp(QTL),
residual = ~cross,
data = multipop)
Fitted LMMsolve Object
Description
An object of class LMMsolve
returned by the LMMsolve function,
representing a fitted linear mixed model. Objects of this class have
methods for the generic functions coef, fitted, residuals, loglik and
deviance.
Value
An object of class LMMsolve
contains the following components:
logL |
The restricted log-likelihood at convergence |
sigma2e |
The residual error |
tau2e |
The estimated variance components |
EDdf |
The effective dimensions |
varPar |
The number of variance parameters for each variance component |
VarDf |
The table with variance components |
theta |
The precision parameters |
coefMME |
A vector with all the estimated effects from mixed model equations |
ndxCoefficients |
The indices of the coefficients with the names |
yhat |
The fitted values |
residuals |
The residuals |
nIter |
The number of iterations for the mixed model to converge |
y |
Response variable |
X |
The design matrix for the fixed part of the mixed model |
Z |
The design matrix for the random part of the mixed model |
lGinv |
List with precision matrices for the random terms |
lRinv |
List with precision matrices for the residual |
C |
The mixed model coefficient matrix after last iteration |
cholC |
The cholesky decomposition of coefficient matrix C |
constantREML |
The REML constant |
dim |
The dimensions for each of the fixed and random terms in the mixed model |
term.labels.f |
The names of the fixed terms in the mixed model |
term.labels.r |
The names of the random terms in the mixed model |
respVar |
The name(s) of the response variable(s). |
splRes |
An object with definition of spline argument |
deviance |
The relative deviance |
family |
An object of class family specifying the distribution and link function |
trace |
A data.frame with the convergence sequence for the log likelihood and effective dimensions |
.
Construct equally placed knots
Description
Construct equally placed knots.
Usage
PsplinesKnots(xmin, xmax, degree, nseg, cyclic = FALSE)
Arguments
xmin |
A numerical value. |
xmax |
A numerical value. |
degree |
A numerical value. |
nseg |
A numerical value. |
cyclic |
A boolean, default false |
Value
A numerical vector of knot positions.
Row-wise kronecker product
Description
Row-wise kronecker product
Usage
RowKronecker(X1, X2)
Arguments
X1 |
A matrix. |
X2 |
A matrix. |
Value
The row-wise kronecker product of X1 and X2.
Sea Surface Temperature
Description
Sea Surface Temperature
Usage
SeaSurfaceTemp
Format
A data.frame with 15607 rows and 4 columns.
- lon
longitude
- lat
latitude
- sst
sea surface temperature in Kelvin
- type
defines training and test set
References
Cressie et al. (2022) Basis-function models in spatial statistics. Annual Review of Statistics and Its Application. doi:10.1146/annurev-statistics-040120-020733
Standard errors for predictions
Description
Calculates the standard errors for predictions D \hat{u}
,
see Welham et al. 2004 and Gilmour et al. 2004 for details.
Usage
calcStandardErrors(C, D)
Arguments
C |
a symmetric matrix of class spam |
D |
a matrix of class spam |
Details
The prediction error variance is given by D C^{-1} D'
,
where C
is the mixed model coefficient matrix, and D
defines
linear combinations of fixed and random effects.
The standard errors are given by the the square root of
the diagonal. To calculate the standard errors in an efficient way we use that
\frac{\partial log|C + \xi_i d_i d_i'|}{\partial \xi_i} |_{\xi_i=0}
= trace(C^{-1} d_i d_i') =
trace(d_i' C^{-1} d_i) = d_i' C^{-1} d_i,
where d_i
is row i
of matrix D
. The values of
d_i' C^{-1} d_i
can be calculated more efficient, avoiding the
calculation of the inverse of C
, by using Automated Differentiation
of the Choleksy algorithm, see section 2.3 in Smith (1995) for details.
Value
a vector with standard errors for predictions D \hat{u}
.
References
Welham, S., Cullis, B., Gogel, B., Gilmour, A., & Thompson, R. (2004). Prediction in linear mixed models. Australian & New Zealand Journal of Statistics, 46(3), 325-347.
Smith, S. P. (1995). Differentiation of the Cholesky algorithm. Journal of Computational and Graphical Statistics, 4(2), 134-147.
Gilmour, A., Cullis, B., Welham, S., Gogel, B., & Thompson, R. (2004). An efficient computing strategy for prediction in mixed linear models. Computational statistics & data analysis, 44(4), 571-586.
Coefficients from the mixed model equations of an LMMsolve object.
Description
Obtain the coefficients from the mixed model equations of an LMMsolve object.
Usage
## S3 method for class 'LMMsolve'
coef(object, se = FALSE, ...)
Arguments
object |
an object of class LMMsolve |
se |
calculate standard errors, default FALSE. |
... |
some methods for this generic require additional arguments. None are used in this method. |
Value
A list of vectors, containing the estimated effects for each fixed effect and the predictions for each random effect in the defined linear mixed model.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain coefficients.
coefs1 <- coef(LMM1)
## Obtain coefficients with standard errors.
coefs2 <- coef(LMM1, se = TRUE)
Helper function for constructing Rinv
Description
Helper function for constructing Rinv
Usage
constructRinv(df, residual, weights)
Deviance of an LMMsolve object
Description
Obtain the deviance of a model fitted using LMMsolve.
Usage
## S3 method for class 'LMMsolve'
deviance(object, relative = TRUE, includeConstant = TRUE, ...)
Arguments
object |
an object of class LMMsolve |
relative |
Deviance relative conditional or absolute unconditional
(-2*logLik(object))? Default |
includeConstant |
Should the constant in the restricted log-likelihood
be included. Default is |
... |
some methods for this generic require additional arguments. None are used in this method. |
Value
The deviance of the fitted model.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain deviance.
deviance(LMM1)
Give diagnostics for mixed model coefficient matrix C and the cholesky decomposition
Description
Give diagnostics for mixed model coefficient matrix C and the cholesky decomposition
Usage
diagnosticsMME(object)
Arguments
object |
an object of class LMMsolve. |
Value
A summary of the mixed model coefficient matrix and its choleski decomposition.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain deviance.
diagnosticsMME(LMM1)
Display the sparseness of the mixed model coefficient matrix
Description
Display the sparseness of the mixed model coefficient matrix
Usage
displayMME(object, cholesky = FALSE)
Arguments
object |
an object of class LMMsolve. |
cholesky |
Should the cholesky decomposition of the coefficient matrix be plotted? |
Value
A plot of the sparseness of the mixed model coefficient matrix.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain deviance.
displayMME(LMM1)
Fitted values of an LMMsolve object.
Description
Obtain the fitted values from a mixed model fitted using LMMSolve.
Usage
## S3 method for class 'LMMsolve'
fitted(object, ...)
Arguments
object |
an object of class LMMsolve |
... |
some methods for this generic require additional arguments. None are used in this method. |
Value
A vector of fitted values.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain fitted values.
fitted1 <- fitted(LMM1)
Log-likelihood of an LMMsolve object
Description
Obtain the Restricted Maximum Log-Likelihood of a model fitted using LMMsolve.
Usage
## S3 method for class 'LMMsolve'
logLik(object, includeConstant = TRUE, ...)
Arguments
object |
an object of class LMMsolve |
includeConstant |
Should the constant in the restricted log-likelihood
be included. Default is |
... |
some methods for this generic require additional arguments. None are used in this method. |
Value
The restricted maximum log-likelihood of the fitted model.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain log-likelihood.
logLik(LMM1)
## Obtain log-likelihood without constant.
logLik(LMM1, includeConstant = FALSE)
Family Object for Multinomial Model
Description
The Multinomial model is not part of the standard family. The implementation is based on Chapter 6 in Fahrmeir et al. (2013).
Usage
multinomial()
Value
An object of class familyLMMsolver
with the following components:
family |
character string with the family name. |
linkfun |
the link function. |
linkinv |
the inverse of the link function. |
dev.resids |
function giving the deviance for each observation as a function of (y, mu, wt) |
References
Fahrmeir, Ludwig, Thomas Kneib, Stefan Lang, Brian Marx, Regression models. Springer Berlin Heidelberg, 2013.
Simulated QTL mapping data set
Description
Simulated QTL mapping data set
Usage
multipop
Format
A data.frame with 180 rows and 6 columns.
- cross
Cross ID, two populations, AxB and AxC
- ind
Genotype ID
- pA
Probability that individual has alleles from parent A
- pB
Probability that individual has alleles from parent B
- pC
Probability that individual has alleles from parent C
- pheno
Simulated phenotypic value
Obtain Smooth Trend.
Description
Obtain the smooth trend for models fitted with a spline component.
Usage
obtainSmoothTrend(
object,
grid = NULL,
newdata = NULL,
deriv = 0,
includeIntercept = FALSE,
which = 1
)
Arguments
object |
An object of class LMMsolve. |
grid |
A numeric vector having the length of the dimension of the fitted spline component. This represents the number of grid points at which a surface will be computed. |
newdata |
A data.frame containing new points for which the smooth trend should be computed. Column names should include the names used when fitting the spline model. |
deriv |
Derivative of B-splines, default 0. At the moment only implemented for spl1D. |
includeIntercept |
Should the value of the intercept be included in the computed smooth trend? Ignored if deriv > 0. |
which |
An integer, for if there are multiple splxD terms in the model. Default value is 1. |
Value
A data.frame with predictions for the smooth trend on the specified grid. The standard errors are saved if 'deriv' has default value 0.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit a model with a 1-dimensional spline at the plot level.
LMM1_spline <- LMMsolve(fixed = yield ~ rep + gen,
spline = ~spl1D(x = plot, nseg = 20),
data = john.alpha)
## Obtain the smooth trend for the fitted model on a dense grid.
smooth1 <- obtainSmoothTrend(LMM1_spline,
grid = 100)
## Obtain the smooth trend on a new data set - plots 10 to 40.
newdat <- data.frame(plot = 10:40)
smooth2 <- obtainSmoothTrend(LMM1_spline,
newdata = newdat)
## The first derivative of the smooth trend can be obtained by setting deriv = 1.
smooth3 <- obtainSmoothTrend(LMM1_spline,
grid = 100,
deriv = 1)
## For examples of higher order splines see the vignette.
Predict function
Description
Predict function
Usage
## S3 method for class 'LMMsolve'
predict(object, newdata, type = c("response", "link"), se.fit = FALSE, ...)
Arguments
object |
an object of class LMMsolve. |
newdata |
A data.frame containing new points for which the smooth trend should be computed. Column names should include the names used when fitting the spline model. |
type |
When this has the value "link" the linear predictor fitted values or predictions (possibly with associated standard errors) are returned. When type = "response" (default) fitted values or predictions on the scale of the response are returned (possibly with associated standard errors). |
se.fit |
calculate standard errors, default |
... |
other arguments. Not yet implemented. |
Value
A data.frame with predictions for the smooth trend on the specified grid. The standard errors are saved if 'se.fit=TRUE'.
Examples
## simulate some data
f <- function(x) { 0.3 + 0.4*x + 0.2*sin(20*x) }
set.seed(12)
n <- 150
x <- seq(0, 1, length = n)
sigma2e <- 0.04
y <- f(x) + rnorm(n, sd = sqrt(sigma2e))
dat <- data.frame(x, y)
## fit the model
obj <- LMMsolve(fixed = y ~ 1,
spline = ~spl1D(x, nseg = 50), data = dat)
## make predictions on a grid
newdat <- data.frame(x = seq(0, 1, length = 300))
pred <- predict(obj, newdata = newdat, se.fit = TRUE)
head(pred)
Test function for predict, for the moment internal
Description
Test function for predict, for the moment internal
Usage
predictTest(object, classify)
Residuals of an LMMsolve object.
Description
Obtain the residuals from a mixed model fitted using LMMSolve.
Usage
## S3 method for class 'LMMsolve'
residuals(object, ...)
Arguments
object |
an object of class LMMsolve |
... |
some methods for this generic require additional arguments. None are used in this method. |
Value
A vector of residuals.
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain fitted values.
residuals1 <- residuals(LMM1)
Fit P-splines
Description
Fit multi dimensional P-splines using sparse implementation.
Usage
spl1D(
x,
nseg,
pord = 2,
degree = 3,
cyclic = FALSE,
scaleX = TRUE,
xlim = range(x),
cond = NULL,
level = NULL
)
spl2D(
x1,
x2,
nseg,
pord = 2,
degree = 3,
cyclic = c(FALSE, FALSE),
scaleX = TRUE,
x1lim = range(x1),
x2lim = range(x2),
cond = NULL,
level = NULL
)
spl3D(
x1,
x2,
x3,
nseg,
pord = 2,
degree = 3,
scaleX = TRUE,
x1lim = range(x1),
x2lim = range(x2),
x3lim = range(x3)
)
Arguments
x , x1 , x2 , x3 |
The variables in the data containing the values of
the |
nseg |
The number of segments |
pord |
The order of penalty, default |
degree |
The degree of B-spline basis, default |
cyclic |
Cyclic or linear B-splines; default |
scaleX |
Should the fixed effects be scaled. |
xlim , x1lim , x2lim , x3lim |
A numerical vector of length 2 containing the
domain of the corresponding x covariate where the knots should be placed.
Default set to |
cond |
Conditional factor: splines are defined conditional on the level.
Default |
level |
The level of the conditional factor. Default |
Value
A list with the following elements:
-
X
- design matrix for fixed effect. The intercept is not included. -
Z
- design matrix for random effect. -
lGinv
- a list of precision matrices -
knots
- a list of vectors with knot positions -
dim.f
- the dimensions of the fixed effect. -
dim.r
- the dimensions of the random effect. -
term.labels.f
- the labels for the fixed effect terms. -
term.labels.r
- the labels for the random effect terms. -
x
- a list of vectors for the spline variables. -
pord
- the order of the penalty. -
degree
- the degree of the B-spline basis. -
scaleX
- logical indicating if the fixed effects are scaled. -
EDnom
- the nominal effective dimensions.
Functions
-
spl2D()
: 2-dimensional splines -
spl3D()
: 3-dimensional splines
See Also
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit a model with a 1-dimensional spline at the plot level.
LMM1_spline <- LMMsolve(fixed = yield ~ rep + gen,
spline = ~spl1D(x = plot, nseg = 20),
data = john.alpha)
summary(LMM1_spline)
## Fit model on US precipitation data from spam package.
data(USprecip, package = "spam")
## Only use observed data
USprecip <- as.data.frame(USprecip)
USprecip <- USprecip[USprecip$infill == 1, ]
## Fit a model with a 2-dimensional P-spline.
LMM2_spline <- LMMsolve(fixed = anomaly ~ 1,
spline = ~spl2D(x1 = lon, x2 = lat, nseg = c(41, 41)),
data = USprecip)
summary(LMM2_spline)
Summarize Linear Mixed Model fits
Description
Summary method for class "LMMsolve". Creates either a table of effective dimensions (which = "dimensions") or a table of variances (which = "variances").
Usage
## S3 method for class 'LMMsolve'
summary(object, which = c("dimensions", "variances"), ...)
## S3 method for class 'summary.LMMsolve'
print(x, ...)
Arguments
object |
An object of class LMMsolve |
which |
A character string indicating which summary table should be created. |
... |
Some methods for this generic require additional arguments. None are used in this method. |
x |
An object of class summary.LMMsolve, the result of a call to summary.LMM |
Value
A data.frame with either effective dimensions or variances depending on which.
Methods (by generic)
-
print(summary.LMMsolve)
: print summary
Examples
## Fit model on john.alpha data from agridat package.
data(john.alpha, package = "agridat")
## Fit simple model with only fixed effects.
LMM1 <- LMMsolve(fixed = yield ~ rep + gen,
data = john.alpha)
## Obtain table of effective dimensions.
summ1 <- summary(LMM1)
print(summ1)
## Obtain table of variances.
summ2 <- summary(LMM1,
which = "variances")
print(summ2)