| Type: | Package | 
| Title: | Scalable Bayesian Disease Mapping Models for High-Dimensional Data | 
| Version: | 0.5.7 | 
| Date: | 2025-09-16 | 
| Maintainer: | Aritz Adin <aritz.adin@unavarra.es> | 
| Description: | Implements several spatial and spatio-temporal scalable disease mapping models for high-dimensional count data using the INLA technique for approximate Bayesian inference in latent Gaussian models (Orozco-Acosta et al., 2021 <doi:10.1016/j.spasta.2021.100496>; Orozco-Acosta et al., 2023 <doi:10.1016/j.cmpb.2023.107403> and Vicente et al., 2023 <doi:10.1007/s11222-023-10263-x>). The creation and develpment of this package has been supported by Project MTM2017-82553-R (AEI/FEDER, UE) and Project PID2020-113125RB-I00/MCIN/AEI/10.13039/501100011033. It has also been partially funded by the Public University of Navarra (project PJUPNA2001). | 
| URL: | https://github.com/spatialstatisticsupna/bigDM | 
| BugReports: | https://github.com/spatialstatisticsupna/bigDM/issues | 
| Depends: | R (≥ 4.0.0) | 
| Additional_repositories: | https://inla.r-inla-download.org/R/stable | 
| Imports: | crayon, doParallel, fastDummies, foreach, future, future.apply, geos, MASS, Matrix, methods, parallel, parallelly, RColorBrewer, Rdpack, sf, spatialreg, spdep, stats, utils, rlist | 
| Suggests: | bookdown, INLA (≥ 22.12.16), knitr, rmarkdown, testthat (≥ 3.0.0), tmap | 
| RdMacros: | Rdpack | 
| License: | GPL-3 | 
| Encoding: | UTF-8 | 
| LazyData: | true | 
| LazyDataCompression: | xz | 
| RoxygenNote: | 7.3.2 | 
| Config/testthat/edition: | 3 | 
| NeedsCompilation: | no | 
| Packaged: | 2025-09-16 07:28:10 UTC; aritz.adin | 
| Author: | Aritz Adin | 
| Repository: | CRAN | 
| Date/Publication: | 2025-09-16 07:50:02 UTC | 
Scalable Bayesian Disease Mapping Models for High-Dimensional Data
Description
This package implements several (scalable) spatial and spatio-temporal Poisson mixed models for high-dimensional areal count data in a fully Bayesian setting using the integrated nested Laplace approximation (INLA) technique.
Details
Below, there is a list with a brief overview of all package functions:
| add_neighbour | Adds isolated areas (polygons) to its nearest neighbour | 
| CAR_INLA | Fits several spatial CAR models for high-dimensional count data | 
| clustering_partition | Obtain a spatial partition using the DBSC algorithm | 
| connect_subgraphs | Merges disjoint connected subgraphs | 
| divide_carto | Divides the spatial domain into subregions | 
| MCAR_INLA | Fits several spatial multivariate CAR models for high-dimensional count data | 
| mergeINLA | Merges inlaobjects for partition models | 
| Mmodel_compute_cor | Computes between-diseases correlation coefficients for M-models | 
| Mmodel_icar | Implements the spatially non-structured multivariate latent effect | 
| Mmodel_icar | Implements the intrinsic multivariate CAR latent effect | 
| Mmodel_lcar | Implements the Leroux et al. (1999) multivariate CAR latent effect | 
| Mmodel_pcar | Implements the proper multivariate CAR latent effect | 
| random_partition | Defines a random partition of the spatial domain based on a regular grid | 
| STCAR_INLA | Fits several spatio-temporal CAR models for high-dimensional count data | 
| ---------------------- | ---------------------------------------------------------------------------------- | 
Author(s)
Maintainer: Aritz Adin <aritz.adin@unavarra.es>
 
This work has been supported by Project MTM2017-82553-R (AEI/FEDER, UE) and Project PID2020-113125RB-I00/MCIN/AEI/10.13039/501100011033.
It has also been partially funded by the Public University of Navarra (project PJUPNA2001) and by la Caixa Foundation (ID 1000010434), Caja Navarra Foundation and UNED Pamplona, under agreement LCF/PR/PR15/51100007 (project REF P/13/20).
References
Orozco-Acosta E, Adin A, Ugarte MD (2021). “Scalable Bayesian modeling for smoothing disease mapping risks in large spatial data sets using INLA.” Spatial Statistics, 41, 100496. doi:10.1016/j.spasta.2021.100496.
Orozco-Acosta E, Adin A, Ugarte MD (2023). “Big problems in spatio-temporal disease mapping: methods and software.” Computer Methods and Programs in Biomedicine, 231, 107403. doi:10.1016/j.cmpb.2023.107403.
Vicente G, Adin A, Goicoa T, Ugarte MD (2023). “High-dimensional order-free multivariate spatial disease mapping.” Statistics and Computing, 33(5), 104. doi:10.1007/s11222-023-10263-x.
See Also
See the following vignettes for further details and examples using this package:
Examples
## See the examples for CAR_INLA, MCAR_INLA and STCAR_INLA functions ##
Fit a (scalable) spatial Poisson mixed model to areal count data, where several CAR prior distributions can be specified for the spatial random effect.
Description
Fit a spatial Poisson mixed model to areal count data. The linear predictor is modelled as
\log{r_{i}}=\alpha+\mathbf{x_i}^{'}\mathbf{\beta} + \xi_i, \quad \mbox{for} \quad i=1,\ldots,n;
where \alpha is a global intercept, \mathbf{x_i}^{'}=(x_{i1},\ldots,x_{ip}) is a p-vector of standardized covariates in the i-th area,
\mathbf{\beta}=(\beta_1,\ldots,\beta_p) is the p-vector of fixed effects coefficients, and \xi_i is a spatially structured random effect.
Several conditional autoregressive (CAR) prior distributions can be specified for the spatial random effect, such as the intrinsic CAR prior (Besag et al. 1991), the convolution or BYM prior (Besag et al. 1991),
the CAR prior proposed by Leroux et al. (1999), and the reparameterization of the BYM model given by Dean et al. (2001) named BYM2 (Riebler et al. 2016).
If covariates are included in the model, two different approaches can be used to address the potential confounding issues between the fixed effects and the spatial random effects of the model: restricted regression and the use of orthogonality constraints.
At the moment, only continuous covariates can be included in the model as potential risk factors, which are automatically standardized before fitting the model. See Adin et al. (2021) for further details.
Three main modelling approaches can be considered:
- the usual model with a global spatial random effect whose dependence structure is based on the whole neighbourhood graph of the areal units ( - model="global"argument)
- a Disjoint model based on a partition of the whole spatial domain where independent spatial CAR models are simultaneously fitted in each partition ( - model="partition"and- k=0arguments)
- a modelling approach where k-order neighbours are added to each partition to avoid border effects in the Disjoint model ( - model="partition"and- k>0arguments).
For both the Disjoint and k-order neighbour models, parallel or distributed computation strategies can be performed to speed up computations by using the 'future' package (Bengtsson 2021).
Inference is conducted in a fully Bayesian setting using the integrated nested Laplace approximation (INLA; Rue et al. (2009)) technique through the R-INLA package (https://www.r-inla.org/). For the scalable model proposals (Orozco-Acosta et al. 2021), approximate values of the Deviance Information Criterion (DIC) and Watanabe-Akaike Information Criterion (WAIC) can also be computed.
The function allows also to use the new hybrid approximate method that combines the Laplace method with a low-rank Variational Bayes correction to the posterior mean (van Niekerk et al. 2023) by including the inla.mode="compact" argument.
Usage
CAR_INLA(
  carto = NULL,
  ID.area = NULL,
  ID.group = NULL,
  O = NULL,
  E = NULL,
  X = NULL,
  confounding = NULL,
  W = NULL,
  prior = "Leroux",
  model = "partition",
  k = 0,
  strategy = "simplified.laplace",
  scale.model = FALSE,
  PCpriors = FALSE,
  merge.strategy = "original",
  compute.intercept = NULL,
  compute.DIC = TRUE,
  n.sample = 1000,
  compute.fitted.values = FALSE,
  save.models = FALSE,
  plan = "sequential",
  workers = NULL,
  inla.mode = "classic",
  num.threads = NULL
)
Arguments
| carto | object of class  | 
| ID.area | character; name of the variable that contains the IDs of spatial areal units. | 
| ID.group | character; name of the variable that contains the IDs of the spatial partition (grouping variable).
Only required if  | 
| O | character; name of the variable that contains the observed number of disease cases for each areal units. | 
| E | character; name of the variable that contains either the expected number of disease cases or the population at risk for each areal unit. | 
| X | a character vector specifying the names of covariates within the  | 
| confounding | one of either  | 
| W | optional argument with the binary adjacency matrix of the spatial areal units.  If  | 
| prior | one of either  | 
| model | one of either  | 
| k | numeric value with the neighbourhood order used for the partition model. Usually k=2 or 3 is enough to get good results.
If k=0 (default) the Disjoint model is considered. Only required if  | 
| strategy | one of either  | 
| scale.model | logical value (default  | 
| PCpriors | logical value (default  | 
| merge.strategy | one of either  | 
| compute.intercept | CAUTION! This argument is deprecated from version 0.5.2. | 
| compute.DIC | logical value; if  | 
| n.sample | numeric; number of samples to generate from the posterior marginal distribution of the linear predictor when computing approximate DIC/WAIC values. Default to 1000. | 
| compute.fitted.values | logical value (default  | 
| save.models | logical value (default  | 
| plan | one of either  | 
| workers | character or vector (default  | 
| inla.mode | one of either  | 
| num.threads | maximum number of threads the inla-program will use. See  | 
Details
For a full model specification and further details see the vignettes accompanying this package.
Value
This function returns an object of class inla. See the mergeINLA function for details.
References
Adin A, Goicoa T, Hodges JS, Schnell P, Ugarte MD (2021). “Alleviating confounding in spatio-temporal areal models with an application on crimes against women in India.” Statistical Modelling, 1471082X211015452. doi:10.1177/1471082X211015452.
Bengtsson H (2021). “A unifying framework for parallel and distributed processing in R using futures.” The R Journal, 13(2), 273–291. doi:10.32614/RJ-2021-048.
Besag J, York J, Mollié A (1991). “Bayesian image restoration, with two applications in spatial statistics.” Annals of the Institute of Statistical Mathematics, 43(1), 1–20. doi:10.1007/bf00116466.
Dean CB, Ugarte MD, Militino AF (2001). “Detecting interaction between random region and fixed age effects in disease mapping.” Biometrics, 57(1), 197–202. doi:10.1111/j.0006-341x.2001.00197.x.
Leroux BG, Lei X, Breslow N (1999). “Estimation of disease rates in small areas: A new mixed model for spatial dependence.” In Halloran ME, Berry D (eds.), Statistical Models in Epidemiology, the Environment, and Clinical Trials, 179–191. Springer-Verlag: New York.
Riebler A, Sørbye SH, Simpson D, Rue H (2016). “An intuitive Bayesian spatial model for disease mapping that accounts for scaling.” Statistical methods in medical research, 25(4), 1145–1165. doi:10.1177/0962280216660421.
Rue H, Martino S, Chopin N (2009). “Approximate Bayesian inference for latent Gaussian models by using integrated nested Laplace approximations.” Journal of the Royal Statistical Society: Series B (Statistical Methodology), 71(2), 319–392. doi:10.1111/j.1467-9868.2008.00700.x.
Orozco-Acosta E, Adin A, Ugarte MD (2021). “Scalable Bayesian modeling for smoothing disease mapping risks in large spatial data sets using INLA.” Spatial Statistics, 41, 100496. doi:10.1016/j.spasta.2021.100496.
van Niekerk J, Krainski E, Rustand D, Rue H (2023). “A new avenue for Bayesian inference with INLA.” Computational Statistics & Data Analysis, 181, 107692. doi:10.1016/j.csda.2023.107692.
Examples
## Not run: 
if(require("INLA", quietly=TRUE)){
  ## Load the Spain colorectal cancer mortality data ##
  data(Carto_SpainMUN)
  ## Global model with a Leroux CAR prior distribution ##
  Global <- CAR_INLA(carto=Carto_SpainMUN, ID.area="ID", O="obs", E="exp",
                     prior="Leroux", model="global", strategy="gaussian")
  summary(Global)
  ## Disjoint model with a Leroux CAR prior distribution  ##
  ## using 4 local clusters to fit the models in parallel ##
  Disjoint <- CAR_INLA(carto=Carto_SpainMUN, ID.area="ID", ID.group="region", O="obs", E="exp",
                       prior="Leroux", model="partition", k=0, strategy="gaussian",
                       plan="cluster", workers=rep("localhost",4))
  summary(Disjoint)
  ## 1st-order neighbourhood model with a Leroux CAR prior distribution ##
  ## using 4 local clusters to fit the models in parallel               ##
  order1 <- CAR_INLA(carto=Carto_SpainMUN, ID.area="ID", ID.group="region", O="obs", E="exp",
                     prior="Leroux", model="partition", k=1, strategy="gaussian",
                     plan="cluster", workers=rep("localhost",4))
  summary(order1)
  ## 2nd-order neighbourhood model with a Leroux CAR prior distribution ##
  ## using 4 local clusters to fit the models in parallel               ##
  order2 <- CAR_INLA(carto=Carto_SpainMUN, ID.area="ID", ID.group="region", O="obs", E="exp",
                     prior="Leroux", model="partition", k=2, strategy="gaussian",
                     plan="cluster", workers=rep("localhost",4))
  summary(order2)
}
## End(Not run)
Spanish colorectal cancer mortality data
Description
sf object containing the polygons of the municipalities of continental Spain
and simulated colorectal cancer mortality data.
Usage
Carto_SpainMUN
Format
Formal class sf; the data contains a data.frame with 7907 rows and 9 variables.
- ID: character vector of geographic identifiers 
- name: character vector of municipality names 
- area: municipality polygon areas (in square meters) 
- perimeter: municipality polygon perimeters (in meters) 
- obs: observed number of cases 
- exp: expected number of cases 
- SMR: standardized mortality ratios 
- region: character vector of autonomous regions 
- geometry: sfc_MULTIPOLYGON 
Spanish lung cancer mortality data
Description
data.frame object containing simulated lung cancer mortality data in the 7907 municipalities of continental Spain during the period 1991-2015.
Usage
Data_LungCancer
Format
Formal class data.frame with 197.675 rows and 5 colunmns.
- ID: character vector of geographic identifiers 
- year: numeric vector of year's identifiers 
- obs: observed number of cases 
- exp: expected number of cases 
- SMR: standardized mortality ratios 
- pop: population at risk 
Spanish cancer mortality data for the joint analysis of multiple diseases
Description
data.frame object containing simulated cancer mortality data for three diseases in the 7907 municipalities of continental Spain.
Usage
Data_MultiCancer
Format
Formal class data.frame with 237.271 rows and 5 colunmns.
- ID: character vector of geographic identifiers 
- disease: numeric vector of disease identifiers 
- obs: observed number of cases 
- exp: expected number of cases 
- SMR: standardized mortality ratios 
Fit a (scalable) spatial multivariate Poisson mixed model to areal count data where dependence between spatial patterns of the diseases is addressed through the use of M-models (Botella-Rocamora et al. 2015).
Description
Fit a spatial multivariate Poisson mixed model to areal count data. The linear predictor is modelled as
\log{r_{ij}}=\alpha_j + \theta_{ij}, \quad \mbox{for} \quad i=1,\ldots,n; \quad j=1,\ldots,J
where \alpha_j is a disease-specific intercept and \theta_{ij} is the spatial main effect of area i for the j-th disease.
Following Botella-Rocamora et al. (2015), we rearrange the spatial effects into the matrix \mathbf{\Theta} = \{ \theta_{ij}: i=1, \ldots, I; j=1, \ldots, J \} whose columns are spatial random effects and its joint distribution specifies how dependence within-diseases and between-diseases is defined.
Several conditional autoregressive (CAR) prior distributions can be specified to deal with spatial dependence within-diseases, such as the intrinsic CAR prior (Besag et al. 1991), the CAR prior proposed by Leroux et al. (1999), and the proper CAR prior distribution.
As in the CAR_INLA function, three main modelling approaches can be considered:
- the usual model with a global spatial random effect whose dependence structure is based on the whole neighbourhood graph of the areal units ( - model="global"argument)
- a Disjoint model based on a partition of the whole spatial domain where independent spatial CAR models are simultaneously fitted in each partition ( - model="partition"and- k=0arguments)
- a modelling approach where k-order neighbours are added to each partition to avoid border effects in the Disjoint model ( - model="partition"and- k>0arguments).
For both the Disjoint and k-order neighbour models, parallel or distributed computation strategies can be performed to speed up computations by using the 'future' package (Bengtsson 2021).
Inference is conducted in a fully Bayesian setting using the integrated nested Laplace approximation (INLA; Rue et al. (2009)) technique through the R-INLA package (https://www.r-inla.org/). For the scalable model proposals (Orozco-Acosta et al. 2021), approximate values of the Deviance Information Criterion (DIC) and Watanabe-Akaike Information Criterion (WAIC) can also be computed.
The function allows also to use the new hybrid approximate method that combines the Laplace method with a low-rank Variational Bayes correction to the posterior mean (van Niekerk et al. 2023) by including the inla.mode="compact" argument.
Usage
MCAR_INLA(
  carto = NULL,
  data = NULL,
  ID.area = NULL,
  ID.disease = NULL,
  ID.group = NULL,
  O = NULL,
  E = NULL,
  W = NULL,
  prior = "intrinsic",
  model = "partition",
  k = 0,
  strategy = "simplified.laplace",
  merge.strategy = "original",
  compute.intercept = NULL,
  compute.DIC = TRUE,
  n.sample = 1000,
  compute.fitted.values = FALSE,
  save.models = FALSE,
  plan = "sequential",
  workers = NULL,
  inla.mode = "classic",
  num.threads = NULL
)
Arguments
| carto | object of class  | 
| data | object of class  | 
| ID.area | character; name of the variable that contains the IDs of spatial areal units. The values of this variable must match those given in the  | 
| ID.disease | character; name of the variable that contains the IDs of the diseases. | 
| ID.group | character; name of the variable that contains the IDs of the spatial partition (grouping variable). Only required if  | 
| O | character; name of the variable that contains the observed number of cases for each areal unit and disease. | 
| E | character; name of the variable that contains either the expected number of cases or the population at risk for each areal unit and disease. | 
| W | optional argument with the binary adjacency matrix of the spatial areal units. If  | 
| prior | one of either  | 
| model | one of either  | 
| k | numeric value with the neighbourhood order used for the partition model. Usually k=2 or 3 is enough to get good results. If k=0 (default) the Disjoint model is considered. Only required if  | 
| strategy | one of either  | 
| merge.strategy | one of either  | 
| compute.intercept | CAUTION! This argument is deprecated from version 0.5.2. | 
| compute.DIC | logical value; if  | 
| n.sample | numeric; number of samples to generate from the posterior marginal distribution of the linear predictor when computing approximate DIC/WAIC values. Default to 1000. | 
| compute.fitted.values | logical value (default  | 
| save.models | logical value (default  | 
| plan | one of either  | 
| workers | character or vector (default  | 
| inla.mode | one of either  | 
| num.threads | maximum number of threads the inla-program will use. See  | 
Details
For a full model specification and further details see the vignettes accompanying this package.
Value
This function returns an object of class inla. See the mergeINLA function for details.
References
Bengtsson H (2021). “A unifying framework for parallel and distributed processing in R using futures.” The R Journal, 13(2), 273–291. doi:10.32614/RJ-2021-048.
Besag J, York J, Mollié A (1991). “Bayesian image restoration, with two applications in spatial statistics.” Annals of the Institute of Statistical Mathematics, 43(1), 1–20. doi:10.1007/bf00116466.
Botella-Rocamora P, Martinez-Beneito MA, Banerjee S (2015). “A unifying modeling framework for highly multivariate disease mapping.” Statistics in Medicine, 34(9), 1548–1559. doi:10.1002/sim.6423.
Leroux BG, Lei X, Breslow N (1999). “Estimation of disease rates in small areas: A new mixed model for spatial dependence.” In Halloran ME, Berry D (eds.), Statistical Models in Epidemiology, the Environment, and Clinical Trials, 179–191. Springer-Verlag: New York.
Rue H, Martino S, Chopin N (2009). “Approximate Bayesian inference for latent Gaussian models by using integrated nested Laplace approximations.” Journal of the Royal Statistical Society: Series B (Statistical Methodology), 71(2), 319–392. doi:10.1111/j.1467-9868.2008.00700.x.
Vicente G, Adin A, Goicoa T, Ugarte MD (2023). “High-dimensional order-free multivariate spatial disease mapping.” Statistics and Computing, 33(5), 104. doi:10.1007/s11222-023-10263-x.
van Niekerk J, Krainski E, Rustand D, Rue H (2023). “A new avenue for Bayesian inference with INLA.” Computational Statistics & Data Analysis, 181, 107692. doi:10.1016/j.csda.2023.107692.
Examples
## Not run: 
if(require("INLA", quietly=TRUE)){
  ## Load the sf object that contains the spatial polygons of the municipalities of Spain ##
  data(Carto_SpainMUN)
  str(Carto_SpainMUN)
  ## Load the simulated cancer mortality data (three diseases) ##
  data(Data_MultiCancer)
  str(Data_MultiCancer)
  ## Fit the Global model with an iCAR prior for the within-disease random effects ##
  Global <- MCAR_INLA(carto=Carto_SpainMUN, data=Data_MultiCancer,
                      ID.area="ID", ID.disease="disease", O="obs", E="exp",
                      prior="intrinsic", model="global", strategy="gaussian")
  summary(Global)
  ## Fit the Disjoint model with an iCAR prior for the within-disease random effects ##
  ## using 4 local clusters to fit the models in parallel                            ##
  Disjoint <- MCAR_INLA(carto=Carto_SpainMUN, data=Data_MultiCancer,
                        ID.area="ID", ID.disease="disease", O="obs", E="exp", ID.group="region",
                        prior="intrinsic", model="partition", k=0, strategy="gaussian",
                        plan="cluster", workers=rep("localhost",4))
  summary(Disjoint)
  ## 1st-order neighbourhood model with an iCAR prior for the within-disease random effects ##
  ## using 4 local clusters to fit the models in parallel                                   ##
  order1 <- MCAR_INLA(carto=Carto_SpainMUN, data=Data_MultiCancer,
                      ID.area="ID", ID.disease="disease", O="obs", E="exp", ID.group="region",
                      prior="intrinsic", model="partition", k=1, strategy="gaussian",
                      plan="cluster", workers=rep("localhost",4))
  summary(order1)
}
## End(Not run)
Compute correlation coefficients between diseases
Description
This function takes a inla object fitted using the MCAR_INLA function and computes the correlation coefficients between diseases.
Usage
Mmodel_compute_cor(model, n.sample = 10000)
Arguments
| model | object of class  | 
| n.sample | numeric; number of samples to generate from the approximated joint posterior for the hyperparameters (see  | 
Value
The input inla object with two additional elements:
| summary.cor | A data.frame containing the mean, standard deviation, quantiles and mode of the correlation coefficients between diseases. | 
| marginals.cor | A list containing the posterior marginal densities of the correlation coefficients between diseases. | 
| summary.var | A data.frame containing the mean, standard deviation, quantiles and mode of the variances for each disease. | 
| marginals.var | A list containing the posterior marginal densities of the variances for each disease. | 
Intrinsic multivariate CAR latent effect
Description
M-model implementation of the intrinsic multivariate CAR latent effect using the rgeneric model of INLA.
Usage
Mmodel_icar(
  cmd = c("graph", "Q", "mu", "initial", "log.norm.const", "log.prior", "quit"),
  theta = NULL
)
Arguments
| cmd | Internal functions used by the  | 
| theta | Vector of hyperparameters. | 
Details
This function considers an intrinsic CAR prior for the spatial latent effects of the different diseases and introduces correlation between them using the M-model proposal of Botella-Rocamora et al. (2015).
Putting the spatial latent effects for each disease in a matrix, the between disease dependence is introduced through the M matrix as \Theta=\Phi M, where the columns of \Phi follow an intrinsic CAR prior distribution (within-disease correlation).
A Wishart prior for the between covariance matrix M'M is considered using the Bartlett decomposition.
The following arguments are required to be defined before calling the functions:
-  W: binary adjacency matrix of the spatial areal units
-  J: number of diseases
-  initial.values: initial values defined for the cells of the M-matrix
Value
This is used internally by the INLA::inla.rgeneric.define() function.
References
Botella-Rocamora P, Martinez-Beneito MA, Banerjee S (2015). “A unifying modeling framework for highly multivariate disease mapping.” Statistics in Medicine, 34(9), 1548–1559. doi:10.1002/sim.6423.
Spatially non-structured multivariate latent effect
Description
M-model implementation of the spatially non-structured multivariate latent effect using the rgeneric model of INLA.
Usage
Mmodel_iid(
  cmd = c("graph", "Q", "mu", "initial", "log.norm.const", "log.prior", "quit"),
  theta = NULL
)
Arguments
| cmd | Internal functions used by the  | 
| theta | Vector of hyperparameters. | 
Details
This function considers a spatially non-structured prior for the spatial latent effects of the different diseases and introduces correlation between them using the M-model proposal of Botella-Rocamora et al. (2015).
Putting the latent effects for each disease in a matrix, the between disease dependence is introduced through the M matrix as \Theta=\Phi M, where the columns of \Phi follow an IID (independent and identically distributed) prior distribution (within-disease correlation).
A Wishart prior for the between covariance matrix M'M is considered using the Bartlett decomposition.
The following arguments are required to be defined before calling the functions:
-  W: binary adjacency matrix of the spatial areal units
-  J: number of diseases
-  initial.values: initial values defined for the cells of the M-matrix
Value
This is used internally by the INLA::inla.rgeneric.define() function.
References
Botella-Rocamora P, Martinez-Beneito MA, Banerjee S (2015). “A unifying modeling framework for highly multivariate disease mapping.” Statistics in Medicine, 34(9), 1548–1559. doi:10.1002/sim.6423.
Leroux et al. (1999) multivariate CAR latent effect
Description
M-model implementation of the Leroux et al. (1999) multivariate CAR latent effect with different spatial smoothing parameters using the rgeneric model of INLA.
Usage
Mmodel_lcar(
  cmd = c("graph", "Q", "mu", "initial", "log.norm.const", "log.prior", "quit"),
  theta = NULL
)
Arguments
| cmd | Internal functions used by the  | 
| theta | Vector of hyperparameters. | 
Details
This function considers a Leroux et al. (1999) CAR prior (denoted as LCAR) for the spatial latent effects of the different diseases and introduces correlation between them using the M-model proposal of Botella-Rocamora et al. (2015).
Putting the spatial latent effects for each disease in a matrix, the between disease dependence is introduced through the M matrix as \Theta=\Phi M, where the columns of \Phi follow a LCAR prior distribution (within-disease correlation).
A Wishart prior for the between covariance matrix M'M is considered using the Bartlett decomposition.
Uniform prior distributions on the interval [alpha.min, alpha.max] are considered for all the spatial smoothing parameters.
The following arguments are required to be defined before calling the functions:
-  W: binary adjacency matrix of the spatial areal units
-  J: number of diseases
-  initial.values: initial values defined for the cells of the M-matrix
-  alpha.min: lower limit defined for the uniform prior distribution of the spatial smoothing parameters
-  alpha.max: upper limit defined for the uniform prior distribution of the spatial smoothing parameters
Value
This is used internally by the INLA::inla.rgeneric.define() function.
Note
The M-model implementation of this model using R-INLA requires the use of J \times (J+3)/2 hyperparameters. So, the results must be carefully checked.
References
Botella-Rocamora P, Martinez-Beneito MA, Banerjee S (2015). “A unifying modeling framework for highly multivariate disease mapping.” Statistics in Medicine, 34(9), 1548–1559. doi:10.1002/sim.6423.
Leroux BG, Lei X, Breslow N (1999). “Estimation of disease rates in small areas: A new mixed model for spatial dependence.” In Halloran ME, Berry D (eds.), Statistical Models in Epidemiology, the Environment, and Clinical Trials, 179–191. Springer-Verlag: New York.
Proper multivariate CAR latent effect
Description
M-model implementation of the proper multivariate CAR latent effect with different spatial autocorrelation parameters using the rgeneric model of INLA.
Usage
Mmodel_pcar(
  cmd = c("graph", "Q", "mu", "initial", "log.norm.const", "log.prior", "quit"),
  theta = NULL
)
Arguments
| cmd | Internal functions used by the  | 
| theta | Vector of hyperparameters. | 
Details
This function considers a proper CAR prior (denoted as pCAR) for the spatial latent effects of the different diseases and introduces correlation between them using the M-model proposal of Botella-Rocamora et al. (2015).
Putting the spatial latent effects for each disease in a matrix, the between disease dependence is introduced through the M matrix as \Theta=\Phi M, where the columns of \Phi follow a pCAR prior distribution (within-disease correlation).
A Wishart prior for the between covariance matrix M'M is considered using the Bartlett decomposition.
Uniform prior distributions on the interval [alpha.min, alpha.max] are considered for all the spatial autocorrelation parameters.
The following arguments are required to be defined before calling the functions:
-  W: binary adjacency matrix of the spatial areal units
-  J: number of diseases
-  initial.values: initial values defined for the cells of the M-matrix
-  alpha.min: lower limit defined for the uniform prior distribution of the spatial smoothing parameters
-  alpha.max: upper limit defined for the uniform prior distribution of the spatial smoothing parameters
Value
This is used internally by the INLA::inla.rgeneric.define() function.
Note
The M-model implementation of this model using R-INLA requires the use of J \times (J+3)/2 hyperparameters. So, the results must be carefully checked.
References
Botella-Rocamora P, Martinez-Beneito MA, Banerjee S (2015). “A unifying modeling framework for highly multivariate disease mapping.” Statistics in Medicine, 34(9), 1548–1559. doi:10.1002/sim.6423.
Fit a (scalable) spatio-temporal Poisson mixed model to areal count data.
Description
Fit a spatio-temporal Poisson mixed model to areal count data, where several CAR prior distributions for the spatial random effects, first and second order random walk priors for the temporal random effects, and different types of spatio-temporal interactions described in Knorr-Held (2000) can be specified. The linear predictor is modelled as
\log{r_{it}}=\alpha + \mathbf{x_{it}}^{'}\mathbf{\beta} + \xi_i+\gamma_t+\delta_{it}, \quad \mbox{for} \quad i=1,\ldots,n; \quad t=1,\ldots,T
where \alpha is a global intercept, \mathbf{x_{it}}^{'}=(x_{it1},\ldots,x_{itp}) is a p-vector of standardized covariates in the i-th area and time period t, \mathbf{\beta}=(\beta_1,\ldots,\beta_p) is the p-vector of fixed effects coefficients,
\xi_i is a spatially structured random effect, \gamma_t is a temporally structured random effect, and \delta_{it} is the space-time interaction effect. If the interaction term is dropped, an additive model is obtained.
To ensure model identifiability, sum-to-zero constraints are imposed over the random effects of the model. Details on the derivation of these constraints can be found in Goicoa et al. (2018).
As in the CAR_INLA function, three main modelling approaches can be considered:
- the usual model with a global spatial random effect whose dependence structure is based on the whole neighbourhood graph of the areal units ( - model="global"argument)
- a Disjoint model based on a partition of the whole spatial domain where independent spatial CAR models are simultaneously fitted in each partition ( - model="partition"and- k=0arguments)
- a modelling approach where k-order neighbours are added to each partition to avoid border effects in the Disjoint model ( - model="partition"and- k>0arguments).
For both the Disjoint and k-order neighbour models, parallel or distributed computation strategies can be performed to speed up computations by using the 'future' package (Bengtsson 2021).
Inference is conducted in a fully Bayesian setting using the integrated nested Laplace approximation (INLA; Rue et al. (2009)) technique through the R-INLA package (https://www.r-inla.org/). For the scalable model proposals (Orozco-Acosta et al. 2023), approximate values of the Deviance Information Criterion (DIC) and Watanabe-Akaike Information Criterion (WAIC) can also be computed.
The function allows also to use the new hybrid approximate method that combines the Laplace method with a low-rank Variational Bayes correction to the posterior mean (van Niekerk et al. 2023) by including the inla.mode="compact" argument.
Usage
STCAR_INLA(
  carto = NULL,
  data = NULL,
  ID.area = NULL,
  ID.year = NULL,
  ID.group = NULL,
  O = NULL,
  E = NULL,
  X = NULL,
  W = NULL,
  spatial = "Leroux",
  temporal = "rw1",
  interaction = "TypeIV",
  model = "partition",
  k = 0,
  strategy = "simplified.laplace",
  scale.model = FALSE,
  PCpriors = FALSE,
  merge.strategy = "original",
  compute.intercept = NULL,
  compute.DIC = TRUE,
  n.sample = 1000,
  compute.fitted.values = FALSE,
  save.models = FALSE,
  plan = "sequential",
  workers = NULL,
  inla.mode = "classic",
  num.threads = NULL
)
Arguments
| carto | object of class  | 
| data | object of class  | 
| ID.area | character; name of the variable that contains the IDs of spatial areal units. The values of this variable must match those given in the  | 
| ID.year | character; name of the variable that contains the IDs of time points. | 
| ID.group | character; name of the variable that contains the IDs of the spatial partition (grouping variable). Only required if  | 
| O | character; name of the variable that contains the observed number of disease cases for each areal and time point. | 
| E | character; name of the variable that contains either the expected number of disease cases or the population at risk for each areal unit and time point. | 
| X | a character vector containing the names of the covariates within the  | 
| W | optional argument with the binary adjacency matrix of the spatial areal units. If  | 
| spatial | one of either  | 
| temporal | one of either  | 
| interaction | one of either  | 
| model | one of either  | 
| k | numeric value with the neighbourhood order used for the partition model. Usually k=2 or 3 is enough to get good results. If k=0 (default) the Disjoint model is considered. Only required if  | 
| strategy | one of either  | 
| scale.model | logical value (default  | 
| PCpriors | logical value (default  | 
| merge.strategy | one of either  | 
| compute.intercept | CAUTION! This argument is deprecated from version 0.5.2. | 
| compute.DIC | logical value; if  | 
| n.sample | numeric; number of samples to generate from the posterior marginal distribution of the linear predictor when computing approximate DIC/WAIC values. Default to 1000. | 
| compute.fitted.values | logical value (default  | 
| save.models | logical value (default  | 
| plan | one of either  | 
| workers | character or vector (default  | 
| inla.mode | one of either  | 
| num.threads | maximum number of threads the inla-program will use. See  | 
Details
For a full model specification and further details see the vignettes accompanying this package.
Value
This function returns an object of class inla. See the mergeINLA function for details.
References
Goicoa T, Adin A, Ugarte MD, Hodges JS (2018). “In spatio-temporal disease mapping models, identifiability constraints affect PQL and INLA results.” Stochastic Environmental Research and Risk Assessment, 32(3), 749–770. doi:10.1007/s00477-017-1405-0.
Knorr-Held L (2000). “Bayesian modelling of inseparable space-time variation in disease risk.” Statistics in Medicine, 19(17-18), 2555–2567.
Orozco-Acosta E, Adin A, Ugarte MD (2021). “Scalable Bayesian modeling for smoothing disease mapping risks in large spatial data sets using INLA.” Spatial Statistics, 41, 100496. doi:10.1016/j.spasta.2021.100496.
Orozco-Acosta E, Adin A, Ugarte MD (2023). “Big problems in spatio-temporal disease mapping: methods and software.” Computer Methods and Programs in Biomedicine, 231, 107403. doi:10.1016/j.cmpb.2023.107403.
van Niekerk J, Krainski E, Rustand D, Rue H (2023). “A new avenue for Bayesian inference with INLA.” Computational Statistics & Data Analysis, 181, 107692. doi:10.1016/j.csda.2023.107692.
Examples
## Not run: 
if(require("INLA", quietly=TRUE)){
  ## Load the sf object that contains the spatial polygons of the municipalities of Spain ##
  data(Carto_SpainMUN)
  str(Carto_SpainMUN)
  ## Create province IDs ##
  Carto_SpainMUN$ID.prov <- substr(Carto_SpainMUN$ID,1,2)
  ## Load simulated data of lung cancer mortality data during the period 1991-2015 ##
  data("Data_LungCancer")
  str(Data_LungCancer)
  ## Disjoint model with a BYM2 spatial random effect, RW1 temporal random effect and      ##
  ## Type I interaction random effect using 4 local clusters to fit the models in parallel ##
  Disjoint <- STCAR_INLA(carto=Carto_SpainMUN, data=Data_LungCancer,
                         ID.area="ID", ID.year="year", O="obs", E="exp", ID.group="ID.prov",
                         spatial="BYM2", temporal="rw1", interaction="TypeI",
                         model="partition", k=0, strategy="gaussian",
                         plan="cluster", workers=rep("localhost",4))
  summary(Disjoint)
  ## 1st-order nb. model with a BYM2 spatial random effect, RW1 temporal random effect and ##
  ## Type I interaction random effect using 4 local clusters to fit the models in parallel ##
  order1 <- STCAR_INLA(carto=Carto_SpainMUN, data=Data_LungCancer,
                       ID.area="ID", ID.year="year", O="obs", E="exp", ID.group="ID.prov",
                       spatial="BYM2", temporal="rw1", interaction="TypeI",
                       model="partition", k=1, strategy="gaussian",
                       plan="cluster", workers=rep("localhost",4))
  summary(order1)
}
## End(Not run)
Add isolated areas (polygons) to its nearest neighbour
Description
The function returns a neighbour list of class nb and its associated spatial adjacency matrix
computed by adding isolated areas to its nearest neighbour (in terms of Euclidean distance between centroids) using the knearneigh function of 'spdep' package.
Usage
add_neighbour(carto, nb = NULL, plot = FALSE)
Arguments
| carto | object of class  | 
| nb | optional argument with the neighbour list of class  | 
| plot | logical value (default  | 
Value
This function returns a list with the following two elements:
-  nb: the modified neighbours's list
-  W: associated spatial adjacency matrix of classdgCMatrix
Examples
library(spdep)
## Load the Spanish colorectal cancer mortality data ##
data(Carto_SpainMUN)
## Compute the neighbour list from spatial polygons ##
nb_SpainMUN <- poly2nb(Carto_SpainMUN)
summary(nb_SpainMUN) # 1 region with no links
## Add isolated area to its nearest neighbour ####
carto.mod <- add_neighbour(carto=Carto_SpainMUN, nb=nb_SpainMUN)
summary(carto.mod$nb) # 0 region with no links
Obtain a partition of the spatial domain using the density-based spatial clustering (DBSC) algorithm described in Santafé et al. (2021)
Description
The function takes an object of class SpatialPolygonsDataFrame or sf and defines a spatial partition using the DBSC algorithm described in Santafé et al. (2021).
Usage
clustering_partition(
  carto,
  ID.area = NULL,
  var = NULL,
  n.cluster = 10,
  min.size = NULL,
  W = NULL,
  l = 1,
  Wk = NULL,
  distance = "euclidean",
  verbose = TRUE
)
Arguments
| carto | object of class  | 
| ID.area | character; name of the variable that contains the IDs of spatial areal units. | 
| var | character; name of the variable that contains the data of interest to compute spatial clusters, usually the vector of log-SMR. | 
| n.cluster | numeric; value to fix the number of cluster centers in the DBSC algorithm. Default to 10. | 
| min.size | numeric (default  | 
| W | optional argument with the binary adjacency matrix of the spatial areal units. If  | 
| l | numeric value with the neighbourhood order used to assign areas to each cluster. If  | 
| Wk | previously computed binary adjacency matrix of l-order neighbours. If this argument is included (default  | 
| distance | the distance measure to be used (default  | 
| verbose | logical value (default  | 
Details
The DBSC algorithm implemented in this function is a new spatial clustering algorithm based on the density clustering algorithm introduced by Rodriguez and Laio (2014) and the posterior modification presented by Wang and Song (2016). This algorithm is able to obtain a single clustering partition of the data by automatically detecting clustering centers and assigning each area to its nearest cluster centroid. The algorithm has its basis in the assumption that cluster centers are points with high local density and relatively large distance to other points with higher local densities. See Santafé et al. (2021) for more details.
Value
sf object with the original data and a grouping variable named 'ID.group'.
References
Rodriguez A, Laio A (2014). “Clustering by fast search and find of density peaks.” Science, 344(6191), 1492–1496. doi:10.1126/science.1242072.
Santafé G, Adin A, Lee D, Ugarte MD (2021). “Dealing with risk discontinuities to estimate cancer mortality risks when the number of small areas is large.” Statistical Methods in Medical Research, 30(1), 6–21. doi:10.1177/0962280220946502.
Wang G, Song Q (2016). “Automatic clustering via outward statistical testing on density metrics.” IEEE Transactions on Knowledge and Data Engineering, 28(8), 1971–1985. doi:10.1109/TKDE.2016.2535209.
Examples
## Not run: 
library(sf)
library(tmap)
## Load the Spain colorectal cancer mortality data ##
data(Carto_SpainMUN)
## Define a spatial partition using the DBSC algorithm ##
Carto_SpainMUN$logSMR <- log(Carto_SpainMUN$obs/Carto_SpainMUN$exp+0.0001)
carto.new <- clustering_partition(carto=Carto_SpainMUN, ID.area="ID", var="logSMR",
                                  n.cluster=20, l=2, min.size=100, verbose=TRUE)
table(carto.new$ID.group)
## Plot of the grouping variable 'ID.group' ##
carto.data <- st_set_geometry(carto.new, NULL)
carto.partition <- aggregate(carto.new[,"geometry"], list(ID.group=carto.data[,"ID.group"]), head)
tmap4 <- packageVersion("tmap") >= "3.99"
if(tmap4){
        tm_shape(carto.new) +
                tm_polygons(fill="ID.group", fill.scale=tm_scale(values="brewer.set3")) +
                tm_shape(carto.partition) +
                tm_borders(col="black", lwd=2) +
                tm_layout(legend.outside=TRUE, legend.frame=FALSE)
}else{
        tm_shape(carto.new) +
                tm_polygons(col="ID.group") +
                tm_shape(carto.partition) +
                tm_borders(col="black", lwd=2) +
                tm_layout(legend.outside=TRUE)
}
## End(Not run)
Merge disjoint connected subgraphs
Description
The function returns a neighbour list of class nb and its associated spatial adjacency matrix
computed by merging disjoint connected subgraphs through its nearest polygon centroids.
Usage
connect_subgraphs(carto, ID.area = NULL, nb = NULL, plot = FALSE)
Arguments
| carto | object of class  | 
| ID.area | character vector of geographic identifiers. | 
| nb | optional argument with the neighbours list of class  | 
| plot | logical value (default  | 
Details
This function first calls the add_neighbour function to search for isolated areas.
Value
This function returns a list with the following two elements:
-  nb: the modified neighbours list
-  W: associated spatial adjacency matrix of classdgCMatrix
Examples
library(spdep)
## Load the Spain colorectal cancer mortality data ##
data(Carto_SpainMUN)
## Select the polygons (municipalities) of the 'Comunidad Valenciana' region ##
carto <- Carto_SpainMUN[Carto_SpainMUN$region=="Comunidad Valenciana",]
carto.nb <- poly2nb(carto)
n.comp.nb(carto.nb)$nc # 2 disjoint connected subgraphs
## Plot the spatial polygons and its neighbourhood graph
op <- par(mfrow=c(1,2), pty="s")
plot(carto$geometry, main="Original neighbourhood graph")
plot(carto.nb, st_centroid(st_geometry(carto), of_largest_polygon=TRUE),
     pch=19, cex=0.5, col="red", add=TRUE)
## Use the 'connect_subgraphs' function ##
carto.mod <- connect_subgraphs(carto=carto, ID.area="ID", nb=carto.nb, plot=TRUE)
title(main="Modified neighbourhood graph")
n.comp.nb(carto.mod$nb)$nc==1
par(op)
Divide the spatial domain into subregions
Description
The function takes an object of class SpatialPolygonsDataFrame or sf
and divides it into subregions according to some grouping variable.
Usage
divide_carto(carto, ID.group = NULL, k = 0, plot = FALSE)
Arguments
| carto | object of class  | 
| ID.group | character vector of grouping identifiers. | 
| k | numeric value with the neighbourhood order to add polygons at the border of the spatial subdomains. If k=0 (default) a disjoint partition is defined. | 
| plot | logical value (default  | 
Value
List of sf objects with the spatial polygons of each subdomain.
Examples
## Not run: 
library(tmap)
## Load the Spain colorectal cancer mortality data ##
data(Carto_SpainMUN)
## Plot of the grouping variable 'region' ##
tmap4 <- packageVersion("tmap") >= "3.99"
if(tmap4){
        tm_shape(Carto_SpainMUN) +
                tm_polygons(fill="region",
                            fill.scale=tm_scale(values="brewer.set3"),
                            fill.legend=tm_legend(frame=FALSE))
}else{
        tm_shape(Carto_SpainMUN) +
                tm_polygons(col="region") +
                tm_layout(legend.outside=TRUE)
}
## Disjoint partition ##
carto.k0 <- divide_carto(carto=Carto_SpainMUN, ID.group="region", k=0)
## Partition + 1st order neighbours ##
carto.k1 <- divide_carto(carto=Carto_SpainMUN, ID.group="region", k=1)
## Partition + 2nd order neighbours ##
carto.k2 <- divide_carto(carto=Carto_SpainMUN, ID.group="region", k=2)
## Plot the spatial polygons for the autonomous region of Castilla y Leon ##
plot(carto.k2$`Castilla y Leon`$geometry, col="dodgerblue4", main="Castilla y Leon")
plot(carto.k1$`Castilla y Leon`$geometry, col="dodgerblue", add=TRUE)
plot(carto.k0$`Castilla y Leon`$geometry, col="lightgrey", add=TRUE)
## End(Not run)
Merge inla objects for partition models
Description
The function takes local models fitted for each subregion of the whole spatial domain and unifies them into a single inla object.
This function is valid for both disjoint and k-order neighbourhood models.
Usage
mergeINLA(
  inla.models = list(),
  k = NULL,
  ID.area = "Area",
  ID.year = NULL,
  ID.disease = NULL,
  O = "O",
  E = "E",
  merge.strategy = "original",
  compute.DIC = TRUE,
  n.sample = 1000,
  compute.fitted.values = FALSE
)
Arguments
| inla.models | list of multiple objects of class  | 
| k | numeric value with the neighbourhood order used for the partition model. If k=0 the Disjoint model is considered. | 
| ID.area | character; name of the variable that contains the IDs of spatial areal units. Default to  | 
| ID.year | character; name of the variable that contains the IDs of time points. Default to  | 
| ID.disease | character; name of the variable that contains the IDs of the diseases. Default to  | 
| O | character; name of the variable that contains the observed number of disease cases for each areal units. Default to  | 
| E | character; name of the variable that contains either the expected number of disease cases or the population at risk for each areal unit. Default to  | 
| merge.strategy | one of either  | 
| compute.DIC | logical value; if  | 
| n.sample | numeric; number of samples to generate from the posterior marginal distribution of the linear predictor when computing approximate DIC/WAIC values. Default to 1000. | 
| compute.fitted.values | logical value (default  | 
Details
If the disjoint model is fitted (k=0 argument), the log-risk surface is just the union of the posterior estimates of each submodel.
 
If the k-order neighbourhood model is fitted (k>0 argument), note that the final log-risk surface \log{\bf r}=(\log{r_1},\ldots,\log{r_{nT}})^{'} is no longer the union of the posterior estimates obtained from each submodel.
Since multiple log-risk estimates can be obtained for some areal-time units from the different local submodel, their posterior estimates must be properly combined to obtain a single posterior distribution for each \log{r_{it}}.
Two different merging strategies could be considered. If the merge.strategy="mixture" argument is specified, mixture distributions of the estimated posterior probability density functions with weights proportional to the conditional predictive ordinates (CPO) are computed.
If the merge.strategy="original" argument is specified (default option), the posterior marginal estimate ot the areal-unit corresponding to the original submodel is selected.
 
See Orozco-Acosta et al. (2021) and Orozco-Acosta et al. (2023) for more details.
Value
This function returns an object of class inla containing the following elements:
| summary.fixed | A data.frame containing the mean, standard deviation and quantiles of the model's fixed effects. This feature is EXPERIMENTAL for the moment. | 
| marginals.fixed | A list containing the posterior marginal density of the model's fixed effects. This feature is EXPERIMENTAL for the moment. | 
| summary.fixed.partition | A data.frame containing the mean, standard deviation and quantiles of the model's fixed effects in each partition. | 
| marginals.fixed.partition | A list containing the posterior marginal density of the model's fixed effects in each partition. | 
| summary.random | If  | 
| marginals.random | If  | 
| summary.linear.predictor | If  | 
| marginals.linear.predictor | If  | 
| summary.fitted.values | A data.frame containing the mean, standard deviation, quantiles, mode and cdf of the risks (or rates) in the model. Available only if  | 
| marginals.fitted.values | A list containing the posterior marginal densities of the risks (or rates) in the model. Available only if  | 
| summary.cor | A data.frame containing the mean, standard deviation, quantiles and mode of the between-disease correlation coefficients. Only for the multivariate spatial models fitted using the  | 
| marginals.cor | A list containing the posterior marginal densities of the between-disease correlation coefficients. Only for the multivariate spatial models fitted using the  | 
| summary.cor.partition | A data.frame containing the mean, standard deviation, quantiles and mode of the between-disease correlation coefficients in each partition. Only for the multivariate spatial models fitted using the  | 
| marginals.cor.partition | A list containing the posterior marginal densities of the between-disease correlation coefficients in each partition. Only for the multivariate spatial models fitted using the  | 
| summary.var | A data.frame containing the mean, standard deviation, quantiles and mode of the within-disease variances for each disease. Only for the multivariate spatial models fitted using the  | 
| marginals.var | A list containing the posterior marginal densities of the within-disease variances for each disease. Only for the multivariate spatial models fitted using the  | 
| summary.var.partition | A data.frame containing the mean, standard deviation, quantiles and mode of the within-disease variances in each partition. Only for the multivariate spatial models fitted using the  | 
| marginals.var.partition | A list containing the posterior marginal densities of the within-disease variances in each partition. Only for the multivariate spatial models fitted using the  | 
| logfile | A list of the log files of each submodel. | 
| version | A list containing information about the R-INLA version. | 
| cpu.used | The sum of cpu times used by the  | 
Examples
## See the vignettes accompanying this package ##
Define a random partition of the spatial domain based on a regular grid
Description
The function takes an object of class SpatialPolygonsDataFrame or sf and
defines a random partition of the spatial polygons based on a regular grid over the whole domain
using the st_make_grid function of the sf package.
Usage
random_partition(
  carto,
  rows = 3,
  columns = 3,
  min.size = 50,
  max.size = 1000,
  prop.zero = NULL,
  O = NULL
)
Arguments
| carto | object of class  | 
| rows | integer; number of rows to define the regular grid. Default to 3. | 
| columns | integer; number of columns to define the regular grid. Default to 3. | 
| min.size | numeric; value to fix the minimum number of areas in each spatial partition (if  | 
| max.size | numeric; value to fix the maximum number of areas in each spatial partition (if  | 
| prop.zero | numeric; value between 0 and 1 that indicates the maximum proportion of areas with no cases for each spatial partition. | 
| O | character; name of the variable that contains the observed number of disease cases for each areal units. Only required if  | 
Details
After defining a random partition of the spatial polygons based on a regular grid, the subregions with number of areas smaller than the value given by the min.size are merged to its nearest neighbour.
Then, the subregions with number of areas greater than the value given by the max.size argument are divided.
Finally, if prop.zero argument is set, the subregions with proportion of areas with zero cases below that threshold are merged to its smallest neighbour.
Value
sf object with the original data and a grouping variable named 'ID.group'
Examples
## Not run: 
library(tmap)
tmap4 <- packageVersion("tmap") >= "3.99"
## Load the Spain colorectal cancer mortality data ##
data(Carto_SpainMUN)
## Random partition based on a 3x3 regular grid (with no size restrictions) ##
carto.r1 <- random_partition(carto=Carto_SpainMUN, rows=3, columns=3,
                             min.size=NULL, max.size=NULL)
table(carto.r1$ID.group)
part1 <- aggregate(carto.r1[,"geometry"], by=list(ID.group=carto.r1$ID.group), head)
if(tmap4){
        tm_shape(carto.r1) +
                tm_polygons(fill="ID.group",
                            fill.scale=tm_scale(values="brewer.set3"),
                            fill.legend=tm_legend(frame=FALSE)) +
                tm_shape(part1) + tm_borders(col="black", lwd=2) +
                tm_title(text="3x3 regular grid (with no size restrictions)")
}else{
        tm_shape(carto.r1) +
                tm_polygons(col="ID.group") +
                tm_shape(part1) + tm_borders(col="black", lwd=2) +
                tm_layout(main.title="3x3 regular grid (with no size restrictions)",
                          main.title.position="center", main.title.size=1,
                          legend.outside=TRUE)
}
## Random partition based on a 6x4 regular grid (with size restrictions) ##
carto.r2 <- random_partition(carto=Carto_SpainMUN, rows=6, columns=4,
                             min.size=50, max.size=600)
table(carto.r2$ID.group)
part2 <- aggregate(carto.r2[,"geometry"], by=list(ID.group=carto.r2$ID.group), head)
if(tmap4){
        tm_shape(carto.r2) +
                tm_polygons(fill="ID.group",
                            fill.scale=tm_scale(values="brewer.set3"),
                            fill.legend=tm_legend(frame=FALSE)) +
                tm_shape(part2) + tm_borders(col="black", lwd=2) +
                tm_title(text="6x4 regular grid (min.size=50, max.size=600)")
}else{
        tm_shape(carto.r2) +
                tm_polygons(col="ID.group") +
                tm_shape(part2) + tm_borders(col="black", lwd=2) +
                tm_layout(main.title="6x4 regular grid (min.size=50, max.size=600)",
                          main.title.position="center", main.title.size=1,
                          legend.outside=TRUE)
}
## Random partition based on a 6x4 regular grid (with size and proportion of zero restrictions) ##
carto.r3 <- random_partition(carto=Carto_SpainMUN, rows=6, columns=4,
                             min.size=50, max.size=600, prop.zero=0.5, O="obs")
table(carto.r3$ID.group)
part3 <- aggregate(carto.r3[,"geometry"], by=list(ID.group=carto.r3$ID.group), head)
if(tmap4){
        tm_shape(carto.r3) +
                tm_polygons(fill="ID.group",
                            fill.scale=tm_scale(values="brewer.set3"),
                            fill.legend=tm_legend(frame=FALSE)) +
                tm_shape(part3) + tm_borders(col="black", lwd=2) +
                tm_title(text="6x4 regular grid (min.size=50, max.size=600, prop.zero=0.5)")
}else{
        tm_shape(carto.r3) +
                tm_polygons(col="ID.group") +
                tm_shape(part3) + tm_borders(col="black", lwd=2) +
                tm_layout(main.title="6x4 regular grid (min.size=50, max.size=600, prop.zero=0.5)",
                          main.title.position="center", main.title.size=1,
                          legend.outside=TRUE)
}
## End(Not run)