Title: | Zero-Inflated Endemic-Epidemic Count Time Series |
---|---|
Description: | Extending 'surveillance::hhh4()' for zero-inflated infectious disease counts as described in Lu and Meyer (2023) <doi:10.1002/bimj.202100408>. This package is a partial fork of 'surveillance' and intended as a proof of concept for this model extension. It will be merged with other extensions in the future. |
Authors: | Junyi Lu [aut], Sebastian Meyer [cre, ctb, cph, ths], Michaela Paul [cph], R Core Team [cph] (A few code segments are modified versions of code from base R) |
Maintainer: | Sebastian Meyer <[email protected]> |
License: | GPL-2 |
Version: | 0.3.2 |
Built: | 2025-03-07 05:04:54 UTC |
Source: | https://github.com/Junyi-L/hhh4ZI |
Coverage levels at school entry for the first and second dose of the combined measles-mumps-rubella (MMR) vaccine for the years 2005 to 2018, estimated from children presenting vaccination documents at school entry examinations.
TotalKids VacPass Dosis1 Dosis2
TotalKids VacPass Dosis1 Dosis2
Four data frames, each with 14 rows (years) and 16 columns (states):
TotalKids Number of children examined.
VacPass Number of children who presented vaccination documents.
Dosis1 Percentage of children with vaccination documents, who received at least 1 dose of MMR vaccine.
Dosis2 Percentage of children with vaccination documents, who received at least 2 doses of MMR vaccine.
Coverage levels were derived from vaccination documents presented at medical examinations, which are conducted by local health authorities at school entry each year. Records include information about the receipt of 1st and 2nd doses of MMR, from year 2005 to 2018. Note that information from children who did not present a vaccination document on the day of the medical examination, is not included in the estimated coverage.
https://www.gbe-bund.de, Gesundheitsbericherstattung des Bundes; Queried on 23 February 2021.
Fits a zero-inflated autoregressive negative binomial (hhh4
) model
to a univariate or multivariate time series of counts.
The characteristic feature of hhh4
models is the additive
decomposition of the conditional mean into epidemic and
endemic components (Held et al, 2005).
The inflated parameter is a logit-linear predictor and can have autoregressive terms.
hhh4ZI( stsObj, control = list(ar = list(f = ~-1, offset = 1, lag = 1), ne = list(f = ~-1, offset = 1, lag = 1, weights = neighbourhood(stsObj) == 1, scale = NULL, normalize = FALSE), end = list(f = ~1, offset = 1), zi = list(f = ~1, lag = 1, lag.unitSpecific = FALSE), family = c("NegBin1", "NegBinM"), subset = 2:nrow(stsObj), optimizer = list(stop = list(tol = 1e-05, niter = 100), regression = list(method = "nlminb"), variance = list(method = "Nelder-Mead")), verbose = FALSE, start = list(fixed = NULL, random = NULL, sd.corr = NULL), data = list(t = stsObj@epoch - min(stsObj@epoch)), keep.terms = FALSE), check.analyticals = FALSE )
hhh4ZI( stsObj, control = list(ar = list(f = ~-1, offset = 1, lag = 1), ne = list(f = ~-1, offset = 1, lag = 1, weights = neighbourhood(stsObj) == 1, scale = NULL, normalize = FALSE), end = list(f = ~1, offset = 1), zi = list(f = ~1, lag = 1, lag.unitSpecific = FALSE), family = c("NegBin1", "NegBinM"), subset = 2:nrow(stsObj), optimizer = list(stop = list(tol = 1e-05, niter = 100), regression = list(method = "nlminb"), variance = list(method = "Nelder-Mead")), verbose = FALSE, start = list(fixed = NULL, random = NULL, sd.corr = NULL), data = list(t = stsObj@epoch - min(stsObj@epoch)), keep.terms = FALSE), check.analyticals = FALSE )
stsObj |
object of class |
control |
a list containing the model specification and control arguments,
the parts relating to
|
check.analyticals |
logical (or a subset of
|
hhh4ZI
returns an object of class "hhh4ZI"
,
which inherits from class "hhh4"
, and
is a list containing the following components:
coefficients named vector with estimated (regression) parameters of the model
se estimated standard errors (for regression parameters)
cov covariance matrix (for regression parameters)
Sigma estimated variance-covariance matrix of random effects
Sigma.orig estimated variance parameters on internal scale used for optimization
call the matched call
dim vector with number of fixed and random effects in the model
loglikelihood (penalized) loglikelihood evaluated at the MLE
margll (approximate) log marginal likelihood should the model contain random effects
convergence logical. Did optimizer converge?
mu The fitted mean values in hhh4 model part
fitted.values fitted mean values in zero-inflated model
gamma fitted zero inflation parameter
control control object of the fit
terms the terms object used in the fit if keep.terms = TRUE
and NULL
otherwise
stsObj the supplied stsObj
lags named integer vector of length three containing the lags
used for the epidemic components "ar"
, "ne"
and "zi"
respectively. The corresponding lag is NA
if the component
was not included in the model.
nObs number of observations used for fitting the model
nTime number of time points used for fitting the model
nUnit number of units (e.g. areas) used for fitting the model
runtime the proc.time
-queried time taken
to fit the model, i.e., a named numeric vector of length 5 of class
"proc_time"
neW1 <- neighbourhood(measles) == 1 fit <- hhh4ZI(measles, control = list( ar = list(f = ~1), ne = list(f = ~1, weights = neW1, normalize = TRUE), end = list(f = ~1), zi = list(f = ~1), family = "NegBin1", verbose = TRUE, keep.terms = TRUE ) ) summary(fit) sim_data <- simulate(fit, simplify = FALSE)
neW1 <- neighbourhood(measles) == 1 fit <- hhh4ZI(measles, control = list( ar = list(f = ~1), ne = list(f = ~1, weights = neW1, normalize = TRUE), end = list(f = ~1), zi = list(f = ~1), family = "NegBin1", verbose = TRUE, keep.terms = TRUE ) ) summary(fit) sim_data <- simulate(fit, simplify = FALSE)
Bi-weekly number of measles cases in the 16 states (Bundeslaender) of Germany for the years 2005 to 2018.
measles
measles
An object of class sts
with 364 rows and 16 columns.
The population
slot contains the population fractions
of each state from 2005 to 2018, obtained from the Federal Statistical Office of Germany.
SurvStat@RKI 2.0 (https://survstat.rki.de), Robert Koch Institute; Queried on 26 March 2021.
Statistisches Bundesamt (https://www.destatis.de/DE/Home/_inhalt.html); Queried on 10 April 2021.
Computes successive one-step-ahead predictions from a model fit.
There is a method for hhh4
models from surveillance
(see the documentation of oneStepAhead
there)
and a derived method for ZI-extended models fitted from hhh4ZI
.
The documentation of the arguments is inherited from the former;
where "hhh4"
is mentioned, "hhh4ZI"
works interchangeably.
Predictions can be inspected using quantile
,
confint
and plot
methods.
oneStepAhead(result, tp, ...) ## S3 method for class 'hhh4' oneStepAhead( result, tp, type = c("rolling", "first", "final"), which.start = c("current", "final"), keep.estimates = FALSE, verbose = type != "final", cores = 1, ... ) ## S3 method for class 'hhh4ZI' oneStepAhead( result, tp, type = c("rolling", "first", "final"), which.start = c("current", "final"), keep.estimates = FALSE, verbose = TRUE, cores = 1, ... ) ## S3 method for class 'oneStepAhead_hhh4ZI' quantile(x, probs = c(2.5, 10, 50, 90, 97.5)/100, ...) ## S3 method for class 'oneStepAhead_hhh4ZI' confint(object, parm, level = 0.95, ...) ## S3 method for class 'oneStepAhead_hhh4ZI' plot(x, unit = 1, probs = 1:99/100, start = NULL, ...)
oneStepAhead(result, tp, ...) ## S3 method for class 'hhh4' oneStepAhead( result, tp, type = c("rolling", "first", "final"), which.start = c("current", "final"), keep.estimates = FALSE, verbose = type != "final", cores = 1, ... ) ## S3 method for class 'hhh4ZI' oneStepAhead( result, tp, type = c("rolling", "first", "final"), which.start = c("current", "final"), keep.estimates = FALSE, verbose = TRUE, cores = 1, ... ) ## S3 method for class 'oneStepAhead_hhh4ZI' quantile(x, probs = c(2.5, 10, 50, 90, 97.5)/100, ...) ## S3 method for class 'oneStepAhead_hhh4ZI' confint(object, parm, level = 0.95, ...) ## S3 method for class 'oneStepAhead_hhh4ZI' plot(x, unit = 1, probs = 1:99/100, start = NULL, ...)
result |
fitted |
tp |
numeric vector of length 2 specifying the time range in
which to compute one-step-ahead predictions (for the time points
|
... |
unused (argument of the generic). |
type |
The default |
which.start |
Which initial parameter values should be used when successively
refitting the model to subsets of the data (up to time point
|
keep.estimates |
logical indicating if parameter estimates and log-likelihoods from the successive fits should be returned. |
verbose |
non-negative integer (usually in the range |
cores |
the number of cores to use when computing
the predictions for the set of time points |
x |
an object of class |
probs |
numeric vector of probabilities with values in [0,1]. |
object |
an object of class |
parm |
unused (argument of the generic). |
level |
required confidence level of the prediction interval. |
unit |
single integer or character selecting a unit for which to produce the plot. |
start |
x-coordinate of the first prediction. If |
Non-Randomized Version of the PIT Histogram (for Count Data)
## S3 method for class 'oneStepAhead_hhh4ZI' pit(x, units = NULL, ...) ## S3 method for class 'hhh4ZI' pit(x, subset = x$control$subset, units = seq_len(x$nUnit), ...)
## S3 method for class 'oneStepAhead_hhh4ZI' pit(x, units = NULL, ...) ## S3 method for class 'hhh4ZI' pit(x, subset = x$control$subset, units = seq_len(x$nUnit), ...)
x |
an object of class |
units |
integer or character vector indexing the units for which to compute the PIT histogram. By default, all units are considered. |
... |
further arguments passed to |
subset |
subset of time points for which to produce the PIT histogram. Defaults to the subset used for fitting the model. |
hhh4ZI
ModelsForks of plot.hhh4
et al. to support
zero-inflated models fitted with hhh4ZI
.
## S3 method for class 'hhh4ZI' plot(x, type = c("fitted", "maxEV", "season", "maps", "ri", "neweights"), ...) plotHHH4ZI_fitted( x, units = 1, names = NULL, col = c("grey85", "blue", "orange"), pch = 19, pt.cex = 0.6, pt.col = 1, par.settings = list(), legend = TRUE, legend.args = list(), legend.observed = FALSE, decompose = NULL, total = FALSE, meanHHH = NULL, ... ) plotHHH4ZI_fitted1( x, unit = 1, main = NULL, col = c("grey85", "blue", "orange"), pch = 19, pt.cex = 0.6, pt.col = 1, border = col, start = x$stsObj@start, end = NULL, xaxis = NULL, xlim = NULL, ylim = NULL, xlab = "", ylab = "No. infected", hide0s = FALSE, decompose = NULL, total = FALSE, meanHHH = NULL ) plotHHH4ZI_maps( x, which = c("mean", "endemic", "epi.own", "epi.neighbours", "zi"), prop = FALSE, main = which, zmax = NULL, col.regions = NULL, labels = FALSE, sp.layout = NULL, ..., map = x$stsObj@map, meanHHH = NULL ) plotHHH4ZI_maxEV( ..., matplot.args = list(), refline.args = list(), legend.args = list() ) plotHHH4ZI_ri( x, component, exp = FALSE, at = list(n = 10), col.regions = cm.colors(100), colorkey = TRUE, labels = FALSE, sp.layout = NULL, gpar.missing = list(col = "darkgrey", lty = 2, lwd = 2), ... ) plotHHH4ZI_season( ..., components = NULL, intercept = FALSE, xlim = NULL, ylim = NULL, xlab = NULL, ylab = "", main = NULL, par.settings = list(), matplot.args = list(), legend = NULL, legend.args = list(), refline.args = list(), unit = 1, period = NULL ) plotHHH4ZI_neweights(x, plotter = boxplot, ..., exclude = 0, maxlag = Inf)
## S3 method for class 'hhh4ZI' plot(x, type = c("fitted", "maxEV", "season", "maps", "ri", "neweights"), ...) plotHHH4ZI_fitted( x, units = 1, names = NULL, col = c("grey85", "blue", "orange"), pch = 19, pt.cex = 0.6, pt.col = 1, par.settings = list(), legend = TRUE, legend.args = list(), legend.observed = FALSE, decompose = NULL, total = FALSE, meanHHH = NULL, ... ) plotHHH4ZI_fitted1( x, unit = 1, main = NULL, col = c("grey85", "blue", "orange"), pch = 19, pt.cex = 0.6, pt.col = 1, border = col, start = x$stsObj@start, end = NULL, xaxis = NULL, xlim = NULL, ylim = NULL, xlab = "", ylab = "No. infected", hide0s = FALSE, decompose = NULL, total = FALSE, meanHHH = NULL ) plotHHH4ZI_maps( x, which = c("mean", "endemic", "epi.own", "epi.neighbours", "zi"), prop = FALSE, main = which, zmax = NULL, col.regions = NULL, labels = FALSE, sp.layout = NULL, ..., map = x$stsObj@map, meanHHH = NULL ) plotHHH4ZI_maxEV( ..., matplot.args = list(), refline.args = list(), legend.args = list() ) plotHHH4ZI_ri( x, component, exp = FALSE, at = list(n = 10), col.regions = cm.colors(100), colorkey = TRUE, labels = FALSE, sp.layout = NULL, gpar.missing = list(col = "darkgrey", lty = 2, lwd = 2), ... ) plotHHH4ZI_season( ..., components = NULL, intercept = FALSE, xlim = NULL, ylim = NULL, xlab = NULL, ylab = "", main = NULL, par.settings = list(), matplot.args = list(), legend = NULL, legend.args = list(), refline.args = list(), unit = 1, period = NULL ) plotHHH4ZI_neweights(x, plotter = boxplot, ..., exclude = 0, maxlag = Inf)
x |
a fitted |
type |
type of plot: either |
... |
For |
units , unit
|
integer or character vector specifying a single
|
names , main
|
main title(s) for the selected
|
col , border
|
length 3 vectors specifying the fill and border colors for the endemic, autoregressive, and spatio-temporal component polygons (in this order). |
pch , pt.cex , pt.col
|
style specifications for the dots drawn to represent
the observed counts. |
par.settings |
list of graphical parameters for
|
legend |
Integer vector specifying in which of the
|
legend.args |
list of arguments for |
legend.observed |
logical indicating if the legend should contain a line for the dots corresponding to observed counts. |
decompose |
if |
total |
logical indicating if the fitted components should be
summed over all units to be compared with the total observed
counts at each time point. If |
meanHHH |
(internal) use different component means than those
estimated and available from |
start , end
|
time range to plot specified by vectors of length two
in the form |
xaxis |
if this is a list (of arguments for
|
xlim |
numeric vector of length 2 specifying the x-axis range.
The default ( |
ylim |
y-axis range.
For |
xlab , ylab
|
axis labels. For |
hide0s |
logical indicating if dots for zero observed counts should be omitted. Especially useful if there are too many. |
which |
a character vector specifying the components of the mean for which to produce maps. By default, the overall mean and all three components are shown. |
prop |
a logical indicating whether the component maps should display proportions of the total mean instead of absolute numbers. |
zmax |
a numeric vector of length |
col.regions |
a vector of colors used to encode the fitted
component means (see |
labels |
determines if and how regions are labeled, see
|
sp.layout |
optional list of additional layout items, see
|
map |
an object inheriting from |
matplot.args |
list of line style specifications passed to
|
refline.args |
list of line style specifications (e.g.,
|
component |
component for which to plot the estimated
region-specific random intercepts. Must partially match one of
|
exp |
logical indicating whether to |
at |
a numeric vector of breaks for the color levels (see
|
colorkey |
a Boolean indicating whether to draw the color key.
Alternatively, a list specifying how to draw it, see
|
gpar.missing |
list of graphical parameters for
|
components |
character vector of component names, i.e., a subset
of |
intercept |
logical indicating whether to include the global
intercept. For |
period |
a numeric value giving the (longest) period of the
harmonic terms in the model. This usually coincides with the
|
plotter |
the (name of a) function used to produce the plot of
weights (a numeric vector) as a function of neighbourhood order (a
factor variable). It is called as
|
exclude |
vector of neighbourhood orders to be excluded from
plotting (passed to |
maxlag |
maximum order of neighbourhood to be assumed when
computing the |
hhh4ZI
ModelsThe following scores are implemented:
logarithmic score (logs), ranked probability score (rps),
Dawid-Sebastiani score (dss), squared error score (ses).
These are extended versions of the corresponding frunctions in surveillance
to handle zero-inflated negative binomial predictions,
which use an additional zero inflation parameter gamma
.
## S3 method for class 'oneStepAhead_hhh4ZI' scores( x, which = c("logs", "rps", "dss", "ses"), units = NULL, sign = FALSE, individual = FALSE, ... ) ## S3 method for class 'hhh4ZI' scores( x, which = c("logs", "rps", "dss", "ses"), subset = x$control$subset, units = seq_len(x$nUnit), sign = FALSE, ... )
## S3 method for class 'oneStepAhead_hhh4ZI' scores( x, which = c("logs", "rps", "dss", "ses"), units = NULL, sign = FALSE, individual = FALSE, ... ) ## S3 method for class 'hhh4ZI' scores( x, which = c("logs", "rps", "dss", "ses"), subset = x$control$subset, units = seq_len(x$nUnit), sign = FALSE, ... )
x |
an object of class |
which |
character vector determining which scores to compute.
The package surveillance implements the following proper
scoring rules: logarithmic score ( |
units |
integer or character vector indexing the units for which to compute the scores. By default, all units are considered. |
sign |
logical indicating if the function should also return
|
individual |
logical indicating if the individual scores of the
|
... |
unused (argument of the generic). |
subset |
subset of time points for which to compute the scores. |
hhh4ZI
Count Time SeriesFork of simulate.hhh4
to support
zero-inflated models fitted with hhh4ZI
.
## S3 method for class 'hhh4ZI' simulate( object, nsim = 1, seed = NULL, y.start = NULL, subset = 1:nrow(object$stsObj), coefs = coef(object), components = c("ar", "ne", "end"), simplify = nsim > 1, ... )
## S3 method for class 'hhh4ZI' simulate( object, nsim = 1, seed = NULL, y.start = NULL, subset = 1:nrow(object$stsObj), coefs = coef(object), components = c("ar", "ne", "end"), simplify = nsim > 1, ... )
object |
of class |
nsim |
number of time series to simulate. Defaults to |
seed |
an object specifying how the random number generator should be
initialized for simulation (via |
y.start |
vector or matrix (with |
subset |
time period in which to simulate data. Defaults to (and cannot
exceed) the whole period defined by the underlying |
coefs |
coefficients used for simulation from the model in |
components |
character vector indicating which components of the fitted model
|
simplify |
logical indicating if only the simulated counts ( |
... |
unused (argument of the generic). |
hhh4ZI
ModelRe-fit a hhh4ZI
model with a modified control list,
equivalently to update.hhh4
.
## S3 method for class 'hhh4ZI' update( object, ..., S = NULL, subset.upper = NULL, use.estimates = object$convergence, evaluate = TRUE )
## S3 method for class 'hhh4ZI' update( object, ..., S = NULL, subset.upper = NULL, use.estimates = object$convergence, evaluate = TRUE )
object |
a fitted |
... |
elements modifying the original control list. |
S |
a named list of numeric vectors (with names |
subset.upper |
refit on a subset of the data up to that time point
(used by |
use.estimates |
logical indicating if |
evaluate |
logical indicating if the updated |
Refits a previous hhh4
fit with a ZI component
using hhh4ZI
.
## S3 method for class 'hhh4' upgrade(object, control = list(f = ~1, lag = 1, lag.unitSpecific = FALSE), ...)
## S3 method for class 'hhh4' upgrade(object, control = list(f = ~1, lag = 1, lag.unitSpecific = FALSE), ...)
object |
a |
control |
either a list of specifications for the |
... |
further (non- |