Other vignettes available
If this vignette is being viewed on CRAN, note that many other vignettes describing how to use sdmTMB are available on the documentation site under Articles.
Notation conventions
This appendix uses the following notation conventions, which generally follow the guidance in Edwards & Auger-MΓ©thΓ© (2019):
Greek symbols for parameters,
the Latin/Roman alphabet for data (except and , which are used by convention),
bold symbols for vectors or matrices (e.g., is a vector and is the value of at point in space ),
for all distribution dispersion parameters for consistency with the code,
to define the expected value (mean) of variable ,
to define the expected variance of the variable ,
a superscript represents interpolated or projected values as opposed to values at knot locations (e.g., vs.Β ), and
where possible, notation has been chosen to match VAST (Thorson 2019) to maintain consistency (e.g., for spatial fields and for spatiotemporal fields).
We include tables of all major indices (Table 1) and symbols (Table 2).
Symbol | Description |
---|---|
Index for space; a vector of x and y coordinates | |
Index for time | |
Group |
Symbol | Code | Description |
---|---|---|
y_i |
Observed response data | |
mu_i |
Mean | |
phi |
A dispersion parameter for a distribution | |
fit$family$link |
Link function | |
fit$family$linkinv |
Inverse link function | |
b_j |
Parameter vector | |
X_ij |
A predictor model matrix | |
offset |
An offset variable at point and time | |
omega_s |
Spatial random field at point (knot) | |
omega_s_A |
Spatial random field at point (interpolated) | |
zeta_s |
Spatially varying coefficient random field at point (knot) | |
zeta_s_A |
Spatially varying coefficient random field at point (interpolated) | |
epsilon_st |
Spatiotemporal random field at point and time (knot) | |
epsilon_st_A |
Spatiotemporal random field at point and time (interpolated) | |
b_t |
AR(1) or random walk spatiotemporal deviations (knot) | |
RE |
IID random intercept deviation for group | |
- |
Spatial random field covariance matrix | |
- |
Spatially varying coefficient random field covariance matrix | |
- |
Spatiotemporal random field covariance matrix | |
Q_s |
Spatial random field precision matrix | |
Q_s |
Spatially varying coefficient random field precision matrix | |
Q_st |
Spatiotemporal random field precision matrix | |
sigma_G |
IID random intercept variance | |
sigma_E |
Spatiotemporal random field marginal variance | |
sigma_O |
Spatial random field marginal variance | |
sigma_Z |
Spatially varying coefficient random field marginal variance | |
kappa(0) |
Spatial decorrelation rate | |
kappa(1) |
Spatiotemporal decorrelation rate | |
ar1_rho |
Correlation between random fields in subsequent time steps | |
rho_time |
Correlation between time-varying coefficients in subsequent time steps | |
A |
Sparse projection matrix to interpolate between knot and data locations | |
H |
2-parameter rotation matrix used to define anisotropy |
sdmTMB model structure
The complete sdmTMB model can be written as
where
- represents the response data at point and time ;
- represents the mean;
- represents a link function (e.g., log or logit) and represents its inverse;
- , , and represent design matrices (the superscript identifiers βmainβ = main effects, βtvcβ = time varying coefficients, and βsvcβ = spatially varying coefficients);
- represents a vector of fixed-effect coefficients;
- represents an offset: a covariate (usually log transformed) with a coefficient fixed at one;
- represents random intercepts by group , ;
- represents time-varying coefficients (a random walk), ;
- represents spatially varying coefficients (a random field), ;
- represents a spatial component (a random field), ; and
- represents a spatiotemporal component (a random field), .
A single sdmTMB model will rarely, if ever, contain all of the above components. Next, we will split the model to describe the various parts in more detail using ββ to represent the other optional components.
Main effects
Within sdmTMB()
,
is defined by the formula
argument and represents the
main-effect model matrix and a corresponding vector of coefficients.
This main effect formula can contain optional penalized smoothers or
non-linear functions as defined below.
Smoothers
Smoothers in sdmTMB are implemented with the same formula syntax
familiar to mgcv (Wood 2017) users fitting
GAMs (generalized additive models). Smooths are implemented in the
formula using + s(x)
, which implements a smooth from
mgcv::s()
. Within these smooths, the same syntax commonly
used in mgcv::s()
can be applied, e.g.Β 2-dimensional
smooths may be constructed with + s(x, y)
; smooths can be
specific to various factor levels, + s(x, by = group)
;
smooths can vary according to a continuous variable,
+ s(x, by = x2)
; the basis function dimensions may be
specified, e.g.Β + s(x, k = 4)
(see
?mgcv::choose.k
); and various types of splines may be
constructed such as cyclic splines to model seasonality,
e.g.Β + s(month, bs = "cc", k = 12)
.
While mgcv can fit unpenalized (e.g., B-splines) or penalized splines
(P-splines), sdmTMB only implements penalized splines. The penalized
splines are constructed in sdmTMB using the function
mgcv::smooth2random()
, which transforms splines into random
effects (and associated design matrices) that are estimable in a
mixed-effects modelling framework. This is the same approach as is
implemented in the R packages gamm4 (Wood &
Scheipl 2020) and brms (BΓΌrkner
2017).
Linear break-point threshold models
The linear break-point or βhockey stickβ model can be used to describe threshold or asymptotic responses. This function consists of two pieces, so that for , , and for , . In both cases, represents the slope of the function up to a threshold, and the product represents the value at the asymptote. No constraints are placed on parameters or .
These models can be fit by including + breakpt(x)
in the
model formula, where x
is a covariate. The formula can
contain a single break-point covariate.
Logistic threshold models
Models with logistic threshold relationships between a predictor and the response can be fit with the form
where represents the logistic function, is a scaling parameter (controlling the height of the y-axis for the response; unconstrained), is an intercept, is a parameter controlling the point at which the function reaches 50% of the maximum (), and is a parameter controlling the point at which the function reaches 95% of the maximum. The parameter is unconstrained but is constrained to be larger than .
These models can be fit by including + logistic(x)
in
the model formula, where x
is a covariate. The formula can
contain a single logistic covariate.
Spatial random fields
Spatial random fields,
,
are included if spatial = 'on'
(or TRUE
) and
omitted if spatial = 'off'
(or FALSE
).
The marginal standard deviation of
is indicated by Spatial SD
in the printed model output or
as sigma_O
in the output of
sdmTMB::tidy(fit, "ran_pars")
. The βOβ is for βomegaβ
().
Internally, the random fields follow a Gaussian Markov random field (GMRF)
where is a sparse precision matrix and is the marginal variance.
Spatiotemporal random fields
Spatiotemporal random fields are included by default if there are
multiple time elements (time
argument is not
NULL
) and can be set to IID (independent and identically
distributed, 'iid'
; default), AR(1) ('ar1'
),
random walk ('rw'
), or off ('off'
) via the
spatiotemporal
argument. These text values are case
insensitive.
Spatiotemporal random fields are represented by
within sdmTMB. This has been chosen to match the representation in VAST
(Thorson 2019). The marginal standard
deviation of
is indicated by Spatiotemporal SD
in the printed model
output or as sigma_E
in the output of
sdmTMB::tidy(fit, "ran_pars")
. The βEβ is for βepsilonβ
().
IID spatiotemporal random fields
IID spatiotemporal random fields
(spatiotemporal = 'iid'
) can be represented as
where represent random field deviations at point and time . The random fields are assumed independent across time steps.
Similarly to the spatial random fields, these spatiotemporal random fields (including all versions described below) are parameterized internally with a sparse precision matrix ()
AR(1) spatiotemporal random fields
First-order auto regressive, AR(1), spatiotemporal random fields
(spatiotemporal = 'ar1'
) add a parameter defining the
correlation between random field deviations from one time step to the
next. They are defined as
where
is the correlation between subsequent spatiotemporal random fields. The
term scales the spatiotemporal variance by the correlation such that it
represents the steady-state marginal variance. The correlation
allows for mean-reverting spatiotemporal fields, and is constrained to
be
.
Internally, the parameter is estimated as ar1_phi
, which is
unconstrained. The parameter ar1_phi
is transformed to
with
.
Random walk spatiotemporal random fields (RW)
Random walk spatiotemporal random fields
(spatiotemporal = 'rw'
) represent a model where the
difference in spatiotemporal deviations from one time step to the next
are IID. They are defined as
where the distribution of the spatiotemporal field in the initial time step is the same as for the AR(1) model, but the absence of the parameter allows the spatiotemporal field to be non-stationary in time. Note that, in contrast to the AR(1) parametrization, the variance is no longer the steady-state marginal variance.
Time-varying regression parameters
Parameters can be modelled as time-varying according to a random walk
or first-order autoregressive, AR(1), process. The time-series model is
defined by time_varying_type
. For all types:
where
is an optional vector of time-varying regression parameters and
is the corresponding model matrix with covariate values. This is defined
via the time_varying
argument, assuming that the
time
argument is also supplied a column name.
time_varying
takes a one-sided formula.
~ 1
implies a time-varying intercept.
For time_varying_type = 'rw'
, the first time step is
estimated independently:
In this case, the first time-step value is given an implicit uniform
prior. I.e., the same variable should not appear in the fixed effect
formula since the initial value is estimated as part of the time-varying
formula. The formula time_varying = ~ 1
implicitly
represents a time-varying intercept (assuming the time
argument has been supplied) and, this case, the intercept should be
omitted from the main effects (formula ~ + 0 + ...
or
formula ~ -1 + ...
).
For time_varying_type = 'rw0'
, the first time step is
estimated from a mean-zero prior:
In this case, the time-varying variable
(including the intercept) should be included in the main
effects. We suggest using this formulation, but leave the
'rw'
option so that legacy code works.
For time_varying_type = 'ar1'
:
where is the correlation between subsequent time steps. The first time step is given a mean-zero prior.
Spatially varying coefficients (SVC)
Spatially varying coefficient models are defined as
where
is a random field representing a spatially varying coefficient. Usually,
would represent a prediction matrix that is constant spatially for a
given time
as defined by a one-sided formula supplied to
spatial_varying
. For example
spatial_varying = ~ 0 + x
, where 0
omits the
intercept.
The random fields are parameterized internally with a sparse precision matrix ()
IID random or multi-level intercepts
Multilevel/hierarchical intercepts are defined as
where
is an example optional βrandomβ interceptβan intercept with mean zero
that varies by level
and is constrained by
.
This is defined by the formula
argument via the
(1 | g)
syntax as in lme4 or glmmTMB. There can be multiple
random intercepts, despite only showing one above. E.g.,
(1 | g1) + (1 | g2)
, in which case they are assumed
independent and uncorrelated from each other.
Offset terms
Offset terms can be included through the offset
argument
in sdmTMB()
. These are included in the linear predictor
as
where
is an offset termβa log transformed variable without a
coefficient (assuming a log link). The offset is not included
in the prediction. Therefore, if offset
represents a
measure of effort, for example, the prediction is for one unit of effort
(log(1) = 0
).
Observation model families
Here we describe the main observation families that are available in sdmTMB and comment on their parametrization, statistical properties, utility, and code representation in sdmTMB.
Binomial
where
is the size or number of trials, and
is the probability of success for each trial. If
,
the distribution becomes the Bernoulli distribution. Internally, the
distribution is parameterized as the robust
version in TMB, which is numerically stable when probabilities
approach 0 or 1. Following the structure of stats::glm()
,
lme4, and glmmTMB, a binomial family can be specified in one of 4
ways:
- the response may be a factor (and the model classifies the first level versus all others)
- the response may be binomial (0/1)
- the response can be a matrix of form
cbind(success, failure)
, or - the response may be the observed proportions, and the
weights
argument is used to specify the Binomial size () parameter (probabilty ~ ..., weights = N
).
Code defined within TMB.
Example: family = binomial(link = "logit")
Beta
where is the mean and is a precision parameter. This parametrization follows Ferrari & Cribari-Neto (2004) and the betareg R package (Cribari-Neto & Zeileis 2010). The variance is .
Code defined within TMB.
Example: family = Beta(link = "logit")
Gamma
where represents the Gamma shape and represents the scale. The mean is and variance is .
Code defined within TMB.
Example: family = Gamma(link = "log")
Gaussian
where is the mean and is the standard deviation. The variance is .
Example: family = Gaussian(link = "identity")
Code defined within TMB.
Lognormal
sdmTMB uses the bias-corrected lognormal distribution where represents the standard deviation in log-space:
Because of the bias correction, and .
Code defined within
sdmTMB based on the TMB dnorm()
normal density.
Example: family = lognormal(link = "log")
Negative Binomial 1 (NB1)
where is the mean and is the dispersion parameter. The variance scales linearly with the mean (Hilbe 2011). Internally, the distribution is parameterized as the robust version in TMB.
Code defined within sdmTMB based on NB2 and borrowed from glmmTMB.
Example: family = nbinom1(link = "log")
Negative Binomial 2 (NB2)
where is the mean and is the dispersion parameter. The variance scales quadratically with the mean (Hilbe 2011). The NB2 parametrization is more commonly seen in ecology than the NB1. Internally, the distribution is parameterized as the robust version in TMB.
Code defined within TMB.
Example: family = nbinom2(link = "log")
Poisson
where represents the mean and .
Code defined within TMB.
Example: family = poisson(link = "log")
Student-t
where
,
the degrees of freedom (df
), is a user-supplied fixed
parameter. Lower values of
result in heavier tails compared to the Gaussian distribution. Above
approximately df = 20
, the distribution becomes very
similar to the Gaussian. The Student-t distribution with a low degrees
of freedom (e.g.,
)
can be helpful for modelling data that would otherwise be suitable for
Gaussian but needs an approach that is robust to outliers (e.g., Anderson et al. 2017).
Code defined within
sdmTMB based on the dt()
distribution in TMB.
Example: family = student(link = "log", df = 7)
Tweedie
where is the mean, is the power parameter constrained between 1 and 2, and is the dispersion parameter. The Tweedie distribution can be helpful for modelling data that are positive and continuous but also contain zeros.
Internally, is transformed from to constrain it between 1 and 2 and is estimated as an unconstrained variable.
The source code is implemented as in the cplm package (Zhang 2013) and is based on Dunn & Smyth (2005). The TMB version is defined here.
Example: family = tweedie(link = "log")
Gamma mixture
This is a 2 component mixture that extends the Gamma distribution,
where represents the Gamma shape, represents the scale for the first (smaller component) of the distribution, represents the scale for the second (larger component) of the distribution, and controls the contribution of each component to the mixture (also interpreted as the probability of larger events).
The mean is and the variance is .
Here, and for the other mixture distributions, the probability of the
larger mean can be obtained from
plogis(fit$model$par[["logit_p_mix"]])
and the ratio of the
larger mean to the smaller mean can be obtained from
1 + exp(fit$model$par[["log_ratio_mix"]])
. The standard
errors are available in the TMB sdreport:
fit$sd_report
.
If you wish to fix the probability of a large (i.e., extreme) mean,
which can be hard to estimate, you can use the map
list.
E.g.:
sdmTMB(...,
control = sdmTMBcontrol(
start = list(logit_p_mix = qlogis(0.05)), # 5% probability of 'mu2'
map = list(logit_p_mix = factor(NA)) # don't estimate
)
)
Example: family = gamma_mix(link = "log")
. See also
family = delta_gamma_mix()
for an extension incorporating
this distribution with delta models.
Lognormal mixture
This is a 2 component mixture that extends the lognormal distribution,
Because of the bias correction, and .
As with the Gamma mixture, controls the contribution of each component to the mixture (also interpreted as the probability of larger events).
Example: family = lognormal_mix(link = "log")
. See also
family = delta_lognormal_mix()
for an extension
incorporating this distribution with delta models.
Negative binomial 2 mixture
This is a 2 component mixture that extends the NB2 distribution,
where is the mean of the first (smaller component) of the distribution, is the mean of the larger component, and controls the contribution of each component to the mixture.
Example: family = nbinom2_mix(link = "log")
Gaussian random fields
MatΓ©rn parameterization
The MatΓ©rn defines the covariance between spatial locations and as
where controls the spatial variance, controls the smoothness, represents the Gamma function, represents the distance between locations and , represents the modified Bessel function of the second kind, and represents the decorrelation rate. The parameter is set to 1 to take advantage of the Stochastic Partial Differential Equation (SPDE) approximation to the GRF to greatly increase computational efficiency (Lindgren et al. 2011). Internally, the parameters and are converted to range and marginal standard deviation as and .
In the case of a spatiotemporal model with both spatial and
spatiotemporal fields, if share_range = TRUE
in
sdmTMB()
(the default), then a single
and range are estimated with separate
and
.
This often makes sense since data are often only weakly informative
about
.
If share_range = FALSE
, then separate
and
are estimated. The spatially varying coefficient field always shares
with the spatial random field.
Projection matrix
The values of the spatial variables at the knots are multiplied by a projection matrix that bilinearly interpolates from the knot locations to the values at the locations of the observed or predicted data (Lindgren & Rue 2015)
where represents the values of the spatial random fields at the observed locations or predicted data locations. The matrix has a row for each data point or prediction point and a column for each knot. Three non-zero elements on each row define the weight of the neighbouring 3 knot locations for location . The same bilinear interpolation happens for any spatiotemporal random fields
Anisotropy
TMB allows for anisotropy, where spatial covariance may be asymmetric
with respect to latitude and longitude (full
details). Anisotropy can be turned on or off with the logical
anisotropy
argument to sdmTMB()
. There are a
number of ways to implement anisotropic covariance (Fuglstad et al. 2015), and we adopt a
2-parameter rotation matrix
.
The elements of
are defined by the parameter vector
so that
,
and
.
Once a model is fitted with sdmTMB()
, the anisotropy
relationships may be plotted using the plot_anisotropy()
function, which takes the fitted object as an argument. If a barrier
mesh is used, anisotropy is disabled.
Incorporating physical barriers into the SPDE
In some cases the spatial domain of interest may be complex and
bounded by some barrier such as by land or water (e.g., coastlines,
islands, lakes). SPDE models allow for physical barriers to be
incorporated into the modelling (Bakka et
al. 2019). With sdmTMB()
models, the mesh
construction occurs in two steps: the user (1) constructs a mesh with a
call to sdmTMB::make_mesh()
, and (2) passes the mesh to
sdmTMB::add_barrier_mesh()
. The barriers must be
constructed as sf
objects (Pebesma
2018) with polygons defining the barriers. See
?sdmTMB::add_barrier_mesh
for an example.
The barrier implementation requires the user to select a fraction
value (range_fraction
argument) that defines the fraction
of the usual spatial range when crossing the barrier (Bakka et al. 2019). For example, if
the range was estimated at 10 km, range_fraction = 0.2
would assume that the range was 2 km across the barrier. This would let
the spatial correlation decay 5 times faster with distance. From
experimentation, values around 0.1 or 0.2 seem to work well but values
much lower than 0.1 can result in convergence issues.
This website by Francesco Serafini and Haakon Bakka provides an illustration with INLA. The implementation within TMB was borrowed from code written by Olav Nikolai Breivik and Hans Skaug at the TMB Case Studies Github site.
Optimization
Optimization details
The sdmTMB model is fit by maximum marginal likelihood. Internally, a
TMB (Kristensen et al. 2016)
model template calculates the marginal log likelihood and its gradient,
and the negative log likelihood is minimized via the non-linear
optimization routine stats::nlminb()
in R (Gay 1990; R Core Team 2021). Random effects are
estimated at values that maximize the log likelihood conditional on the
estimated fixed effects and are integrated over via the Laplace
approximation (Kristensen et al.
2016).
Like AD Model Builder (Fournier et
al. 2012), TMB allows for parameters to be fit in phases and
we include the multiphase
argument in
sdmTMB::sdmTMBcontrol()
to allow this. For high-dimensional
models (many fixed and random effects), phased estimation may be faster
and result in more stable convergence. In sdmTMB, phased estimation
proceeds by first estimating all fixed-effect parameters contributing to
the likelihood (holding random effects constant at initial values). In
the second phase, the random-effect parameters (and their variances) are
also estimated. Fixed-effect parameters are also estimated in the second
phase and are initialized at their estimates from the first phase.
In some cases, a single call to stats::nlminb()
may not
be result in convergence (e.g., the maximum gradient of the marginal
likelihood with respect to fixed-effect parameters is not small enough
yet), and the algorithm may need to be run multiple times. In the
sdmTMB::sdmTMBcontrol()
function, we include an argument
nlminb_loops
that will restart the optimization at the
previous best values. The number of nlminb_loops
should
generally be small (e.g., 2 or 3 initially), and defaults to 1. For some
sdmTMB models, the Hessian may also be unstable and need to be
re-evaluated. We do this optionally with the
stats::optimHess()
routine after the call to
stats::nlminb()
. The stats::optimHess()
function implements a Newton optimization routine to find the Hessian,
and we include the argument newton_loops
in
sdmTMB::sdmTMBcontrol()
to allow for multiple function
evaluations (each starting at the previous best value). By default, this
is not included and newton_loops
is set to 0. If a model is
already fit, the function sdmTMB::run_extra_optimization()
can run additional optimization loops with either routine to further
reduce the maximum gradient.
Assessing convergence
Much of the guidance around diagnostics and glmmTMB also applies to
sdmTMB, e.g.Β the
glmmTMB vignette on troubleshooting. Optimization with
stats::nlminb()
involves specifying the number of
iterations and evaluations (eval.max
and
iter.max
) and the tolerances (abs.tol
,
rel.tol
, x.tol
, xf.tol
)βa greater
number of iterations and smaller tolerance thresholds increase the
chance that the optimal solution is found, but more evaluations
translates into longer computation time. Warnings of
non-positive-definite Hessian matrices (accompanied by parameters with
NA
s for standard errors) often mean models are improperly
specified given the data. Standard errors can be observed in the output
of print.sdmTMB()
or by checking
fit$sd_report
. The maximum gradient of the marginal
likelihood with respect to fixed-effect parameters can be checked by
inspecting (fit$gradients
). Guidance varies, but the
maximum gradient should likely be at least
before assuming the fitting routine is consistent with convergence. If
maximum gradients are already relatively small, they can often be
reduced further with additional optimization calls beginning at the
previous best parameter vector as described above with
sdmTMB::run_extra_optimization()
.