nma {multinma} | R Documentation |
Network meta-analysis models
Description
The nma
function fits network meta-analysis and (multilevel) network
meta-regression models in Stan.
Usage
nma(
network,
consistency = c("consistency", "ume", "nodesplit"),
trt_effects = c("fixed", "random"),
regression = NULL,
class_interactions = c("common", "exchangeable", "independent"),
likelihood = NULL,
link = NULL,
...,
nodesplit = get_nodesplits(network, include_consistency = TRUE),
prior_intercept = .default(normal(scale = 100)),
prior_trt = .default(normal(scale = 10)),
prior_het = .default(half_normal(scale = 5)),
prior_het_type = c("sd", "var", "prec"),
prior_reg = .default(normal(scale = 10)),
prior_aux = .default(),
prior_aux_reg = .default(),
aux_by = NULL,
aux_regression = NULL,
QR = FALSE,
center = TRUE,
adapt_delta = NULL,
int_thin = 0,
int_check = TRUE,
mspline_degree = 3,
n_knots = 7,
knots = NULL,
mspline_basis = NULL
)
Arguments
network |
An |
consistency |
Character string specifying the type of (in)consistency
model to fit, either |
trt_effects |
Character string specifying either |
regression |
A one-sided model formula, specifying the prognostic and
effect-modifying terms for a regression model. Any references to treatment
should use the |
class_interactions |
Character string specifying whether effect modifier
interactions are specified as |
likelihood |
Character string specifying a likelihood, if unspecified will be inferred from the data (see details) |
link |
Character string specifying a link function, if unspecified will default to the canonical link (see details) |
... |
Further arguments passed to
|
nodesplit |
For |
prior_intercept |
Specification of prior distribution for the intercept |
prior_trt |
Specification of prior distribution for the treatment effects |
prior_het |
Specification of prior distribution for the heterogeneity
(if |
prior_het_type |
Character string specifying whether the prior
distribution |
prior_reg |
Specification of prior distribution for the regression
coefficients (if |
prior_aux |
Specification of prior distribution for the auxiliary
parameter, if applicable (see details). For |
prior_aux_reg |
Specification of prior distribution for the auxiliary
regression parameters, if |
aux_by |
Vector of variable names listing the variables to stratify the
auxiliary parameters by. Currently only used for survival models, see
details. Cannot be used with |
aux_regression |
A one-sided model formula giving a regression model for
the auxiliary parameters. Currently only used for survival models, see
details. Cannot be used with |
QR |
Logical scalar (default |
center |
Logical scalar (default |
adapt_delta |
See adapt_delta for details |
int_thin |
A single integer value, the thinning factor for returning
cumulative estimates of integration error. Saving cumulative estimates is
disabled by |
int_check |
Logical, check sufficient accuracy of numerical integration
by fitting half of the chains with |
mspline_degree |
Non-negative integer giving the degree of the M-spline
polynomial for |
n_knots |
For |
knots |
For |
mspline_basis |
Instead of specifying |
Details
When specifying a model formula in the regression
argument, the
usual formula syntax is available (as interpreted by model.matrix()
). The
only additional requirement here is that the special variable .trt
should
be used to refer to treatment. For example, effect modifier interactions
should be specified as variable:.trt
. Prognostic (main) effects and
interactions can be included together compactly as variable*.trt
, which
expands to variable + variable:.trt
(plus .trt
, which is already in the
NMA model).
For the advanced user, the additional specials .study
and .trtclass
are
also available, and refer to studies and (if specified) treatment classes
respectively. When node-splitting models are fitted (consistency = "nodesplit"
) the special .omega
is available, indicating the arms
to which the node-splitting inconsistency factor is added.
See ?priors
for details on prior
specification. Default prior distributions are available, but may not be
appropriate for the particular setting and will raise a warning if used. No
attempt is made to tailor these defaults to the data provided. Please
consider appropriate prior distributions for the particular setting,
accounting for the scales of outcomes and covariates, etc. The function
plot_prior_posterior()
may be useful in examining the influence of the
chosen prior distributions on the posterior distributions, and the
summary()
method for nma_prior
objects prints prior intervals.
Value
nma()
returns a stan_nma object, except when consistency = "nodesplit"
when a nma_nodesplit or nma_nodesplit_df object is
returned. nma.fit()
returns a stanfit object.
Likelihoods and link functions
Currently, the following likelihoods and link functions are supported for each data type:
Data type | Likelihood | Link function |
Binary | bernoulli , bernoulli2 | logit , probit , cloglog |
Count | binomial , binomial2 | logit , probit , cloglog |
Rate | poisson | log |
Continuous | normal | identity , log |
Ordered | ordered | logit , probit , cloglog |
Survival | exponential , weibull , gompertz , exponential-aft , weibull-aft , lognormal , loglogistic , gamma , gengamma , mspline , pexp | log |
The bernoulli2
and binomial2
likelihoods correspond to a two-parameter
Binomial likelihood for arm-based AgD, which more closely matches the
underlying Poisson Binomial distribution for the summarised aggregate
outcomes in a ML-NMR model than the typical (one parameter) Binomial
distribution (see Phillippo et al. 2020).
When a cloglog
link is used, including an offset for log follow-up time
(i.e. regression = ~offset(log(time))
) results in a model on the log
hazard (see Dias et al. 2011).
For survival data, all accelerated failure time models (exponential-aft
,
weibull-aft
, lognormal
, loglogistic
, gamma
, gengamma
) are
parameterised so that the treatment effects and any regression parameters
are log Survival Time Ratios (i.e. a coefficient of \log(2)
means
that the treatment or covariate is associated with a doubling of expected
survival time). These can be converted to log Acceleration Factors using
the relation \log(\mathrm{AF}) = -\log(\mathrm{STR})
(or equivalently
\mathrm{AF} = 1/\mathrm{STR}
).
Further details on each likelihood and link function are given by Dias et al. (2011).
Auxiliary parameters
Auxiliary parameters are only present in the following models.
Normal likelihood with IPD
When a Normal likelihood is fitted to IPD, the auxiliary parameters are the
arm-level standard deviations \sigma_{jk}
on treatment k
in
study j
.
Ordered multinomial likelihood
When fitting a model to M
ordered outcomes, the auxiliary parameters
are the latent cutoffs between each category, c_0 < c_1 < \dots <
c_M
. Only c_2
to c_{M-1}
are estimated; we fix c_0 =
-\infty
, c_1 = 0
, and c_M = \infty
. When specifying priors for
these latent cutoffs, we choose to specify priors on the differences
c_{m+1} - c_m
. Stan automatically truncates any priors so that the
ordering constraints are satisfied.
Survival (time-to-event) likelihoods
All survival likelihoods except the exponential
and exponential-aft
likelihoods have auxiliary parameters. These are typically study-specific
shape parameters \gamma_j>0
, except for the lognormal
likelihood
where the auxiliary parameters are study-specific standard deviations on
the log scale \sigma_j>0
.
The gengamma
likelihood has two sets of auxiliary parameters,
study-specific scale parameters \sigma_j>0
and shape parameters
k_j
, following the parameterisation of
Lawless (1980), which permits a range of
behaviours for the baseline hazard including increasing, decreasing,
bathtub and arc-shaped hazards. This parameterisation is related to that
discussed by Cox et al. (2007) and implemented in the
flexsurv
package with Q = k^{-0.5}
. The parameterisation used here
effectively bounds the shape parameter k
away from numerical
instabilities as k \rightarrow \infty
(i.e. away from Q
\rightarrow 0
, the log-Normal distribution) via the prior distribution.
Implicitly, this parameterisation is restricted to Q > 0
and so
certain survival distributions like the inverse-Gamma and inverse-Weibull
are not part of the parameter space; however, Q > 0
still encompasses
the other survival distributions implemented in this package.
For the mspline
and pexp
likelihoods, the auxiliary parameters are the
spline coefficients for each study. These form a unit simplex (i.e. lie
between 0 and 1, and sum to 1), and are given a random walk prior
distribution. prior_aux
specifies the hyperprior on the random walk
standard deviation \sigma
which controls the level of smoothing of
the baseline hazard, with \sigma = 0
corresponding to a constant
baseline hazard.
The auxiliary parameters can be stratified by additional factors through
the aux_by
argument. For example, to allow the shape of the baseline
hazard to vary between treatment arms as well as studies, use aux_by = c(".study", ".trt")
. (Technically, .study
is always included in the
stratification even if omitted from aux_by
, but we choose here to make
the stratification explicit.) This is a common way of relaxing the
proportional hazards assumption. The default is equivalent to aux_by = ".study"
which stratifies the auxiliary parameters by study, as described
above.
A regression model may be specified on the auxiliary parameters using
aux_regression
. This is useful if we wish to model departures from
non-proportionality, rather than allowing the baseline hazards to be
completely independent using aux_by
. This is necessary if absolute
predictions (e.g. survival curves) are required in a population for
unobserved combinations of covariates; for example, if aux_by = .trt
then
absolute predictions may only be produced for the observed treatment arms
in each study population, whereas if aux_regression = ~.trt
then absolute
predictions can be produced for all treatments in any population. For
mspline
and pexp
likelihoods, the regression coefficients are smoothed
over time using a random walk prior to avoid overfitting: prior_aux_reg
specifies the hyperprior for the random walk standard deviation. For other
parametric likelihoods, prior_aux_reg
specifies the prior for the
auxiliary regression coefficients.
References
Cox C, Chu H, Schneider MF, Muñoz A (2007).
“Parametric survival analysis and taxonomy of hazard functions for the generalized gamma distribution.”
Statistics in Medicine, 26(23), 4352–4374.
doi:10.1002/sim.2836.
Dias S, Welton NJ, Sutton AJ, Ades AE (2011).
“NICE DSU Technical Support Document 2: A generalised linear modelling framework for pair-wise and network meta-analysis of randomised controlled trials.”
National Institute for Health and Care Excellence.
https://www.sheffield.ac.uk/nice-dsu.
Lawless JF (1980).
“Inference in the Generalized Gamma and Log Gamma Distributions.”
Technometrics, 22(3), 409–419.
doi:10.1080/00401706.1980.10486173.
Phillippo DM, Dias S, Ades AE, Belger M, Brnabic A, Schacht A, Saure D, Kadziola Z, Welton NJ (2020).
“Multilevel Network Meta-Regression for population-adjusted treatment comparisons.”
Journal of the Royal Statistical Society: Series A (Statistics in Society), 183(3), 1189–1210.
doi:10.1111/rssa.12579.
Examples
## Smoking cessation NMA
# Set up network of smoking cessation data
head(smoking)
smk_net <- set_agd_arm(smoking,
study = studyn,
trt = trtc,
r = r,
n = n,
trt_ref = "No intervention")
# Print details
smk_net
# Fitting a fixed effect model
smk_fit_FE <- nma(smk_net,
trt_effects = "fixed",
prior_intercept = normal(scale = 100),
prior_trt = normal(scale = 100))
smk_fit_FE
# Fitting a random effects model
smk_fit_RE <- nma(smk_net,
trt_effects = "random",
prior_intercept = normal(scale = 100),
prior_trt = normal(scale = 100),
prior_het = normal(scale = 5))
smk_fit_RE
# Fitting an unrelated mean effects (inconsistency) model
smk_fit_RE_UME <- nma(smk_net,
consistency = "ume",
trt_effects = "random",
prior_intercept = normal(scale = 100),
prior_trt = normal(scale = 100),
prior_het = normal(scale = 5))
smk_fit_RE_UME
# Fitting all possible node-splitting models
smk_fit_RE_nodesplit <- nma(smk_net,
consistency = "nodesplit",
trt_effects = "random",
prior_intercept = normal(scale = 100),
prior_trt = normal(scale = 100),
prior_het = normal(scale = 5))
# Summarise the node-splitting results
summary(smk_fit_RE_nodesplit)
## Plaque psoriasis ML-NMR
# Set up plaque psoriasis network combining IPD and AgD
library(dplyr)
pso_ipd <- filter(plaque_psoriasis_ipd,
studyc %in% c("UNCOVER-1", "UNCOVER-2", "UNCOVER-3"))
pso_agd <- filter(plaque_psoriasis_agd,
studyc == "FIXTURE")
head(pso_ipd)
head(pso_agd)
pso_ipd <- pso_ipd %>%
mutate(# Variable transformations
bsa = bsa / 100,
prevsys = as.numeric(prevsys),
psa = as.numeric(psa),
weight = weight / 10,
durnpso = durnpso / 10,
# Treatment classes
trtclass = case_when(trtn == 1 ~ "Placebo",
trtn %in% c(2, 3, 5, 6) ~ "IL blocker",
trtn == 4 ~ "TNFa blocker"),
# Check complete cases for covariates of interest
complete = complete.cases(durnpso, prevsys, bsa, weight, psa)
)
pso_agd <- pso_agd %>%
mutate(
# Variable transformations
bsa_mean = bsa_mean / 100,
bsa_sd = bsa_sd / 100,
prevsys = prevsys / 100,
psa = psa / 100,
weight_mean = weight_mean / 10,
weight_sd = weight_sd / 10,
durnpso_mean = durnpso_mean / 10,
durnpso_sd = durnpso_sd / 10,
# Treatment classes
trtclass = case_when(trtn == 1 ~ "Placebo",
trtn %in% c(2, 3, 5, 6) ~ "IL blocker",
trtn == 4 ~ "TNFa blocker")
)
# Exclude small number of individuals with missing covariates
pso_ipd <- filter(pso_ipd, complete)
pso_net <- combine_network(
set_ipd(pso_ipd,
study = studyc,
trt = trtc,
r = pasi75,
trt_class = trtclass),
set_agd_arm(pso_agd,
study = studyc,
trt = trtc,
r = pasi75_r,
n = pasi75_n,
trt_class = trtclass)
)
# Print network details
pso_net
# Add integration points to the network
pso_net <- add_integration(pso_net,
durnpso = distr(qgamma, mean = durnpso_mean, sd = durnpso_sd),
prevsys = distr(qbern, prob = prevsys),
bsa = distr(qlogitnorm, mean = bsa_mean, sd = bsa_sd),
weight = distr(qgamma, mean = weight_mean, sd = weight_sd),
psa = distr(qbern, prob = psa),
n_int = 64)
# Fitting a ML-NMR model.
# Specify a regression model to include effect modifier interactions for five
# covariates, along with main (prognostic) effects. We use a probit link and
# specify that the two-parameter Binomial approximation for the aggregate-level
# likelihood should be used. We set treatment-covariate interactions to be equal
# within each class. We narrow the possible range for random initial values with
# init_r = 0.1, since probit models in particular are often hard to initialise.
# Using the QR decomposition greatly improves sampling efficiency here, as is
# often the case for regression models.
pso_fit <- nma(pso_net,
trt_effects = "fixed",
link = "probit",
likelihood = "bernoulli2",
regression = ~(durnpso + prevsys + bsa + weight + psa)*.trt,
class_interactions = "common",
prior_intercept = normal(scale = 10),
prior_trt = normal(scale = 10),
prior_reg = normal(scale = 10),
init_r = 0.1,
QR = TRUE)
pso_fit
## Newly-diagnosed multiple myeloma NMA
# Set up newly-diagnosed multiple myeloma network
head(ndmm_ipd)
head(ndmm_agd)
ndmm_net <- combine_network(
set_ipd(ndmm_ipd,
study, trt,
Surv = Surv(eventtime / 12, status)),
set_agd_surv(ndmm_agd,
study, trt,
Surv = Surv(eventtime / 12, status),
covariates = ndmm_agd_covs))
# Fit Weibull (PH) model
ndmm_fit <- nma(ndmm_net,
likelihood = "weibull",
prior_intercept = normal(scale = 100),
prior_trt = normal(scale = 10),
prior_aux = half_normal(scale = 10))
ndmm_fit