The hardware and bandwidth for this mirror is donated by METANET, the Webhosting and Full Service-Cloud Provider.
If you wish to report a bug, or if you are interested in having us mirror your free-software or open-source project, please feel free to contact us at mirror[@]metanet.ch.

Troubleshooting with glmmTMB

2025-10-09

This vignette covers common problems that occur while using glmmTMB. The contents will expand with experience.

If your problem is not covered below, there's a chance it has been solved in the development version; try updating to the latest version of glmmTMB on GitHub.

Warnings

Model convergence problem; non-positive-definite Hessian matrix; NA values for likelihood/AIC/etc.

This warning (Model convergence problem; non-positive-definite Hessian matrix) states that at glmmTMB's maximum-likelihood estimate, the curvature of the negative log-likelihood surface is inconsistent with glmmTMB really having found the best fit (minimum): instead, the surface is downward-curving, or flat, in some direction(s).

It will usually be accompanied by NaN or NA values for the standard errors, log-likelihood, AIC, and BIC, and deviance. Running summary() on the fitted model will produce the warning In sqrt(diag(vcovs)) : NaNs produced.

You can retrieve the log-likelihoods for such poorly fitted models (and use them to compute AIC and BIC in turn); the log-likelihood is intentionally set to NA in the model output to prevent users from inadvertently including poorly fitted models in a model comparison. For a fitted model fit, fit$fit$objective (if the model was fitted with the default nlminb optimizer) will retrieve the negative log-likelihood. Alternatively, fit$obj$fn() will call the underlying TMB objective function with the best-fitted parameters and should retrieve the same value. Blindly using such values can be dangerous; a non-positive-definite Hessian often indicates non-ignorable problems with the model.

These problems are most likely:

How do we diagnose the problem?

Example 1.

Consider this example:

zinbm0 <- glmmTMB(count~spp + (1|site), zi=~spp, Salamanders, family=nbinom2)

First, see if any of the estimated coefficients are extreme. If you're using a non-identity link function (e.g. log, logit), then parameter values with \(|\beta|>10\) are suspect (for a logit link, this implies probabilities very close to 0 or 1; for a log link, this implies mean counts that are close to 0 or extremely large).

Inspecting the fixed-effect estimates for this model:

fixef(zinbm0)
## 
## Conditional model:
## (Intercept)        sppPR        sppDM      sppEC-A      sppEC-L     sppDES-L  
##     -0.5377      -0.6531       0.3303      -0.2001       0.6615       0.7993  
##       sppDF  
##      0.3714  
## 
## Zero-inflation model:
## (Intercept)        sppPR        sppDM      sppEC-A      sppEC-L     sppDES-L  
##     -17.825       17.852       -5.202       17.486       15.431       14.708  
##       sppDF  
##      15.485

The zero-inflation intercept parameter is tiny (\(\approx -18\)): since the parameters are estimated on the logit scale, we back-transform with plogis() to see the at the zero-inflation probability for the baseline level is about 1.5e-08. Most of the other ZI parameters are large and positive, compensating for the intercept: the estimated zero-inflation probabilities for all species are

ff <- fixef(zinbm0)$zi
signif(plogis(c(sppGP=unname(ff[1]),ff[-1]+ff[1])), 2)
##    sppGP    sppPR    sppDM  sppEC-A  sppEC-L sppDES-L    sppDF 
##  1.8e-08  5.1e-01  1.0e-10  4.2e-01  8.4e-02  4.2e-02  8.8e-02

Since the baseline probability is already effectively zero, making the intercept parameter larger or smaller will have very little effect - the likelihood is flat, which leads to the non-positive-definite warning.

Now that we suspect the problem is in the zero-inflation component, we can try to come up with ways of simplifying the model: for example, we could use a model that compared the first species ("GP") to the rest:

Salamanders <- transform(Salamanders, GP=as.numeric(spp=="GP"))
zinbm0_A <- update(zinbm0, ziformula=~GP)

This fits without a warning, although the GP zero-inflation parameter is still extreme:

fixef(zinbm0_A)[["zi"]]
## (Intercept)          GP 
##   -2.890515  -15.414542

Another possibility would be to fit the variation among species in the zero-inflation parameter as a random effect, rather than a fixed effect: this is slightly more parsimonious. This again fits without an error, although both the average level of zero-inflation and the among-species variation are estimated as very small:

zinbm0_B <- update(zinbm0, ziformula=~(1|spp))
fixef(zinbm0_B)[["zi"]]
## (Intercept) 
##   -16.54352
VarCorr(zinbm0_B)
## 
## Conditional model:
##  Groups Name        Std.Dev.
##  site   (Intercept) 1.3894  
## 
## Zero-inflation model:
##  Groups Name        Std.Dev. 
##  spp    (Intercept) 0.0078215

The original analysis considered variation in zero-inflation by site status (mined or not mined) rather than by species - this simpler model only tries to estimate two parameters (mined + difference between mined and no-mining) rather than 7 (one per species) for the zero-inflation model.

zinbm1 <- glmmTMB(count~spp + (1|site), zi=~mined, Salamanders, family=nbinom2)
fixef(zinbm1)[["zi"]]
## (Intercept)     minedno 
##   0.3787986 -17.5118413

This again fits without a warning, but we see that the zero-inflation is effectively zero in the unmined ("minedno") condition (plogis(0.38-17.5)) is approximately \(4\times 10^{-8}\). We can estimate the confidence interval, but it takes some extra work: the default Wald standard errors and confidence intervals are useless in this case.

## at present we need to specify the parameter by number; for
##  extreme cases need to specify the parameter range
## (not sure why the upper bound needs to be so high ... ?)
cc <- confint(zinbm1,method="uniroot",parm=9, parm.range=c(-20,20))
print(cc)
##            2.5 %    97.5 %  Estimate
## zi~minedno    NA -2.083725 -17.51184

The lower CI is not defined; the upper CI is -2.1, i.e. we can state that the zero-inflation probability is less than plogis(-2.08) \(\approx\) 0.11

More broadly, general inspection of the data (e.g., plotting the response against potential covariates) should help to diagnose overly complex models.

Example 2.

In some cases, scaling predictor variables may help. For example, in this example from @phisanti, the results of glm and glmmTMB applied to a scaled version of the data set agree, while glmmTMB applied to the raw data set gives a non-positive-definite Hessian warning. (FIXME: This is no longer true now that we try harder to compute an accurate Hessian ... we need another example ...)

## data taken from gamlss.data:plasma, originally
## http://biostat.mc.vanderbilt.edu/wiki/pub/Main/DataSets/plasma.html
gt_load("vignette_data/plasma.rda")
## [1] "plasma"
m4.1 <- glm(calories ~ fat*fiber, family = Gamma(link = "log"), data = plasma)
m4.2 <- glmmTMB(calories ~ fat*fiber, family = Gamma(link = "log"), data = plasma)
ps  <- transform(plasma,fat=scale(fat,center=FALSE),fiber=scale(fiber,center=FALSE))
m4.3 <- update(m4.2, data=ps)
## scaling factor for back-transforming standard deviations
ss <- c(1,
        fatsc <- 1/attr(ps$fat,"scaled:scale"),
        fibsc <- 1/attr(ps$fiber,"scaled:scale"),
        fatsc*fibsc)
## combine SEs, suppressing the warning from the unscaled model
s_vals <- cbind(glm=sqrt(diag(vcov(m4.1))),
                glmmTMB_unsc=suppressWarnings(sqrt(diag(vcov(m4.2)$cond))),
                glmmTMB_sc=sqrt(diag(vcov(m4.3)$cond))*ss)
print(s_vals,digits=3)
##                  glm glmmTMB_unsc glmmTMB_sc
## (Intercept) 5.11e-02     5.21e-02   5.21e-02
## fat         6.69e-04     6.77e-04   6.77e-04
## fiber       3.70e-03     3.79e-03   3.79e-03
## fat:fiber   4.48e-05     4.54e-05   4.54e-05

Example 3.

Here is another example (from Samantha Sherman):

The first model gives the warning: "non-integer counts in an nbinom1 model" (indicating that we probably should use a different response distribution, or round the values if that seems appropriate).

summary(mod_list$base)
##  Family: nbinom1  ( log )
## Formula:          taeCPUE ~ Avg.Relief + (1 | site.name/reef.name)
## Zero inflation:           ~1
## Data: dd
## 
##       AIC       BIC    logLik -2*log(L)  df.resid 
##        NA        NA        NA        NA      3401 
## 
## Random effects:
## 
## Conditional model:
##  Groups              Name        Variance Std.Dev.
##  reef.name:site.name (Intercept) 0.168    0.4098  
##  site.name           (Intercept) 3.544    1.8825  
## Number of obs: 3407, groups:  reef.name:site.name, 70; site.name, 39
## 
## Dispersion parameter for nbinom1 family (): 5.16e-10 
## 
## Conditional model:
##             Estimate Std. Error z value Pr(>|z|)    
## (Intercept) -4.61485    0.43799 -10.536  < 2e-16 ***
## Avg.Relief   0.16744    0.05898   2.839  0.00453 ** 
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
## 
## Zero-inflation model:
##             Estimate Std. Error z value Pr(>|z|)
## (Intercept)   -20.33      32.11  -0.633    0.527

We can immediately see that the dispersion is very small and that the zero-inflation parameter is strongly negative.

Running diagnostics on the model, these are the only problems reported.

diag_base <- diagnose(mod_list$base)
## Unusually large coefficients (|x|>10):
## 
##   zi~(Intercept) disp~(Intercept) 
##        -20.33129        -21.38486 
## 
## Large negative coefficients in zi (log-odds of zero-inflation),
## dispersion, or random effects (log-standard deviations) suggest
## unnecessary components (converging to zero on the constrained scale);
## large negative and/or positive components in binomial or Poisson
## conditional parameters suggest (quasi-)complete separation. Large
## values of nbinom2 dispersion suggest that you should use a Poisson
## model instead.
## 
## 
## Unusually large Z-statistics (|x|>5):
## 
## (Intercept) 
##   -10.53634 
## 
## Large Z-statistics (estimate/std err) suggest a *possible* failure of
## the Wald approximation - often also associated with parameters that are
## at or near the edge of their range (e.g. random-effects standard
## deviations approaching 0).  (Alternately, they may simply represent
## very well-estimated parameters; intercepts of non-centered models may
## fall in this category.) While the Wald p-values and standard errors
## listed in summary() may be unreliable, profile confidence intervals
## (see ?confint.glmmTMB) and likelihood ratio test p-values derived by
## comparing models (e.g. ?drop1) are probably still OK.  (Note that the
## LRT is conservative when the null value is on the boundary, e.g. a
## variance or zero-inflation value of 0 (Self and Liang 1987; Stram and
## Lee 1994; Goldman and Whelan 2000); in simple cases these p-values are
## approximately twice as large as they should be.)
## 
## 
## Non-positive definite (NPD) Hessian
## 
## The Hessian matrix represents the curvature of the log-likelihood
## surface at the maximum likelihood estimate (MLE) of the parameters (its
## inverse is the estimate of the parameter covariance matrix).  A
## non-positive-definite Hessian means that the likelihood surface is
## approximately flat (or upward-curving) at the MLE, which means the
## model is overfitted or poorly posed in some way. NPD Hessians are often
## associated with extreme parameter estimates.
## 
## 
## parameters with non-finite standard deviations:
## disp~(Intercept)
## 
## 
## 
## recomputing Hessian via Richardson extrapolation. If this is too slow, consider setting check_hessian = FALSE 
## 
## The next set of diagnostics attempts to determine which elements of the
## Hessian are causing the non-positive-definiteness.  Components with
## very small eigenvalues represent 'flat' directions, i.e., combinations
## of parameters for which the data may contain very little information.
## So-called 'bad elements' represent the dominant components (absolute
## values >0.01) of the eigenvectors corresponding to the 'flat'
## directions
## 
## 
## maximum Hessian eigenvalue = 321 
## Hessian eigenvalue 5 = -0.0112 (relative val = -3.5e-05) 
##    bad elements: disp~(Intercept) 
## Hessian eigenvalue 6 = 1.24e-07 (relative val = 3.85e-10) 
##    bad elements: zi~(Intercept) disp~(Intercept)

Let's try dropping the zero-inflation term:

mod_list$nozi <- update(mod_list$base, ziformula=~0)

We also get a "false convergence (8)" warning; see below.

FIXME: this anticipates/duplicates some of the discussion near the end.

The summary() and diagnose() functions reveal only the large, negative dispersion parameter:

summary(mod_list$nozi)
##  Family: nbinom1  ( log )
## Formula:          taeCPUE ~ Avg.Relief + (1 | site.name/reef.name)
## Data: dd
## 
##       AIC       BIC    logLik -2*log(L)  df.resid 
##        NA        NA        NA        NA      3402 
## 
## Random effects:
## 
## Conditional model:
##  Groups              Name        Variance Std.Dev.
##  reef.name:site.name (Intercept) 0.168    0.4099  
##  site.name           (Intercept) 3.544    1.8826  
## Number of obs: 3407, groups:  reef.name:site.name, 70; site.name, 39
## 
## Dispersion parameter for nbinom1 family (): 1.31e-09 
## 
## Conditional model:
##             Estimate Std. Error z value Pr(>|z|)    
## (Intercept) -4.61507    0.43796 -10.538  < 2e-16 ***
## Avg.Relief   0.16745    0.05898   2.839  0.00452 ** 
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1

Diagnose:

diagnose(mod_list$nozi)
## Unusually large coefficients (|x|>10):
## 
## disp~(Intercept) 
##        -20.45202 
## 
## Large negative coefficients in zi (log-odds of zero-inflation),
## dispersion, or random effects (log-standard deviations) suggest
## unnecessary components (converging to zero on the constrained scale);
## large negative and/or positive components in binomial or Poisson
## conditional parameters suggest (quasi-)complete separation. Large
## values of nbinom2 dispersion suggest that you should use a Poisson
## model instead.
## 
## 
## Unusually large Z-statistics (|x|>5):
## 
## (Intercept) 
##   -10.53775 
## 
## Large Z-statistics (estimate/std err) suggest a *possible* failure of
## the Wald approximation - often also associated with parameters that are
## at or near the edge of their range (e.g. random-effects standard
## deviations approaching 0).  (Alternately, they may simply represent
## very well-estimated parameters; intercepts of non-centered models may
## fall in this category.) While the Wald p-values and standard errors
## listed in summary() may be unreliable, profile confidence intervals
## (see ?confint.glmmTMB) and likelihood ratio test p-values derived by
## comparing models (e.g. ?drop1) are probably still OK.  (Note that the
## LRT is conservative when the null value is on the boundary, e.g. a
## variance or zero-inflation value of 0 (Self and Liang 1987; Stram and
## Lee 1994; Goldman and Whelan 2000); in simple cases these p-values are
## approximately twice as large as they should be.)
## 
## 
## Non-positive definite (NPD) Hessian
## 
## The Hessian matrix represents the curvature of the log-likelihood
## surface at the maximum likelihood estimate (MLE) of the parameters (its
## inverse is the estimate of the parameter covariance matrix).  A
## non-positive-definite Hessian means that the likelihood surface is
## approximately flat (or upward-curving) at the MLE, which means the
## model is overfitted or poorly posed in some way. NPD Hessians are often
## associated with extreme parameter estimates.
## 
## 
## parameters with non-finite standard deviations:
## disp~(Intercept)
## 
## 
## 
## recomputing Hessian via Richardson extrapolation. If this is too slow, consider setting check_hessian = FALSE 
## 
## The next set of diagnostics attempts to determine which elements of the
## Hessian are causing the non-positive-definiteness.  Components with
## very small eigenvalues represent 'flat' directions, i.e., combinations
## of parameters for which the data may contain very little information.
## So-called 'bad elements' represent the dominant components (absolute
## values >0.01) of the eigenvectors corresponding to the 'flat'
## directions
## 
## 
## maximum Hessian eigenvalue = 312 
## Hessian eigenvalue 5 = -0.00924 (relative val = -2.96e-05) 
##    bad elements: disp~(Intercept)

The "false convergence" warning comes from the nlminb() optimizer, and is difficult to interpret and resolve. The documentation says that the cause of this warning is that:

the gradient ∇f(x) may be computed incorrectly, the other stopping tolerances may be too tight, or either f or ∇f may be discontinuous near the current iterate x.

The only practical options we have for satisfying ourselves that a false convergence warning is really a false positive are the standard brute-force solutions of (1) making sure the gradients are small and the Hessian is positive definite (these are already checked internally); (2) trying different starting conditions, including re-starting at the current optimum; and (3) trying a different optimizer. We'll try option 3 and refit with the BFGS option from optim():

mod_list$nozi_optim <- update(mod_list$nozi,
                              control=glmmTMBControl(optimizer=optim,
                                                     optArgs=list(method="BFGS")))

BFGS doesn't give us any warnings. Comparing the parameter estimates:

(parcomp <- cbind(nlminb=unlist(fixef(mod_list$nozi)),
                  optim=unlist(fixef(mod_list$nozi_optim))))
##                       nlminb       optim
## cond.(Intercept)  -4.6150732  -4.6152081
## cond.Avg.Relief    0.1674507   0.1674755
## disp.(Intercept) -20.4520188 -11.4800821

The conditional-model parameters are practically identical. The dispersion parameters look quite different (-20.5 vs. -11.5), but if we back-transform from the log scale (via exp()) we can see that they are both extremely small (\(1.31\times 10^{-9}\) vs. \(1.03\times 10^{-5}\)).

Simplify the model by switching from NB1 to Poisson:

mod_list$pois <- update(mod2, family=poisson)
summary(mod_list$pois)
##  Family: poisson  ( log )
## Formula:          taeCPUE ~ Avg.Relief + (1 | site.name/reef.name)
## Data: dd
## 
##       AIC       BIC    logLik -2*log(L)  df.resid 
##    1562.5    1587.0    -777.2    1554.5      3403 
## 
## Random effects:
## 
## Conditional model:
##  Groups              Name        Variance Std.Dev.
##  reef.name:site.name (Intercept) 0.168    0.4099  
##  site.name           (Intercept) 3.544    1.8826  
## Number of obs: 3407, groups:  reef.name:site.name, 70; site.name, 39
## 
## Conditional model:
##             Estimate Std. Error z value Pr(>|z|)    
## (Intercept) -4.61507    0.43804 -10.536  < 2e-16 ***
## Avg.Relief   0.16745    0.05898   2.839  0.00452 ** 
## ---
## Signif. codes:  0 '***' 0.001 '**' 0.01 '*' 0.05 '.' 0.1 ' ' 1
diagnose(mod_list$pois)
## Unusually large Z-statistics (|x|>5):
## 
## (Intercept) 
##   -10.53575 
## 
## Large Z-statistics (estimate/std err) suggest a *possible* failure of
## the Wald approximation - often also associated with parameters that are
## at or near the edge of their range (e.g. random-effects standard
## deviations approaching 0).  (Alternately, they may simply represent
## very well-estimated parameters; intercepts of non-centered models may
## fall in this category.) While the Wald p-values and standard errors
## listed in summary() may be unreliable, profile confidence intervals
## (see ?confint.glmmTMB) and likelihood ratio test p-values derived by
## comparing models (e.g. ?drop1) are probably still OK.  (Note that the
## LRT is conservative when the null value is on the boundary, e.g. a
## variance or zero-inflation value of 0 (Self and Liang 1987; Stram and
## Lee 1994; Goldman and Whelan 2000); in simple cases these p-values are
## approximately twice as large as they should be.)

You can also check directly whether the Hessian (curvature) of the model is OK by examining the pdHess ("positive-definite Hessian") component of the sdr ("standard deviation report") component of the model:

mod_list$pois$sdr$pdHess                          

In general models with non-positive definite Hessian matrices should be excluded from further consideration.

Model convergence problem: eigenvalue problems

m1 <- glmmTMB(count~spp + mined + (1|site), zi=~spp + mined, Salamanders, family=genpois)
diagnose(m1)
## Unusually large coefficients (|x|>10):
## 
##   zi~sppPR   zi~sppDF zi~minedno 
##  -35.20726  -24.18081  -20.16418 
## 
## Large negative coefficients in zi (log-odds of zero-inflation),
## dispersion, or random effects (log-standard deviations) suggest
## unnecessary components (converging to zero on the constrained scale);
## large negative and/or positive components in binomial or Poisson
## conditional parameters suggest (quasi-)complete separation. Large
## values of nbinom2 dispersion suggest that you should use a Poisson
## model instead.

In this example, the fixed-effect covariance matrix is NaN. It may have to do with the generalized Poisson (genpois) distribution, which is known to have convergence problems; luckily, the negative binomial (nbinom1 and nbinom2) and/or Conway-Maxwell Poisson (compois) are good alternatives.

Models with convergence problems should be excluded from further consideration, in general.

In some cases, extreme eigenvalues may be caused by having predictor variables that are on very different scales: try rescaling, and centering, continuous predictors in the model.

NA/NaN function evaluation

Warning in nlminb(start = par, objective = fn, gradient = gr) : NA/NaN function evaluation

This warning occurs when the optimizer visits a region of parameter space that is invalid. It is not a problem as long as the optimizer has left that region of parameter space upon convergence, which is indicated by an absence of the model convergence warnings described above.

The following warnings indicate possibly-transient numerical problems with the fit, and can be treated in the same way (i.e. ignored if there are no errors or convergence warnings about the final fitted model).

Cholmod warning 'matrix not positive definite'

In older versions of R (< 3.6.0):

Warning in f(par, order = order, ...) : value out of range in 'lgamma'

false convergence

This warning:

false convergence: the gradient ∇f(x) may be computed incorrectly, the other stopping tolerances may be too tight, or either f or ∇f may be discontinuous near the current iterate x

comes from the nlminb optimizer used by default in glmmTMB. It's usually hard to diagnose the source of this warning (this Stack Overflow answer explains a bit more about what it means). Reasonable methods for making sure your model is OK are:

and see if the results are sufficiently similar to the original fit.

Errors

NA/NaN gradient evaluation

dat1 = expand.grid(y=-1:1, rep=1:10)
m1 = glmmTMB(y~1, dat1, family=nbinom2)
## Error in eval(family$initialize): negative values not allowed for the negative binomial family

FIXME: this is no longer a "gradient evaluation" error ...

The error occurs here because the negative binomial distribution is inappropriate for data with negative values.

If you see this error, check that the response variable meets the assumptions of the specified distribution.

gradient length

Error in nlminb(start = par, objective = fn, gradient = gr) : gradient function must return a numeric vector of length x

Error in optimHess(par.fixed, obj$fn, obj$gr): gradient in optim evaluated to length x

Try rescaling predictor variables. Try a simpler model and build up. (If you have a simple reproducible example of these errors, please post them to the issues list.)

These binaries (installable software) and packages are in development.
They may not be fully stable and should be used with caution. We make no claims about them.