| Type: | Package | 
| Title: | Tests in Linear Mixed Effects Models | 
| Version: | 3.1-3 | 
| Depends: | R (≥ 3.2.5), lme4 (≥ 1.1-10), stats, methods | 
| Imports: | numDeriv, MASS, ggplot2 | 
| Suggests: | pbkrtest (≥ 0.4-3), tools | 
| Description: | Provides p-values in type I, II or III anova and summary tables for lmer model fits (cf. lme4) via Satterthwaite's degrees of freedom method. A Kenward-Roger method is also available via the pbkrtest package. Model selection methods include step, drop1 and anova-like tables for random effects (ranova). Methods for Least-Square means (LS-means) and tests of linear contrasts of fixed effects are also available. | 
| License: | GPL-2 | GPL-3 [expanded from: GPL (≥ 2)] | 
| Encoding: | UTF-8 | 
| LazyData: | true | 
| URL: | https://github.com/runehaubo/lmerTestR | 
| BugReports: | https://github.com/runehaubo/lmerTestR/issues | 
| RoxygenNote: | 7.1.1 | 
| Collate: | 'anova_contrasts.R' 'contest.R' 'contrast_utils.R' 'data_documentation.R' 'drop1.R' 'estimability.R' 'legacy.R' 'lmer.R' 'lmerTest.R' 'lmer_anova.R' 'lmer_summary.R' 'ls_means.R' 'ranova.R' 'step.R' 'terms_utils.R' 'utils.R' | 
| NeedsCompilation: | no | 
| Packaged: | 2020-10-23 07:00:33 UTC; rhbc | 
| Author: | Alexandra Kuznetsova [aut], Per Bruun Brockhoff [aut, ths], Rune Haubo Bojesen Christensen [aut, cre], Sofie Pødenphant Jensen [ctb] | 
| Maintainer: | Rune Haubo Bojesen Christensen <Rune.Haubo@gmail.com> | 
| Repository: | CRAN | 
| Date/Publication: | 2020-10-23 11:10:04 UTC | 
lmerTest: Tests in Linear Mixed Effects Models
Description
The lmerTest package provides p-values in type I, II or III
anova and summary
tables for linear mixed models (lmer model fits cf. lme4)
via Satterthwaite's degrees of freedom method; a Kenward-Roger method is also
available via the pbkrtest package.
Model selection and assessment methods include step,
drop1, anova-like tables for random effects (ranova),
least-square means (LS-means; ls_means)
and tests of linear contrasts of fixed effects (contest).
Key Functions and Methods
- lmer
- overloads - lme4::lmerand produced an object of class- lmerModLmerTestwhich inherits from- lmerMod. In addition to computing the model (using- lme4::lmer),- lmerTest::lmercomputes a couple of components needed for the evaluation of Satterthwaite's denominator degrees of freedom.
- anova
- anova method for - lmermodel fits produces type I, II, and III anova tables for fixed-effect terms with Satterthwaite and Kenward-Roger methods for denominator degrees of freedom for F-tests.
- summary
- summary method for - lmermodel fits adds denominator degrees of freedom and p-values to the coefficient table.
- ranova
- anova-like table of random effects via likelihood ratio tests with methods for both - lmerModand- lmerModLmerTestobjects.- ranovacan either test reduction of random-effect terms to simpler structures or it can test removal of entire random-effect terms.
- drop1
- F-tests of fixed-effect terms using Satterthwaite or Kenward-Roger methods for denominator degrees of freedom. These 'single term deletion' tables are useful for model selection and tests of marginal terms. Compared to the likelihood ratio tests of - lme4::drop1the F-tests and p-values of- lmerTest::drop1are more accurate and considerably faster since no additional model fitting is required.
- contest
- tests of contrasts, i.e. tests of linear functions of the fixed-effect coefficients. A user-friendly interface for tests of contrasts with outputs either as a summary-like table of t-tests or an anova-like table of F-tests (or a list of either). Contrasts can optionally be tested for estimability. Contrasts are allowed to be rank-deficient as the rank is automatically detected and appropriate adjustments made. Methods for - lmerModLmerTestas well as- lmerModobjects – the latter avoids the Satterthwaite specific computations when the Kenward-Roger method is used.
- show_test
- a function which operates on anova tables and LS-means tables makes it possible to see exactly which functions of the coefficients are being tested. This is helpful when differences between type I, II and III anova tables are being considered and discussed. 
- ls_means
- computes the so-called least-squares means (classical Yates contrasts) as well as pairwise differences of these. 
- step
- performs automatic backward model selection of fixed and random parts of the linear mixed model. 
- as_lmerModLmerTest
- an explicit coerce function from class - lmerModto- lmerModLmerTest.
Details
The computational approach is to let lmerTest::lmer compute the
Hessian and derivatives needed for evaluation of degrees of freedom and
t- and F-tests and to store these in the model object. The
Hessian and derivatives are therefore computed only once per model fit
and reused with each call to anova, summary, etc. Evaluation of
t and F-tests does not involve model re-fitting.
lmerTest::lmer roughly amounts to calling lme4::lmer followed by
lmerTest::as_lmerModLmerTest, so for computationally intensive model
fits it can make sense to use lme4::lmer rather than lmerTest::lmer
if computational time is an issue and summary tables and anova tables will
not be needed.
Author(s)
Alexandra Kuznetsova, Per Bruun Brockhoff, Rune Haubo Bojesen Christensen
References
Alexandra Kuznetsova, Per B. Brockhoff and Rune H. B. Christensen (2017) lmerTest Package: Tests in Linear Mixed Effects Models. Journal of Statistical Software, 82(13), 1–26. doi:10.18637/jss.v082.i13
Examples
## load lmerTest package
library(lmerTest)
## Fit linear mixed model to the ham data:
fm <- lmer(Informed.liking ~ Gender + Information * Product + (1 | Consumer) +
             (1 | Consumer:Product), data=ham)
## Summary including coefficient table with p-values for t-statistics using
## Satterthwaite's method for denominator degrees of freedom:
summary(fm)
## Type III anova table with p-values for F-tests based on Satterthwaite's
## method:
(aov <- anova(fm))
## Inspect the contrast matrix for the Type III test of Product:
show_tests(aov, fractions = TRUE)$Product
## Choose type II anova table with Kenward-Roger method for the F-test:
## Not run: 
if(requireNamespace("pbkrtest", quietly = TRUE))
  anova(fm, type=2, ddf="Kenward-Roger")
## End(Not run)
## Anova-like table of random-effect terms using likelihood ratio tests:
ranova(fm)
## F-tests of 'single term deletions' for all marginal terms:
drop1(fm)
## Least-Square means and pairwise differences:
(lsm <- ls_means(fm))
ls_means(fm, which = "Product", pairwise = TRUE)
## ls_means also have plot and as.data.frame methods:
## Not run: 
plot(lsm, which=c("Product", "Information"))
as.data.frame(lsm)
## Inspect the LS-means contrasts:
show_tests(lsm, fractions=TRUE)$Product
## End(Not run)
## Contrast test (contest) using a custom contrast:
## Here we make the 2-df joint test of the main effects of Gender and Information
(L <- diag(length(fixef(fm)))[2:3, ])
contest(fm, L = L)
## backward elimination of non-significant effects:
step_result <- step(fm)
## Elimination tables for random- and fixed-effect terms:
step_result
# Extract the model that step found:
final_model <- get_model(step_result)
Sensory Assesment of B&O TVs
Description
The TVbo dataset has kindly been made available by the Danish high-end consumer electronics company Bang & Olufsen. The main purpose was to assess 12 different TV sets (products) specified by the two attributes Picture and TVset. 15 different response variables (characteristics of the product) were assessed by a trained panel with 8 assessors.
Usage
data(TVbo)
Format
- Assessor
- factor with 8 levels assessors. 
- TVset
- product factor with 3 levels. 
- Picture
- product factor with 4 levels. 
In addition the following 15 numeric (response) variables are the characteristics on which the TV sets (products) are assessed:
Coloursaturation, Colourbalance, Noise, Depth, Sharpness, Lightlevel, Contrast, Sharpnessofmovement, Flickeringstationary, Flickeringmovement, Distortion, Dimglasseffect, Cutting, Flossyedges, Elasticeffect.
Examples
fm <- lmer(Coloursaturation ~ TVset + Picture + (1|Assessor:TVset) +
             (1|Assessor), data=TVbo)
ranova(fm)
anova(fm)
ANOVA Tables for Linear Mixed Models
Description
ANOVA table with F-tests and p-values using Satterthwaite's or
Kenward-Roger's method for denominator degrees-of-freedom and F-statistic.
Models should be fitted with
lmer from the lmerTest-package.
Usage
## S3 method for class 'lmerModLmerTest'
anova(
  object,
  ...,
  type = c("III", "II", "I", "3", "2", "1"),
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4")
)
Arguments
| object | an  | 
| ... | potentially additional  | 
| type | the type of ANOVA table requested (using SAS terminology) with Type I being the familiar sequential ANOVA table. | 
| ddf | the method for computing the denominator degrees of freedom and
F-statistics.  | 
Details
The "Kenward-Roger" method calls pbkrtest::KRmodcomp internally and
reports scaled F-statistics and associated denominator degrees-of-freedom.
Value
an ANOVA table
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
contestMD for multi degree-of-freedom contrast tests
and KRmodcomp for the "Kenward-Roger" method.
Examples
data("sleepstudy", package="lme4")
m <- lmer(Reaction ~ Days + (Days | Subject), sleepstudy)
anova(m) # with p-values from F-tests using Satterthwaite's denominator df
anova(m, ddf="lme4") # no p-values
# Use the Kenward-Roger method
if(requireNamespace("pbkrtest", quietly = TRUE))
  anova(m, ddf="Kenward-Roger")
Methods for Legacy lmerTest Objects
Description
Methods are defined for legacy lmerTest objects of class
merModLmerTest generated with lmerTest version < 3.0-0.
These methods are defined by interfacing code for lmerModLmerTest
methods and therefore behaves like these methods do (which may differ from
the behavior of lmerTest version < 3.0-0.)
Usage
## S3 method for class 'merModLmerTest'
anova(
  object,
  ...,
  type = c("III", "II", "I", "3", "2", "1"),
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4")
)
## S3 method for class 'merModLmerTest'
summary(object, ..., ddf = c("Satterthwaite", "Kenward-Roger", "lme4"))
## S3 method for class 'merModLmerTest'
ls_means(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  pairwise = FALSE,
  ...
)
## S3 method for class 'merModLmerTest'
lsmeansLT(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  pairwise = FALSE,
  ...
)
## S3 method for class 'merModLmerTest'
difflsmeans(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  ...
)
## S3 method for class 'merModLmerTest'
drop1(
  object,
  scope,
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4"),
  force_get_contrasts = FALSE,
  ...
)
## S3 method for class 'merModLmerTest'
step(
  object,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  alpha.random = 0.1,
  alpha.fixed = 0.05,
  reduce.fixed = TRUE,
  reduce.random = TRUE,
  keep,
  ...
)
Arguments
| object | an  | 
| ... | for the anova method optionally additional models; for other
methods see the corresponding  | 
| type | the type of ANOVA table requested (using SAS terminology) with Type I being the familiar sequential ANOVA table. | 
| ddf | the method for computing the denominator degrees of freedom and
F-statistics.  | 
| model | a model object fitted with  | 
| which | optional character vector naming factors for which LS-means should
be computed. If  | 
| level | confidence level. | 
| pairwise | compute pairwise differences of LS-means instead? | 
| scope | optional character vector naming terms to be dropped from the
model. Note that only marginal terms can be dropped. To see which terms are
marginal, use  | 
| force_get_contrasts | enforce computation of contrast matrices by a method in which the design matrices for full and restricted models are compared. | 
| alpha.random | alpha for random effects elimination | 
| alpha.fixed | alpha for fixed effects elimination | 
| reduce.fixed | reduce fixed effect structure?  | 
| reduce.random | reduce random effect structure?  | 
| keep | an optional character vector of fixed effect terms which should
not be considered for eliminated. Valid terms are given by
 | 
Author(s)
Rune Haubo B. Christensen
Examples
# Load model fits fm1 and fm2 generated with lmerTest version 2.3-37:
load(system.file("testdata","legacy_fits.RData", package="lmerTest"))
# Apply some methods defined by lmerTest:
anova(fm1)
summary(fm1)
contest(fm1, c(0, 1))
contest(fm1, c(0, 1), joint=FALSE)
drop1(fm1)
ranova(fm1)
# lme4-methods also work:
fixef(fm1)
# Ditto for second model fit:
anova(fm2)
summary(fm2)
ls_means(fm2)
difflsmeans(fm2)
Coerce ls_means Objects to data.frames
Description
Coerce ls_means Objects to data.frames
Usage
## S3 method for class 'ls_means'
as.data.frame(x, ..., add_levels = TRUE)
Arguments
| x | an  | 
| ... | currently not used. | 
| add_levels | add  | 
Author(s)
Rune Haubo B. Christensen
See Also
Examples
# Fit example model:
data("cake", package="lme4")
cake$Temp <- factor(cake$temperature, ordered = FALSE)
model <- lmer(angle ~ recipe + Temp + (1|recipe:replicate), cake)
# Extract LS-means:
head(lsm <- ls_means(model))
# Coerce LS-means objects to data.frames:
head(as.data.frame(lsm))
head(as.data.frame(lsm, add_levels=FALSE))
Coerce lmerMod Objects to lmerModLmerTest
Description
Coercing an lme4::lmer model-object (of class 'lmerMod') to a model-object of class 'lmerModLmerTest' involves computing the covariance matrix of the variance parameters and the gradient (Jacobian) of cov(beta) with respect to the variance parameters.
Usage
as_lmerModLmerTest(model, tol = 1e-08)
Arguments
| model | and lmer model-object (of class 'lmerMod') – the result of a
call to  | 
| tol | tolerance for determining of eigenvalues are negative, zero or positive | 
Value
an object of class 'lmerModLmerTest' which sets the following
slots:
| vcov_varpar | the asymptotic covariance matrix of the variance parameters (theta, sigma). | 
| Jac_list | list of Jacobian matrices; gradients of vcov(beta) with respect to the variance parameters. | 
| vcov_beta | the asymptotic covariance matrix of the fixed-effect regression parameters (beta; vcov(beta)). | 
| sigma | the residual standard deviation. | 
Author(s)
Rune Haubo B. Christensen
See Also
the class definition in lmerModLmerTest) and
lmer
Examples
m <- lme4::lmer(Reaction ~ Days + (Days | Subject), sleepstudy)
bm <- as_lmerModLmerTest(m)
slotNames(bm)
Consumer Preference Mapping of Carrots
Description
In a consumer study 103 consumers scored their preference of 12 danish carrot types on a scale from 1 to 7. Moreover the consumers scored the degree of sweetness, bitterness and crispiness in the products.
Usage
data(carrots)
Format
- Consumer
- factor with 103 levels: numbering identifying consumers. 
- Frequency
- factor with 5 levels; "How often do you eat carrots?" 1: once a week or more, 2: once every two weeks, 3: once every three weeks, 4: at least once month, 5: less than once a month. 
- Gender
- factor with 2 levels. 1: male, 2:female. 
- Age
- factor with 4 levels. 1: less than 25 years, 2: 26-40 years, 3: 41-60 years, 4 more than 61 years. 
- Homesize
- factor with two levels. Number of persons in the household. 1: 1 or 2 persons, 2: 3 or more persons. 
- Work
- factor with 7 levels. different types of employment. 1: unskilled worker(no education), 2: skilled worker(with education), 3: office worker, 4: housewife (or man), 5: independent businessman/ self-employment, 6: student, 7: retired 
- Income
- factor with 4 levels. 1: <150000, 2: 150000-300000, 3: 300000-500000, 4: >500000 
- Preference
- consumer score on a seven-point scale. 
- Sweetness
- consumer score on a seven-point scale. 
- Bitterness
- consumer score on a seven-point scale. 
- Crispness
- consumer score on a seven-point scale. 
- sens1
- first sensory variable derived from a PCA. 
- sens2
- second sensory variable derived from a PCA. 
- Product
- factor on 12 levels. 
Details
The carrots were harvested in autumn 1996 and tested in march 1997. In
addition to the consumer survey, the carrot products were evaluated by
a trained panel of tasters, the sensory panel, with respect to a
number of sensory (taste, odour and texture) properties. Since usually
a high number of (correlated) properties (variables) are used, in this
case 14, it is a common procedure to use a few, often 2, combined
variables that contain as much of the information in the sensory
variables as possible. This is achieved by extracting the first two
principal components in a principal components analysis (PCA) on the
product-by-property panel average data matrix. In this data set the
variables for the first two principal components are named
(sens1 and sens2).
Source
Per Bruun Brockhoff, The Royal Veterinary and Agricultural University, Denmark.
Examples
fm <- lmer(Preference ~ sens2 + Homesize + (1 + sens2 | Consumer), data=carrots)
anova(fm)
Determine the Containment Structure for All Terms in a Model
Description
See term_contain for details about containment.
Usage
containment(object)
Arguments
| object | a model object, e.g. of class  | 
Value
a list with one element for each term in the model. Each element/term is a character vector of terms that the term is contained in.
Generic Contrast Test Functions
Description
Generic functions for tests contrasts.
Usage
contest(model, L, ...)
contest1D(model, L, ...)
contestMD(model, L, ...)
Arguments
| model | a model object. | 
| L | a contrast vector or matrix. | 
| ... | additional arguments passed to methods. | 
Author(s)
Rune Haubo B. Christensen
See Also
contest methods for lmer objects:
contest,
contest1D, and
contestMD.
Test of Contrasts
Description
Tests of vector or matrix contrasts for lmer model fits.
Usage
## S3 method for class 'lmerModLmerTest'
contest(
  model,
  L,
  rhs = 0,
  joint = TRUE,
  collect = TRUE,
  confint = TRUE,
  level = 0.95,
  check_estimability = FALSE,
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4"),
  ...
)
## S3 method for class 'lmerMod'
contest(
  model,
  L,
  rhs = 0,
  joint = TRUE,
  collect = TRUE,
  confint = TRUE,
  level = 0.95,
  check_estimability = FALSE,
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4"),
  ...
)
Arguments
| model | a model object fitted with  | 
| L | a contrast vector or matrix or a list of these.
The  | 
| rhs | right-hand-side of the statistical test, i.e. the hypothesized value (a numeric scalar). | 
| joint | make an F-test of potentially several contrast vectors? If
 | 
| collect | collect list of tests in a matrix? | 
| confint | include columns for lower and upper confidence limits? Applies
when  | 
| level | confidence level. | 
| check_estimability | check estimability of contrasts? Only single DF
contrasts are checked for estimability thus requiring  | 
| ddf | the method for computing the denominator degrees of freedom.
 | 
| ... | passed to  | 
Details
If the design matrix is rank deficient, lmer drops columns for the
aliased coefficients from the design matrix and excludes the corresponding
aliased coefficients from fixef(model). When estimability is checked
the original rank-deficient design matrix is recontructed and therefore
L contrast vectors need to include elements for the aliased
coefficients. Similarly when L is a matrix, its number of columns
needs to match that of the reconstructed rank-deficient design matrix.
Value
a data.frame or a list of data.frames.
Author(s)
Rune Haubo B. Christensen
See Also
contestMD for multi
degree-of-freedom contrast tests,
and contest1D for tests of
1-dimensional contrasts.
Examples
data("sleepstudy", package="lme4")
fm <- lmer(Reaction ~ Days + I(Days^2) + (1|Subject) + (0+Days|Subject),
           sleepstudy)
# F-test of third coeffcients - I(Days^2):
contest(fm, c(0, 0, 1))
# Equivalent t-test:
contest(fm, L=c(0, 0, 1), joint=FALSE)
# Test of 'Days + I(Days^2)':
contest(fm, L=diag(3)[2:3, ])
# Other options:
contest(fm, L=diag(3)[2:3, ], joint=FALSE)
contest(fm, L=diag(3)[2:3, ], joint=FALSE, collect=FALSE)
# Illustrate a list argument:
L <- list("First"=diag(3)[3, ], "Second"=diag(3)[-1, ])
contest(fm, L)
contest(fm, L, collect = FALSE)
contest(fm, L, joint=FALSE, confint = FALSE)
contest(fm, L, joint=FALSE, collect = FALSE, level=0.99)
# Illustrate testing of estimability:
# Consider the 'cake' dataset with a missing cell:
data("cake", package="lme4")
cake$temperature <- factor(cake$temperature, ordered=FALSE)
cake <- droplevels(subset(cake, temperature %in% levels(cake$temperature)[1:2] &
                            !(recipe == "C" & temperature == "185")))
with(cake, table(recipe, temperature))
fm <- lmer(angle ~ recipe * temperature + (1|recipe:replicate), cake)
fixef(fm)
# The coefficient for recipeC:temperature185 is dropped:
attr(model.matrix(fm), "col.dropped")
# so any contrast involving this coefficient is not estimable:
Lmat <- diag(6)
contest(fm, Lmat, joint=FALSE, check_estimability = TRUE)
Contrast Tests in 1D
Description
Compute the test of a one-dimensional (vector) contrast in a linear mixed model fitted with lmer from package lmerTest. The contrast should specify a linear function of the mean-value parameters, beta. The Satterthwaite or Kenward-Roger method is used to compute the (denominator) df for the t-test.
Usage
## S3 method for class 'lmerModLmerTest'
contest1D(
  model,
  L,
  rhs = 0,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  confint = FALSE,
  level = 0.95,
  ...
)
## S3 method for class 'lmerMod'
contest1D(
  model,
  L,
  rhs = 0,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  confint = FALSE,
  level = 0.95,
  ...
)
Arguments
| model | a model object fitted with  | 
| L | a numeric (contrast) vector of the same length as
 | 
| rhs | right-hand-side of the statistical test, i.e. the hypothesized value (a numeric scalar). | 
| ddf | the method for computing the denominator degrees of freedom.
 | 
| confint | include columns for lower and upper confidence limits? | 
| level | confidence level. | 
| ... | currently not used. | 
Details
The t-value and associated p-value is for the hypothesis
L' \beta = \mathrm{rhs} in which rhs may be non-zero
and \beta is fixef(model).
The estimated value ("Estimate") is L' \beta with associated
standard error and (optionally) confidence interval.
Value
A data.frame with one row and columns with "Estimate",
"Std. Error", "t value", "df", and "Pr(>|t|)"
(p-value). If confint = TRUE "lower" and "upper" columns
are included before the p-value column.
Author(s)
Rune Haubo B. Christensen
See Also
contest for a flexible
and general interface to tests of contrasts among fixed-effect parameters.
contestMD is also available as a
direct interface for tests of multi degree-of-freedom contrast.
Examples
# Fit model using lmer with data from the lme4-package:
data("sleepstudy", package="lme4")
fm <- lmer(Reaction ~ Days + (1 + Days|Subject), sleepstudy)
# Tests and CI of model coefficients are obtained with:
contest1D(fm, c(1, 0), confint=TRUE) # Test for Intercept
contest1D(fm, c(0, 1), confint=TRUE) # Test for Days
# Tests of coefficients are also part of:
summary(fm)
# Illustrate use of rhs argument:
contest1D(fm, c(0, 1), confint=TRUE, rhs=10) # Test for Days-coef == 10
Multiple Degrees-of-Freedom Contrast Tests
Description
Compute the multi degrees-of-freedom test in a linear mixed model fitted
by lmer. The contrast (L) specifies a linear function of the
mean-value parameters, beta. Satterthwaite's method is used to compute the
denominator df for the F-test.
Usage
## S3 method for class 'lmerModLmerTest'
contestMD(
  model,
  L,
  rhs = 0,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  eps = sqrt(.Machine$double.eps),
  ...
)
calcSatterth(model, L)
## S3 method for class 'lmerMod'
contestMD(
  model,
  L,
  rhs = 0,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  eps = sqrt(.Machine$double.eps),
  ...
)
Arguments
| model | a model object fitted with  | 
| L | a contrast matrix with nrow >= 1 and ncol ==
 | 
| rhs | right-hand-side of the statistical test, i.e. the hypothesized
value. A numeric vector of length  | 
| ddf | the method for computing the denominator degrees of freedom and
F-statistics.  | 
| eps | tolerance on eigenvalues to determine if an eigenvalue is positive. The number of positive eigenvalues determine the rank of L and the numerator df of the F-test. | 
| ... | currently not used. | 
Details
The F-value and associated p-value is for the hypothesis
L \beta = \mathrm{rhs} in which rhs may be non-zero
and \beta is fixef(model).
Note: NumDF = row-rank(L) is determined automatically so row rank-deficient L are allowed. One-dimensional contrasts are also allowed (L has 1 row).
Value
a data.frame with one row and columns with "Sum Sq",
"Mean Sq", "F value", "NumDF" (numerator df),
"DenDF" (denominator df) and "Pr(>F)" (p-value).
Author(s)
Rune Haubo B. Christensen
See Also
contest for a flexible and
general interface to tests of contrasts among fixed-effect parameters.
contest1D is a direct interface for
tests of 1-dimensional contrasts.
Examples
data("sleepstudy", package="lme4")
fm <- lmer(Reaction ~ Days + I(Days^2) + (1|Subject) + (0+Days|Subject),
           sleepstudy)
# Define 2-df contrast - since L has 2 (linearly independent) rows
# the F-test is on 2 (numerator) df:
L <- rbind(c(0, 1, 0), # Note: ncol(L) == length(fixef(fm))
           c(0, 0, 1))
# Make the 2-df F-test of any effect of Days:
contestMD(fm, L)
# Illustrate rhs argument:
contestMD(fm, L, rhs=c(5, .1))
# Make the 1-df F-test of the effect of Days^2:
contestMD(fm, L[2, , drop=FALSE])
# Same test, but now as a t-test instead:
contest1D(fm, L[2, , drop=TRUE])
Compute Deviance of an LMM as a Function of Variance Parameters
Description
This function is used for extracting the asymptotic variance-covariance matrix of the variance parameters.
Usage
devfun_vp(varpar, devfun, reml)
Arguments
| varpar | variance parameters;  | 
| devfun | deviance function as a function of theta only. | 
| reml | if  | 
Value
the REML or ML deviance.
Author(s)
Rune Haubo B. Christensen
Doolittle Decomposition
Description
Doolittle Decomposition
Usage
doolittle(x, eps = 1e-06)
Arguments
| x | a numeric square matrix with at least 2 columns/rows. | 
| eps | numerical tolerance on the whether to normalize with components
in  | 
Value
a list with two matrices of the same dimension as x:
| L | lower-left unit-triangular matrix | 
| U | upper-right triangular matrix (not unit-triangular) | 
Drop Marginal Terms from Model
Description
Computes the F-test for all marginal terms, i.e. terms that can be dropped from the model while respecting the hierarchy of terms in the model.
Usage
## S3 method for class 'lmerModLmerTest'
drop1(
  object,
  scope,
  ddf = c("Satterthwaite", "Kenward-Roger", "lme4"),
  force_get_contrasts = FALSE,
  ...
)
Arguments
| object | an  | 
| scope | optional character vector naming terms to be dropped from the
model. Note that only marginal terms can be dropped. To see which terms are
marginal, use  | 
| ddf | the method for computing the denominator degrees of freedom and
F-statistics.  | 
| force_get_contrasts | enforce computation of contrast matrices by a method in which the design matrices for full and restricted models are compared. | 
| ... | currently not used. | 
Details
Simple marginal contrasts are used for all marginal terms unless the design
matrix is rank deficient. In that case (and if force_get_contrasts is
TRUE) the contrasts (i.e. restriction matrices on the design matrix
of the full model) are computed by comparison of the design matrices
for full and restricted models. The set of marginal terms considered for
dropping are computed using drop.scope(terms(object)).
Since all tests are based on tests of contrasts in the full model, no models are being (re)fitted.
Value
An anova-like table with F-tests of marginal terms.
Author(s)
Rune Haubo B. Christensen
See Also
ranova for tests of marginal random terms.
Examples
# Basic usage:
fm <- lmer(angle ~ recipe + temp + (1|recipe:replicate), cake)
drop1(fm) # Using Satterthwaite degrees of freedom
if(requireNamespace("pbkrtest", quietly = TRUE))
  drop1(fm, ddf="Kenward-Roger") # Alternative DenDF and F-test method
drop1(fm, ddf="lme4", test="Chi") # Asymptotic Likelihood ratio tests
# Consider a rank-deficient design matrix:
fm <- lmer(angle ~ recipe + temp + temperature + (1|recipe:replicate), cake)
# Here temp accounts for the linear effect of temperature, and
# temperature is an (ordered) factor that accounts for the remaining
# variation between temperatures (4 df).
drop1(fm)
# While temperature is in the model, we cannot test the effect of dropping
# temp. After removing temperature we can test the effect of dropping temp:
drop1(lmer(angle ~ recipe + temp + (1|recipe:replicate), cake))
# Polynomials:
# Note that linear terms should usually not be dropped before squared terms.
# Therefore 'Days' should not be dropped before 'I(Days^2)' despite it being
# tested here:
fm <- lmer(Reaction ~ Days + I(Days^2) + (Days|Subject), sleepstudy)
drop1(fm)
# Using poly() provides a test of the whole polynomial structure - not a
# separate test for the highest order (squared) term:
fm <- lmer(Reaction ~ poly(Days, 2) + (Days|Subject), sleepstudy)
drop1(fm)
Ensure a Design Matrix has Full (Column) Rank
Description
Determine and drop redundant columns using the qr
decomposition.
Usage
ensure_full_rank(X, tol = 1e-07, silent = FALSE, test.ans = FALSE)
Arguments
| X | a design matrix as produced by  | 
| tol | 
 | 
| silent | throw message if columns are dropped from  | 
| test.ans | Test if the resulting/returned matrix has full rank? Default
is  | 
Value
A design matrix in which redundant columns are dropped
Compute denominator df for F-test
Description
From a vector of denominator df from independent t-statistics (nu),
the denominator df for the corresponding F-test is computed.
Usage
get_Fstat_ddf(nu, tol = 1e-08)
Arguments
| nu | vector of denominator df for the t-statistics | 
| tol | tolerance on the consequtive differences between elements of nu to | 
Details
Note that if any nu <= 2 then 2 is returned. Also, if all nu
are within tol of each other the simple average of the nu-vector is returned.
This is to avoid downward bias.
Value
the denominator df; a numerical scalar
Author(s)
Rune Haubo B. Christensen
Type I ANOVA table contrasts
Description
Type I ANOVA table contrasts
Usage
get_contrasts_type1(model)
Arguments
| model | a model object with  | 
Value
List of contrast matrices - one contrast matrix for each model term.
Author(s)
Rune Haubo B. Christensen
Contrasts for Type III Tests
Description
Contrasts for Type III Tests
Usage
get_contrasts_type3(model, which = NULL)
Arguments
| model | model object. | 
| which | optional character vector naming terms for which to compute the the contrasts. | 
Value
list of contrast matrices.
Compute cov(beta) as a Function of varpar of an LMM
Description
At the optimum cov(beta) is available as vcov(lmer-model). This function
computes cov(beta) at non (RE)ML estimates of varpar.
Usage
get_covbeta(varpar, devfun)
Arguments
| varpar | variance parameters;  | 
| devfun | deviance function as a function of theta only. | 
Value
cov(beta) at supplied varpar values.
Author(s)
Rune Haubo B. Christensen
Extract Model from an Object
Description
Extract Model from an Object
Usage
get_model(x, ...)
Arguments
| x | an object. | 
| ... | currently not used. | 
See Also
Extract or remake model matrix from model
Description
Extract or remake model matrix from model and potentially change the contrast coding
Usage
get_model_matrix(model, type = c("extract", "remake"), contrasts = "restore")
Arguments
| model | an  | 
| type | extract or remake model matrix? | 
| contrasts | contrasts settings. These may be restored to those in the
model or they may be changed. If a length one character vector (e.g.
 | 
Value
the model (or 'design') matrix.
Author(s)
Rune Haubo B Christensen
Compute the 'Full' Rank-Deficient Design Matrix
Description
Compute the 'Full' Rank-Deficient Design Matrix
Usage
get_rdX(model, do.warn = TRUE)
Arguments
| model | a model object; lmerMod or lmerModLmerTest. | 
| do.warn | throw a message if there is no data for some factor combinations. | 
Value
the rank-deficien design matrix
Author(s)
Rune Haubo B. Christensen
Conjoint Study of Dry Cured Ham
Description
One of the purposes of the study was to investigate the effect of information given to the consumers measured in hedonic liking for the hams. Two of the hams were Spanish and two were Norwegian, each origin representing different salt levels and different aging time. The information about origin was given in such way that both true and false information was given. Essentially a 4x2 design with 4 samples and 2 information levels. A total of 81 Consumers participated in the study.
Usage
data(ham)
Format
- Consumer
- factor with 81 levels: numbering identifying consumers. 
- Product
- factor with four levels. 
- Informed.liking
- numeric: hedonic liking for the products. 
- Information
- factor with two levels. 
- Gender
- factor with two levels. 
- Age
- numeric: age of Consumer. 
References
T. Næs, V. Lengard, S. Bølling Johansen, M. Hersleth (2010) Alternative methods for combining design variables and consumer preference with information about attitudes and demographics in conjoint analysis, Food Quality and Preference, 10-4, 368-378, ISSN 0950-3293, https://doi.org/10.1016/j.foodqual.2009.09.004.
Examples
# Simple model for the ham data:
fm <- lmer(Informed.liking ~ Product*Information + (1|Consumer) , data=ham)
# Anova table for the fixed effects:
anova(fm)
## Not run: 
# Fit 'big' model:
fm <- lmer(Informed.liking ~ Product*Information*Gender*Age +
             + (1|Consumer) + (1|Consumer:Product) +
             (1|Consumer:Information),
           data=ham)
step_fm <- step(fm)
step_fm # Display elimination results
final_fm <- get_model(step_fm)
## End(Not run)
Estimability of Contrasts
Description
Computes the estimability of a vector or matrix of contrasts (i.e. linear functions of the coefficients) from the nullspace of a design matrix or potentially directly from the design matrix.
Usage
is_estimable(
  contrast,
  nullspace = NULL,
  X = NULL,
  tol = sqrt(.Machine$double.eps)
)
Arguments
| contrast | a numeric matrix where each row is a contrast vector for
which estimability is computed. The matrix should have as many columns as
there are columns in the design matrix (which equals the number of
coefficients). If  | 
| nullspace | the nullspace of the design matrix. | 
| X | design matrix. | 
| tol | tolerance for determining if a contrast is orthogonal to the | 
Value
a logical vector of length nrow(contrast) determining if each
contrast is estimable
Author(s)
Rune Haubo B. Christensen
See Also
Examples
# FIXME: We need some examples here
Fit Linear Mixed-Effects Models
Description
This function overloads lmer from the lme4-package
(lme4::lmer) and adds a couple of slots needed for the computation of
Satterthwaite denominator degrees of freedom. All arguments are the same as
for lme4::lmer and all the usual lmer-methods work.
Usage
lmer(
  formula,
  data = NULL,
  REML = TRUE,
  control = lmerControl(),
  start = NULL,
  verbose = 0L,
  subset,
  weights,
  na.action,
  offset,
  contrasts = NULL,
  devFunOnly = FALSE
)
Arguments
| formula | a two-sided linear formula object describing both the
fixed-effects and random-effects part of the model, with the
response on the left of a  | 
| data | an optional data frame containing the variables named in
 | 
| REML | logical scalar - Should the estimates be chosen to optimize the REML criterion (as opposed to the log-likelihood)? | 
| control | a list (of correct class, resulting from
 | 
| start | a named  | 
| verbose | integer scalar.  If  | 
| subset | an optional expression indicating the subset of the rows
of  | 
| weights | an optional vector of ‘prior weights’ to be used
in the fitting process.  Should be  | 
| na.action | a function that indicates what should happen when the
data contain  | 
| offset | this can be used to specify an a priori known
component to be included in the linear predictor during
fitting. This should be  | 
| contrasts | an optional list. See the  | 
| devFunOnly | logical - return only the deviance evaluation function. Note that because the deviance function operates on variables stored in its environment, it may not return exactly the same values on subsequent calls (but the results should always be within machine tolerance). | 
Details
For details about lmer see lmer
(help(lme4::lmer)). The description of all arguments is taken
unedited from the lme4-package.
In cases when a valid lmer-object
(lmerMod) is produced, but when the computations needed for
Satterthwaite df fails, the lmerMod object is returned - not an
lmerModLmerTest object.
Value
an S4 object of class "lmerModLmerTest"
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova for the overload in lmerTest – lme4-authors for the underlying implementation in lme4.
See Also
lmer and lmerModLmerTest
Examples
data("sleepstudy", package="lme4")
m <- lmer(Reaction ~ Days + (Days | Subject), sleepstudy)
class(m) # lmerModLmerTest
Represent Linear Mixed-Effects Models
Description
The lmerModLmerTest class extends lmerMod (which extends
merMod) from the lme4-package.
Value
An object of class lmerModLmerTest with slots as in
lmerMod objects (see merMod) and a few
additional slots as described in the slots section.
Slots
- vcov_varpar
- a numeric matrix holding the asymptotic variance-covariance matrix of the variance parameters (including sigma). 
- Jac_list
- a list of gradient matrices (Jacobians) for the gradient of the variance-covariance of beta with respect to the variance parameters, where beta are the mean-value parameters available in - fixef(object).
- vcov_beta
- a numeric matrix holding the asymptotic variance-covariance matrix of the fixed-effect regression parameters (beta). 
- sigma
- the residual standard deviation. 
Author(s)
Rune Haubo B. Christensen
See Also
LS-means Generic Function
Description
LS-means Generic Function
Usage
ls_means(model, ...)
difflsmeans(model, ...)
lsmeansLT(model, ...)
Arguments
| model | a model object. | 
| ... | parsed on to methods. | 
Author(s)
Rune Haubo B. Christensen
See Also
LS-means for lmerTest Model Fits
Description
Computes LS-means or pairwise differences of LS-mean for all factors in a
linear mixed model. lsmeansLT is provided as an alias for
ls_means for backward compatibility.
Usage
## S3 method for class 'lmerModLmerTest'
ls_means(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  pairwise = FALSE,
  ...
)
## S3 method for class 'lmerModLmerTest'
lsmeansLT(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  pairwise = FALSE,
  ...
)
## S3 method for class 'lmerModLmerTest'
difflsmeans(
  model,
  which = NULL,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  ...
)
Arguments
| model | a model object fitted with  | 
| which | optional character vector naming factors for which LS-means should
be computed. If  | 
| level | confidence level. | 
| ddf | method for computation of denominator degrees of freedom. | 
| pairwise | compute pairwise differences of LS-means instead? | 
| ... | currently not used. | 
Details
Confidence intervals and p-values are based on the t-distribution using degrees of freedom based on Satterthwaites or Kenward-Roger methods.
LS-means is SAS terminology for predicted/estimated marginal means, i.e. means for levels of factors which are averaged over the levels of other factors in the model. A flat (i.e. unweighted) average is taken which gives equal weight to all levels of each of the other factors. Numeric/continuous variables are set at their mean values. See emmeans package for more options and greater flexibility.
LS-means contrasts are checked for estimability and unestimable contrasts appear
as NAs in the resulting table.
LS-means objects (of class "ls_means" have a print method).
Value
An LS-means table in the form of a data.frame. Formally an object
of class c("ls_means", "data.frame") with a number of attributes set.
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
show_tests for display of the
underlying LS-means contrasts.
Examples
# Get data and fit model:
data("cake", package="lme4")
model <- lmer(angle ~ recipe * temp + (1|recipe:replicate), cake)
# Compute LS-means:
ls_means(model)
# Get LS-means contrasts:
show_tests(ls_means(model))
# Compute pairwise differences of LS-means for each factor:
ls_means(model, pairwise=TRUE)
difflsmeans(model) # Equivalent.
Legacy lmerTest representation of Linear Mixed-Effects Models
Description
The merModLmerTest class extends lmerMod (which extends
merMod) from the lme4-package.
Author(s)
Rune Haubo B. Christensen
Nullspace
Description
Compute the (right or left) nullspace of matrix using a (semi-complete) Singular Value Decomposition.
Usage
nullspace(A, type = c("right", "left"), tol = sqrt(.Machine$double.eps))
Arguments
| A | a numeric matrix. | 
| type | 
 | 
| tol | tolerance multiple of the first singular value to determine if subsequent singular values are (sufficiently) positive to be determined greater than zero. | 
Details
This implementation is fastest on matrices with more rows than columns such as a typical design matrix for a linear model.
Value
a matrix with as many rows as there are columns in A. The
number of columns (which may be zero) determine the dimensionality of the
nullspace of A.
Author(s)
Rune Haubo B. Christensen
Examples
# FIXME: We need some examples here
Bar Plots of LS-Means
Description
Bar plots of LS-means using the ggplot2 package.
Usage
## S3 method for class 'ls_means'
plot(x, y = NULL, which = NULL, mult = TRUE, ...)
Arguments
| x | an  | 
| y | not used and ignored with a warning. | 
| which | optional character vector naming factors for which LS-means should
be plotted. If  | 
| mult | if  | 
| ... | currently not used. | 
Value
generates the desired plots and invisibly returns the plot objects.
Author(s)
Rune Haubo B. Christensen
See Also
Examples
# Fit example model with 2 factors:
data("cake", package="lme4")
cake$Temp <- factor(cake$temperature, ordered = FALSE)
model <- lmer(angle ~ recipe * Temp + (1|recipe:replicate), cake)
# Extract LS-means:
(lsm <- ls_means(model))
# Multi-frame plot of the LS-means
plot(lsm)
# Compute list of 'single frame' plots:
res <- plot(lsm, mult=FALSE)
# Display each plot separately:
plot(res[[1]])
plot(res[[2]])
# Example with pairwise differences of LS-means:
(lsm <- ls_means(model, pairwise = TRUE))
plot(lsm, which="Temp")
Plot LS-means for Backward Reduced Model
Description
Computes the LS-means for the final backward reduced model and passes these
to plot.ls_means.
Usage
## S3 method for class 'step_list'
plot(
  x,
  y = NULL,
  which = NULL,
  pairwise = FALSE,
  mult = TRUE,
  level = 0.95,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  ...
)
Arguments
| x | a  | 
| y | not used and ignored with a warning. | 
| which | optional character vector naming factors for which LS-means should
be plotted. If  | 
| pairwise | pairwise differences of LS-means? | 
| mult | if  | 
| level | confidence level. | 
| ddf | denominator degree of freedom method. | 
| ... | currently not used. | 
Details
Error bars are confidence intervals - the default is 95 level can be changed.
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
Examples
## Not run: 
# Fit example model:
tv <- lmer(Sharpnessofmovement ~ TVset * Picture +
             (1 | Assessor:TVset) + (1 | Assessor:Picture) +
             (1 | Assessor:Picture:TVset) + (1 | Repeat) + (1 | Repeat:Picture) +
             (1 | Repeat:TVset) + (1 | Repeat:TVset:Picture) + (1 | Assessor),
           data = TVbo)
# Backward reduce the model:
(st <- step(tv)) # takes ~10 sec to run
# Pairwise comparisons of LS-means for Picture and TVset:
  plot(st, which=c("Picture", "TVset"), pairwise = TRUE)
## End(Not run)
Compute Quadratic Form
Description
Efficiently computes x' A x - or in R-notation:
Usage
qform(x, A)
Arguments
| x | a numeric vector | 
| A | a symmetric numeric matrix | 
Details
Length of x should equal the number of rows and columns of A.
Value
a numerical scalar
ANOVA-Like Table for Random-Effects
Description
Compute an ANOVA-like table with tests of random-effect terms in the model.
Each random-effect term is reduced or removed and likelihood ratio tests of
model reductions are presented in a form similar to that of
drop1.
rand is an alias for ranova.
Usage
ranova(model, reduce.terms = TRUE, ...)
rand(model, reduce.terms = TRUE, ...)
Arguments
| model | a linear mixed effect model fitted with  | 
| reduce.terms | if  | 
| ... | currently ignored | 
Details
If the model is fitted with REML the tests are REML-likelihood ratio tests.
A random-effect term of the form (f1 + f2 | gr) is reduced to
terms of the form (f2 | gr) and (f1 | gr) and these reduced
models are compared to the original model.
If reduce.terms is FALSE (f1 + f2 | gr) is removed
instead.
A random-effect term of the form (f1 | gr) is reduced to (1 | gr)
(unless reduce.terms is FALSE).
A random-effect term of the form (1 | gr) is not reduced but
simply removed.
A random-effect term of the form (0 + f1 | gr) or (-1 + f1 | gr)
is reduced (if reduce.terms = TRUE) to (1 | gr).
A random-effect term of the form (1 | gr1/gr2) is automatically
expanded to two terms: (1 | gr2:gr1) and (1 | gr1) using
findbars.
In this exposition it is immaterial whether f1 and f2 are
factors or continuous variables.
Value
an ANOVA-like table with single term deletions of random-effects
inheriting from class anova and data.frame with the columns:
| npar | number of model parameters. | 
| logLik | the log-likelihood for the model. Note that this is the REML-logLik if the model is fitted with REML. | 
| AIC | the AIC for the model evaluated as  | 
| LRT | the likelihood ratio test statistic; twice the difference in log-likelihood, which is asymptotically chi-square distributed. | 
| Df | degrees of freedom for the likelihood ratio test: the difference in number of model parameters. | 
| Pr(>Chisq) | the p-value. | 
Warning
In certain cases tests of non-nested models may be generated. An example
is when (0 + poly(x, 2) | gr) is reduced (the default) to (1 | gr).
To our best knowledge non-nested model comparisons are only generated in
cases which are statistical nonsense anyway (such as in this example where
the random intercept is suppressed).
Note
Note that anova can be used to compare two models and will often
be able to produce the same tests as ranova. This is, however, not always the
case as illustrated in the examples.
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
drop1 for tests of marginal
fixed-effect terms and
anova for usual anova tables for fixed-effect terms.
Examples
# Test reduction of (Days | Subject) to (1 | Subject):
fm1 <- lmer(Reaction ~ Days + (Days|Subject), sleepstudy)
ranova(fm1) # 2 df test
# This test can also be achieved with anova():
fm2 <- lmer(Reaction ~ Days + (1|Subject), sleepstudy)
anova(fm1, fm2, refit=FALSE)
# Illustrate reduce.test argument:
# Test removal of (Days | Subject):
ranova(fm1, reduce.terms = FALSE) # 3 df test
# The likelihood ratio test statistic is in this case:
fm3 <- lm(Reaction ~ Days, sleepstudy)
2*c(logLik(fm1, REML=TRUE) - logLik(fm3, REML=TRUE)) # LRT
# anova() is not always able to perform the same tests as ranova(),
# for example:
anova(fm1, fm3, refit=FALSE) # compares REML with ML and should not be used
anova(fm1, fm3, refit=TRUE) # is a test of ML fits and not what we seek
# Also note that the lmer-fit needs to come first - not an lm-fit:
# anova(fm3, fm1) # does not work and gives an error
# ranova() may not generate all relevant test:
# For the following model ranova() indicates that we should not reduce
# (TVset | Assessor):
fm <- lmer(Coloursaturation ~ TVset * Picture + (TVset | Assessor), data=TVbo)
ranova(fm)
# However, a more appropriate model is:
fm2 <- lmer(Coloursaturation ~ TVset * Picture + (1 | TVset:Assessor), data=TVbo)
anova(fm, fm2, refit=FALSE)
# fm and fm2 has essentially the same fit to data but fm uses 5 parameters
# more than fm.
rbind Multiple Objects
Description
rbind Multiple Objects
Usage
rbindall(...)
Arguments
| ... | objects to be  | 
Remove Terms from Formula
Description
Remove fixef or ranef terms from formula, return a list of modified formulae with environment restored to that of the original formula.
Usage
rm_complete_terms(terms, full_formula, random = TRUE)
Arguments
| terms | character vector (or list) of terms to remove from
 | 
| full_formula | formula | 
| random | if  | 
Show Tests Generic Function and Default Method
Description
Show Tests Generic Function and Default Method
Usage
show_tests(object, ...)
## Default S3 method:
show_tests(object, fractions = FALSE, names = TRUE, ...)
Arguments
| object | a suitable object with an  | 
| ... | parsed on to methods; currently not used in the default method. | 
| fractions | display entries in the hypothesis matrices as fractions? | 
| names | if  | 
Author(s)
Rune Haubo B. Christensen
Rune Haubo B. Christensen
See Also
show_tests.anova and show_tests.ls_means
Show Hypothesis Tests in ANOVA Tables
Description
Extracts hypothesis matrices for terms in ANOVA tables detailing exactly which functions of the parameters are being tested in anova tables.
Usage
## S3 method for class 'anova'
show_tests(object, fractions = FALSE, names = TRUE, ...)
Arguments
| object | an anova table with a  | 
| fractions | display entries in the hypothesis matrices as fractions? | 
| names | if  | 
| ... | currently not used. | 
Value
a list of hypothesis matrices.
Author(s)
Rune Haubo B. Christensen
See Also
show_tests for ls_means
objects.
Examples
# Fit basic model to the 'cake' data:
data("cake", package="lme4")
fm1 <- lmer(angle ~ recipe * temp + (1|recipe:replicate), cake)
# Type 3 anova table:
(an <- anova(fm1, type="3"))
# Display tests/hypotheses for type 1, 2, and 3 ANOVA tables:
# (and illustrate effects of 'fractions' and 'names' arguments)
show_tests(anova(fm1, type="1"))
show_tests(anova(fm1, type="2"), fractions=TRUE, names=FALSE)
show_tests(an, fractions=TRUE)
Show LS-means Hypothesis Tests and Contrasts
Description
Extracts the contrasts which defines the LS-mean hypothesis tests.
Usage
## S3 method for class 'ls_means'
show_tests(object, fractions = FALSE, names = TRUE, ...)
Arguments
| object | an  | 
| fractions | display contrasts as fractions rather than decimal numbers? | 
| names | include row and column names of the contrasts matrices? | 
| ... | currently not used. | 
Value
a list of contrast matrices; one matrix for each model term.
Author(s)
Rune Haubo B. Christensen
See Also
ls_means for computation of
LS-means and show_tests for anova
objects.
Examples
data("cake", package="lme4")
model <- lmer(angle ~ recipe * temp + (1|recipe:replicate), cake)
# LS-means:
(lsm <- ls_means(model))
# Contrasts for LS-means estimates and hypothesis tests:
show_tests(lsm)
ANOVA Tables for Linear Mixed Models
Description
ANOVA Tables for Linear Mixed Models
Usage
single_anova(
  object,
  type = c("III", "II", "I", "3", "2", "1", "yates", "marginal", "2b"),
  ddf = c("Satterthwaite", "Kenward-Roger")
)
Arguments
| object | an  | 
| type | the type of ANOVA table requested (using the SAS terminology for these) with Type I being the familiar sequential ANOVA table. | 
| ddf | method for computing denominator degrees of freedom. | 
Value
an ANOVA table
Author(s)
Rune Haubo B. Christensen
Generic Step Function
Description
Generic step function with default method stats::step. This
construction ensures that stats::step still works on lm
objects etc. after loading the lmerTest package.
Usage
step(object, ...)
## Default S3 method:
step(object, ...)
Arguments
| object | a model object. | 
| ... | currently not used. | 
Author(s)
Rune Haubo B. Christensen
See Also
Backward Elimination for Linear Mixed Models
Description
Backward elimination of random-effect terms followed by backward elimination of fixed-effect terms in linear mixed models.
Usage
## S3 method for class 'lmerModLmerTest'
step(
  object,
  ddf = c("Satterthwaite", "Kenward-Roger"),
  alpha.random = 0.1,
  alpha.fixed = 0.05,
  reduce.fixed = TRUE,
  reduce.random = TRUE,
  keep,
  ...
)
## S3 method for class 'step_list'
get_model(x, ...)
Arguments
| object | a fitted model object. For the  | 
| ddf | the method for computing the denominator degrees of freedom and
F-statistics.  | 
| alpha.random | alpha for random effects elimination | 
| alpha.fixed | alpha for fixed effects elimination | 
| reduce.fixed | reduce fixed effect structure?  | 
| reduce.random | reduce random effect structure?  | 
| keep | an optional character vector of fixed effect terms which should
not be considered for eliminated. Valid terms are given by
 | 
| ... | currently not used. | 
| x | a step object. | 
Details
Tests of random-effects are performed using ranova (using
reduce.terms = TRUE) and tests of fixed-effects are performed using
drop1.
The step method for lmer fits has a print method.
Value
step returns a list with elements "random" and
"fixed" each
containing anova-like elimination tables. The "fixed" table is
based on drop1 and the "random" table is
based on ranova (a drop1-like table for random effects). Both
tables have a column "Eliminated" indicating the order in which terms
are eliminated from the model with zero (0) indicating that the term
is not eliminated from the model.
The step object also contains the final model as an attribute which
is extractable with get_model(<step_object>).
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
drop1 for tests of marginal
fixed-effect terms and ranova for a
drop1-like table of reduction of
random-effect terms.
Examples
# Fit a model to the ham dataset:
fm <- lmer(Informed.liking ~ Product*Information+
             (1|Consumer) + (1|Product:Consumer)
           + (1|Information:Consumer), data=ham)
# Backward elimination using terms with default alpha-levels:
(step_res <- step(fm))
final <- get_model(step_res)
anova(final)
## Not run: 
# Fit 'big' model:
fm <- lmer(Informed.liking ~ Product*Information*Gender*Age +
             + (1|Consumer) + (1|Consumer:Product) +
             (1|Consumer:Information), data=ham)
step_fm <- step(fm)
step_fm # Display elimination results
final_fm <- get_model(step_fm)
## End(Not run)
Summary Method for Linear Mixed Models
Description
Summaries of Linear Mixed Models with coefficient tables including t-tests and p-values using Satterthwaites's or Kenward-Roger's methods for degrees-of-freedom and t-statistics.
Usage
## S3 method for class 'lmerModLmerTest'
summary(object, ..., ddf = c("Satterthwaite", "Kenward-Roger", "lme4"))
Arguments
| object | an lmerModLmerTest object. | 
| ... | additional arguments passed on to  | 
| ddf | the method for computing the degrees of freedom and
t-statistics.  | 
Details
The returned object is of class
c("summary.lmerModLmerTest", "summary.merMod") utilizing print,
coef and other methods defined for summary.merMod objects.
The "Kenward-Roger" method use methods from the pbkrtest package internally
to compute t-statistics and associated degrees-of-freedom.
Value
A summary object with a coefficient table (a matrix) including
t-values and p-values. The coefficient table can be extracted with
coef(summary(<my-model>)).
Author(s)
Rune Haubo B. Christensen and Alexandra Kuznetsova
See Also
contest1D for one degree-of-freedom contrast tests
and KRmodcomp for Kenward-Roger F-tests.
Examples
# Fit example model:
data("sleepstudy", package="lme4")
fm <- lmer(Reaction ~ Days + (1|Subject) + (0+Days|Subject), sleepstudy)
# Get model summary:
summary(fm) # Satterthwaite df and t-tests
# Extract coefficient table:
coef(summary(fm))
# Use the Kenward-Roger method
if(requireNamespace("pbkrtest", quietly = TRUE))
  summary(fm, ddf="Kenward-Roger")
# The lme4-summary table:
summary(fm, ddf="lme4") # same as summary(as(fm, "lmerMod"))
Determine which Terms Contain a Term
Description
The definition of containment follows from the SAS documentation on "The Four Types of Estimable Functions".
Usage
term_contain(term, factors, dataClasses, term_names)
Arguments
| term | character; name of a model term and one of  | 
| factors | the result of  | 
| dataClasses | the result of
 | 
| term_names | the result of  | 
Details
Containment is defined for two model terms, say, F1 and F2 as: F1 is contained in F2 (F2 contains F1) if
- F1 and F2 involve the same continuous variables (if any) 
- F2 involve more factors than F1 
- All factors in F1 (if any) are part of F2 
The intercept, though not really a model term, is defined by SAS to be contained in all factor terms, but it is not contained in any effect involving a continuous variable.
Value
a logical vector indicating for each term in term_names if
it contains term.