| mbnma.run {MBNMAdose} | R Documentation | 
Run MBNMA dose-response models
Description
Fits a Bayesian dose-response for model-based network meta-analysis (MBNMA) that can account for multiple doses of different agents by applying a desired dose-response function. Follows the methods of Mawdsley et al. (2016).
Usage
mbnma.run(
  network,
  fun = dpoly(degree = 1),
  method = "common",
  regress = NULL,
  regress.effect = "common",
  class.effect = list(),
  UME = FALSE,
  sdscale = FALSE,
  cor = FALSE,
  omega = NULL,
  parameters.to.save = NULL,
  pd = "pd.kl",
  likelihood = NULL,
  link = NULL,
  priors = NULL,
  n.iter = 20000,
  n.chains = 3,
  n.burnin = floor(n.iter/2),
  n.thin = max(1, floor((n.iter - n.burnin)/1000)),
  autojags = FALSE,
  Rhat = 1.05,
  n.update = 10,
  model.file = NULL,
  jagsdata = NULL,
  ...
)
Arguments
| network | An object of class  | 
| fun | An object of  | 
| method | Can take either  | 
| regress | A formula of effect modifiers (variables that
interact with the treatment effect) to incorporate using Network Meta-Regression
(E.g.  | 
| regress.effect | Indicates whether effect modification should be assumed to be
 | 
| class.effect | A list of named strings that determines which dose-response
parameters to model with a class effect and what that effect should be
( | 
| UME | A boolean object to indicate whether to fit an Unrelated Mean Effects model that does not assume consistency and so can be used to test if the consistency assumption is valid. | 
| sdscale | Logical object to indicate whether to write a model that specifies a reference SD
for standardising when modelling using Standardised Mean Differences. Specifying  | 
| cor | A boolean object that indicates whether correlation should be modelled
between relative effect dose-response parameters. This is
automatically set to  | 
| omega | A scale matrix for the inverse-Wishart prior for the covariance matrix used
to model the correlation between dose-response parameters (see Details for dose-response functions).  | 
| parameters.to.save | A character vector containing names of parameters to monitor in JAGS | 
| pd | Can take either: 
 | 
| likelihood | A string indicating the likelihood to use in the model. Can take either  | 
| link | A string indicating the link function to use in the model. Can take any link function
defined within JAGS (e.g.  | 
| priors | A named list of parameter values (without indices) and replacement prior distribution values given as strings using distributions as specified in JAGS syntax (see Plummer (2017)). Note that normal distributions in JAGS are specified as 
 , where 
 . | 
| n.iter | number of total iterations per chain (including burn in; default: 20000) | 
| n.chains | number of Markov chains (default: 3) | 
| n.burnin | length of burn in, i.e. number of iterations to discard at the beginning. Default is 'n.iter/2“, that is, discarding the first half of the simulations. If n.burnin is 0, jags() will run 100 iterations for adaption. | 
| n.thin | thinning rate. Must be a positive integer. Set  | 
| autojags | A boolean value that indicates whether the model should be continually updated until
it has converged below a specific cutoff of  | 
| Rhat | A cutoff value for the Gelman-Rubin convergence diagnostic(Gelman and Rubin 1992).
Unless all parameters have Rhat values lower than this the model will continue to sequentially update up
to a maximum of  | 
| n.update | The maximum number of updates. Each update is run for 1000 iterations, after which the
Rhat values of all parameters are checked against  | 
| model.file | The file path to a JAGS model (.jags file) that can be used
to overwrite the JAGS model that is automatically written based on the
specified options in  | 
| jagsdata | A named list of the data objects to be used in the JAGS model. Only
required if users are defining their own JAGS model using  | 
| ... | Arguments to be sent to R2jags. | 
Details
When relative effects are modelled on more than one dose-response parameter and
cor = TRUE, correlation between the dose-response parameters is automatically
estimated using a vague Wishart prior. This prior can be made slightly more informative
by specifying the relative scale of variances between the dose-response parameters using
omega. cor will automatically be set to FALSE if class effects are modelled.
Value
An object of S3 class(c("mbnma", "rjags")) containing parameter
results from the model. Can be summarized by print() and can check
traceplots using R2jags::traceplot() or various functions from the package mcmcplots.
Nodes that are automatically monitored (if present in the model) have the following interpretation:
| Parameters(s)/Parameter Prefix | Interpretation | 
| <named dose-response parameter>(e.g.emax) | The pooled effect for each dose-response parameter, as defined in dose-response functions. Will vary by agent if pooling is specified as "rel"in the dose-response function. | 
| sd | The between-study SD (heterogeneity) for relative effects, reported if method="random" | 
| sd.<named dose-response parameter>(e.g.sd.emax) | Between-study SD (heterogeneity) for absolute dose-response parameters specified as "random". | 
| <named capitalized dose-response parameter>(e.g.EMAX) | The class effect within each class for a given dose-response parameter. These will be estimated by the model if specified in class.effectsfor a given dose-response parameter. | 
| sd.<named capitalized dose-response parameter>(e.g.sd.EMAX) | The within-class SD for different agents within the same class. Will be estimated by the model if any dose-response parameter in class.effectis set to"random". | 
| totresdev | The residual deviance of the model | 
| deviance | The deviance of the model | 
If there are errors in the JAGS model code then the object will be a list
consisting of two elements - an error message from JAGS that can help with
debugging and model.arg, a list of arguments provided to mbnma.run()
which includes jagscode, the JAGS code for the model that can help
users identify the source of the error.
Dose-response parameter arguments
| Argument | Model specification | 
| "rel" | Implies that relative effects should be pooled for this dose-response parameter separately for each agent in the network. | 
| "common" | Implies that all agents share the same common effect for this dose-response parameter. | 
| "random" | Implies that all agents share a similar (exchangeable) effect for this dose-response parameter. This approach allows for modelling of variability between agents. | 
| numeric() | Assigned a numeric value, indicating that this dose-response parameter should not be estimated from the data but should be assigned the numeric value determined by the user. This can be useful for fixing specific dose-response parameters (e.g. Hill parameters in Emax functions) to a single value. | 
Dose-response function
Several general dose-response functions are provided, but a user-defined dose-response relationship can instead be used.
As of version 0.4.0 dose-response functions are specified as an object of class("dosefun"). See
help details for each of the functions below for the interpretation of specific dose-response parameters.
Built-in dose-response functions are:
-  dpoly(): polynomial (e.g. for a linear model -dpoly(degree=1))
-  dloglin(): log-linear
-  dexp(): exponential
-  demax(): (emax with/without a Hill parameter)
-  dspline(): splines (can fit B-splines (type="bs"), restricted cubic splines (type="rcs"), natural splines (type="ns"), or piecewise linear splines (type="ls"))
-  dfpoly(): fractional polynomials
-  dnonparam(): Non-parametric monotonic function (directioncan be either"increasing"or"decreasing") following the method of Owen et al. (2015)
-  duser(): user-defined function
-  dmulti(): allows agent-specific dose-response functions to be fitted. A separate function must be provided for each agent in the network.
References
Gelman A, Rubin DB (1992).
“Inference from iterative simulation using multiple sequences.”
Statistical Science, 7(4), 457-511.
https://projecteuclid.org/journals/statistical-science/volume-7/issue-4/Inference-from-Iterative-Simulation-Using-Multiple-Sequences/10.1214/ss/1177011136.full.
 Mawdsley D, Bennetts M, Dias S, Boucher M, Welton NJ (2016).
“Model-Based Network Meta-Analysis: A Framework for Evidence Synthesis of Clinical Trial Data.”
CPT Pharmacometrics Syst Pharmacol, 5(8), 393-401.
ISSN 2163-8306 (Electronic) 2163-8306 (Linking), doi:10.1002/psp4.12091, https://pubmed.ncbi.nlm.nih.gov/27479782/.
 Owen RK, Tincello DG, Keith RA (2015).
“Network meta-analysis: development of a three-level hierarchical modeling approach incorporating dose-related constraints.”
Value Health, 18(1), 116-26.
ISSN 1524-4733 (Electronic) 1098-3015 (Linking), doi:10.1016/j.jval.2014.10.006, https://pubmed.ncbi.nlm.nih.gov/25595242/.
 Plummer M (2008).
“Penalized loss functions for Bayesian model comparison.”
Biostatistics, 9(3), 523-39.
ISSN 1468-4357 (Electronic) 1465-4644 (Linking), https://pubmed.ncbi.nlm.nih.gov/18209015/.
 Plummer M (2017).
JAGS user manual.
https://people.stat.sc.edu/hansont/stat740/jags_user_manual.pdf.
 Spiegelhalter DJ, Best NG, Carlin BP, van der Linde A (2002).
“Bayesian measures of model complexity and fit.”
J R Statistic Soc B, 64(4), 583-639.
Examples
# Using the triptans data
network <- mbnma.network(triptans)
######## Dose-response functions ########
# Fit a dose-response MBNMA with a linear function
# with common treatment effects
result <- mbnma.run(network, fun=dpoly(degree=1), method="common")
# Fit a dose-response MBNMA with a log-linear function
# with random treatment effects
result <- mbnma.run(network, fun=dloglin(), method="random")
# Fit a dose-response MBNMA with a fractional polynomial function
# with random treatment effects
# with a probit link function
result <- mbnma.run(network, fun=dfpoly(), method="random", link="probit")
# Fit a user-defined function (quadratic)
fun.def <- ~ (beta.1 * dose) + (beta.2 * (dose^2))
result <- mbnma.run(network, fun=duser(fun=fun.def), method="common")
# Fit an Emax function
# with a single random (exchangeable) parameter for ED50
# with common treatment effects
result <- mbnma.run(network, fun=demax(emax="rel", ed50="random"),
              method="common")
# Fit an Emax function with a Hill parameter
# with a fixed value of 5 for the Hill parameter
# with random relative effects
result <- mbnma.run(network, fun=demax(hill=5), method="random")
# Fit a model with natural cubic splines
# with 3 knots at 10% 30% and 60% quartiles of dose ranges
depnet <- mbnma.network(ssri) # Using the sSRI depression dataset
result <- mbnma.run(depnet, fun=dspline(type="ns", knots=c(0.1,0.3,0.6)))
# Fit a model with different dose-response functions for each agent
multifun <- dmulti(list(dloglin(), # for placebo (can be any function)
                       demax(), # for eletriptan
                       demax(), # for sumatriptan
                       dloglin(), # for frovatriptan
                       demax(), # for almotriptan
                       demax(), # for zolmitriptan
                       dloglin(), # for naratriptan
                       demax())) # for rizatriptan
multidose <- mbnma.run(network, fun=multifun)
########## Class effects ##########
 # Using the osteoarthritis dataset
 pain.df <- osteopain
 # Set a shared class (NSAID) only for Naproxcinod and Naproxen
 pain.df <- pain.df %>% dplyr::mutate(
                class = dplyr::case_when(agent %in% c("Naproxcinod", "Naproxen") ~ "NSAID",
                        !agent %in% c("Naproxcinod", "Naproxen") ~ agent
                        )
                )
 # Run an Emax MBNMA with a common class effect on emax
 painnet <- mbnma.network(pain.df)
 result <- mbnma.run(painnet, fun = demax(),
                class.effect = list(emax = "common"))
####### Priors #######
# Obtain priors from a fractional polynomial function
result <- mbnma.run(network, fun=dfpoly(degree=1), method="random")
print(result$model.arg$priors)
# Change the prior distribution for the power
newpriors <- list(power.1 = "dnorm(0,0.001) T(0,)")
newpriors <- list(sd = "dnorm(0,0.5) T(0,)")
result <- mbnma.run(network, fun=dfpoly(degree=1), method="random",
              priors=newpriors)
########## Sampler options ##########
# Change the number of MCMC iterations, the number of chains, and the thin
result <- mbnma.run(network, fun=dloglin(), method="random",
              n.iter=5000, n.thin=5, n.chains=4)
# Calculate effective number of parameters via plugin method
result <- mbnma.run(network, fun=dloglin(), method="random",
              pd="plugin")
# Calculate effective number of parameters using penalized expected deviance
result <- mbnma.run(network, fun=dloglin(), method="random",
              pd="popt")
####### Examine MCMC diagnostics (using mcmcplots or coda packages) #######
# Density plots
mcmcplots::denplot(result)
# Traceplots
mcmcplots::traplot(result)
# Caterpillar plots
mcmcplots::caterplot(result, "rate")
# Autocorrelation plots (using the coda package)
coda::autocorr.plot(coda::as.mcmc(result))
####### Automatically run jags until convergence is reached #########
# Rhat of 1.08 is set as the criteria for convergence
#on all monitored parameters
conv.res <- mbnma.run(network, fun=demax(),
              method="random",
              n.iter=10000, n.burnin=9000,
              autojags=TRUE, Rhat=1.08, n.update=8)
########## Output ###########
# Print R2jags output and summary
print(result)
summary(result)
# Plot forest plot of results
plot(result)