| Title: | Continuous Time Distance-Based and Network-Based Individual Level Models for Epidemics | 
| Version: | 1.1.8 | 
| Date: | 2025-09-23 | 
| Author: | Waleed Almutiry [aut, cre], Rob Deardon [aut, ths], Vineetha Warriyar K. V. [ctb] | 
| Maintainer: | Waleed Almutiry <wkmtierie@qu.edu.sa> | 
| Description: | Provides tools for simulating from continuous-time individual level models of disease transmission, and carrying out infectious disease data analyses with the same models. The epidemic models considered are distance-based and/or contact network-based models within Susceptible-Infectious-Removed (SIR) or Susceptible-Infectious-Notified-Removed (SINR) compartmental frameworks. <doi:10.18637/jss.v098.i10>. | 
| Depends: | graphics, stats, utils, coda, parallel, R (≥ 3.5.0) | 
| Imports: | methods, igraph | 
| License: | GPL-2 | GPL-3 [expanded from: GPL (≥ 2)] | 
| URL: | https://github.com/waleedalmutiry/EpiILMCT/ | 
| NeedsCompilation: | yes | 
| Packaged: | 2025-09-23 19:42:40 UTC; walee | 
| Repository: | CRAN | 
| Date/Publication: | 2025-09-23 22:40:29 UTC | 
Simulated epidemic data set from a network-based SIR ILM
Description
This is a simulated epidemic data set of population size = 50 individuals that was generated using a network-based SIR individual-level model (ILM) with a contact network that was generated using the power-law model with parameters \beta=1.8 and \alpha=1. The model has one binary susceptible covariate and the infectivity rate is given by:
\lambda_{jt} = (\alpha_{0} + \alpha_{1}z_{j}) \sum_{i \in I_{t}}{c_{ij}}
The infectious period follows a gamma distribution \Gamma(4,\delta). The epidemic was simulated with the following parameter values: \alpha_{0} = 0.08, \alpha_{1} = 0.5 and \delta=2.
The data set file is a list of an object of class "datagen" that contains of type, kerneltype, epidat, location and network, and the covariate matrix.
Usage
data(NetworkData)Format
It is a list of an object of class “datagen” that contains the following:
- type:
- 
The “SIR” compartmental framework. 
- kerneltype:
- 
The “network” kernel function. 
- epidat:
- 
A matrix of the simulated epidemic with four columns as: the id numbers of individuals, removal times, infectious periods, and infection times. 
- location:
- 
A matrix of the XY coordinates of individuals. 
- network:
- 
The undirected binary contact network matrix. 
and a 50 \times 2 matrix of the covariates represents the unity intercept and the binary covariate z.
Simulated epidemic data set from a network-based SINR ILM
Description
This is a simulated epidemic data set of population size = 50 individuals that was generated using a network-based SINR individual-level model (ILM) with a contact network that was generated using the power-law model with parameters \beta=1.8 and \alpha=1. The model has one binary susceptible covariate and the infectivity rate is given by:
\lambda_{jt} = (\alpha_{0} + \alpha_{1}z_{j}) [\sum_{i: \in I_{t}}{c_{ij}}+ \gamma \sum_{i: \in N_{t}}{c_{ij}}]
The incubation period is assumed to follow a gamma distribution \Gamma(4,\delta^{(inc)}), and the delay period is assumed to follow an exponential distribution \delta^{(delay)}. The epidemic was simulated with the following parameter values: \alpha_{0} = 0.08, \alpha_{1} = 2, \gamma = 1, \delta^{(inc)}=2 and \delta^{(delay)}=2.
The data set file contains the XY coordinates of individuals, the contact network matrix, the covariate matrix and the simulated epidemic data.
Usage
data(NetworkDataSINR)Format
A list of the simulated data:
- loc
- 
The XY coordinates of individuals. 
- net
- 
The undirected binary contact network matrix. 
- cov
- 
A matrix of two columns represents the unity intercept and the binary covariate z. 
- epi
- 
The simulated epidemic with six columns as: the id numbers of individuals, removal times, delay periods, notification times, incubation periods, and infection times. 
Simulated epidemic data set from a distance-based SIR ILM
Description
This is a simulated epidemic data set of population size = 50 individuals that was generated using a distance-based SIR individual-level model (ILM) with power-law distance kernel. The model has no susceptible covariates and the infectivity rate is given by:
\lambda_{jt} = \alpha_{0} \sum_{i \in I_{t}}{d_{ij}^{-\beta}}
The infectious period is assumed to follow an exponential distribution with rate \lambda. The epidemic was simulated with the following parameter values: \alpha_{0} = 2.0, \beta = 3 and \delta = 2. 
The data set file is an object of class "datagen" that has a list of type, kerneltype, epidat and location.
Usage
data(SpatialData)Format
An object of class “datagen” that contains the following:
- type:
- 
The “SIR” compartmental framework. 
- kerneltype:
- 
The “distance” kernel function. 
- epidat:
- 
A matrix of the simulated epidemic with four columns as: the id numbers of individuals, removal times, infectious periods, and infection times. 
- location:
- 
A matrix of the XY coordinates of individuals. 
- network:
- 
A zero matrix of contact network. 
Simulated epidemic data set from a distance and network-based SIR ILM
Description
This is a simulated epidemic data set of population size = 50 individuals that was generated using a combined distance and network-based SIR individual-level model (ILM) with power-law distance kernel. The model has one binary susceptible covariate and the infectivity rate is given by:
\lambda_{jt} = (\alpha_{0} + \alpha_{1}z_{j}) \sum_{i \in I_{t}}{d_{ij}^{-\beta_{1}}+\beta_{2}c_{ij}}
The infectious period is assumed to follow an exponential distribution with rate \delta. The epidemic was simulated with the following parameter values: \alpha_{0} = 0.008, \alpha_{1} = 0.2, \beta_{1} = 2, \beta_{2} = 0.5 and \delta = 2. 
The data set file is a list of an object of class "datagen" that contains of type, kerneltype, epidat, location and network, and the covariate matrix.
Usage
data(SpatialNetData)Format
It is a list of an object of class “datagen” that contains the following:
- type:
- 
The “SIR” compartmental framework. 
- kerneltype:
- 
The “both” distance and network kernel functions. 
- epidat:
- 
A matrix of the simulated epidemic with four columns as: the id numbers of individuals, removal times, infectious periods, and infection times. 
- location:
- 
A matrix of the XY coordinates of individuals. 
- network:
- 
The undirected binary contact network matrix. 
and a 50 \times 2 matrix of the covariates represents the unity intercept and the binary covariate z.
Continuous Time level information of an Epidemic
Description
The function as.epidat is used to generate objects of class "datagen". These objects contain the individual event history of an epidemic along with other individual level information. The output of this function provides information required to fit continuous time individual level models.
Usage
  as.epidat(type, kerneltype, incub.time = NULL, inf.time, rem.time,
  id.individual, location = NULL, network = NULL, network.type = NULL)
Arguments
| type | type of compartmental framework, with the choice of “SIR” for Susceptible-Infectious-Removed and “SINR” for Susceptible-Infectious-Notified-Removed. | 
| kerneltype | type of kernel function with choice of “distance” for a distance-based ILM, “network” for a contact network-based ILM and “both” for a combination of network- and distance-based ILM. | 
| incub.time | a vector of the incubation times of individuals. It is required when  | 
| inf.time | a vector of the infection times of individuals. | 
| rem.time | a vector of the removal times of individuals. | 
| id.individual | a vector of the id number of individuals. | 
| location | a matrix of the XY coordinates of individuals. It is required when  | 
| network | a contact network matrix. It is required when  | 
| network.type | type of the contact network model, see the argument  | 
Details
The id.individual is used here to relate individuals to their corresponding row numbers of the location, and contact network, matrices. The elements of the incub.time, inf.time, and rem.time vectors must be in sync with those elements of the id.individual vector. Then, each individual will have an id number and corresponding event times. Any mistake in entering these vectors can seriously affect the use of other functions like epictmcmc and plot.datagen which can highly lead to incorrect results and conclusion.
Value
A class of “datagen” which has a list of type, kerneltype, a sorted matrix of the epidemic with respect to the infection times in ascending order, the XY coordinates of individuals, and/or the contact network.  
See Also
epictmcmc, datagen, plot.datagen.
Examples
# Just for illustation:
# SIR distance-based ILM for a population of 10 individuals:
loc <- cbind(runif(10, 0, 10), runif(10,0,10))
net <- contactnet(type = "random", num.id = 10, location = loc, beta = 0.3)
infection <- c(2.5, 1, 0, 0, 0.5, 0, 2, 1.5, 0, 3)
removal <- c(3.5, 2, 0, 1, 1.5, 0, 3, 2.5, 0, 4)
id <- c(2, 1, 4, 7, 10, 3, 5, 9, 8, 6)
epi <- as.epidat(type = "SIR", kerneltype = "distance", inf.time = infection,
rem.time = removal, id.individual = id, location = loc)
epi
# using the data set generated by using the SINR network-based ILM:
data(NetworkDataSINR)
names(NetworkDataSINR)
netSINR<-as.epidat(type = "SINR", kerneltype = "network", 
incub.time = NetworkDataSINR$epi[,4], inf.time = NetworkDataSINR$epi[,6], 
rem.time = NetworkDataSINR$epi[,2], id.individual = NetworkDataSINR$epi[,1], 
location  = NetworkDataSINR$loc, network = NetworkDataSINR$net, 
network.type = "powerlaw")
names(netSINR)
plot(netSINR, plottype = "history")
netSIR<-as.epidat(type = "SIR", kerneltype = "network", 
inf.time = NetworkDataSINR$epi[,6], rem.time = NetworkDataSINR$epi[,2], 
id.individual = NetworkDataSINR$epi[,1], location  = NetworkDataSINR$loc, 
network = NetworkDataSINR$net, network.type = "powerlaw")
names(netSIR)
plot(netSIR, plottype = "history")
Generate binary adjacency matrix contact networks
Description
This function allows the user to generate contact network with binary adjacency matrices from spatial (power-law or Cauchy) and random network models.
Usage
contactnet(type, num.id = NULL, location = NULL, beta, nu = NULL)
Arguments
| type | type of contact network model, with the choice of “powerlaw” for the power-law model, “Cauchy” for the Cauchy model, and “random” for randomly generated contact network from a Bernoulli distribution with parameter beta. | 
| num.id | the number of individuals (nodes). It has to be specified when  | 
| location | a matrix of the XY coordinates of individuals. Required when  | 
| beta | spatial parameter of the spatial contact network model or probability parameter of the random network model (>0). | 
| nu | scale parameter of the power-law contact network model (>0). Default value is 1. | 
Details
The contact networks considered here are undirected, “unweighted” and have binary adjacency matrix, so that c_{ij}=c_{ji} for i \ne j; i,j = 1,..,N, and each element of the contact network is defined as c_{ij} = 1 if a connection exist between individuals i and j, and 0 otherwise. We can either generate spatial networks which have connections more likely to be present between two individuals closed together than far apart, or random contact networks. 
For spatial contact networks, there are two options of specifying the model for the probability of connections between individuals. We use a generalized version of the power-law contact network model of Bifolchi et al. (2013) for the first option, in which
the probability of a connection between individuals i and j is given by:
p(c_{ij}=1) = 1- e^{-\nu(d_{ij}^{-\beta})} , \quad \nu, \beta > 0,
where d_{ij} is the Euclidean distance between individuals i and j; \beta is the spatial parameter; and \nu is the scale parameter. 
The second option is a Cauchy model as used in Jewell et al., (2009). The probability of a connection between individuals i and j is given by:
p(c_{ij}=1) = 1- e^{-\beta/(d_{ij}^{2} + \beta^{2})} , \quad \beta > 0,
where d_{ij} is the Euclidean distance between individual i and j; and \beta is the spatial parameter.
The final option is a random contact network in which the probability of a connection is generated from a Bernoulli distribution with probability equal to \beta.
Value
An object of class “contactnet” that has a list of:
- location:
- A matrix of the XY coordinates of individuals. 
- contact.network:
- Binary contact network adjacency matrix. 
- type:
- The type of contact network model. 
References
Jewell, C. P., Kypraios, T., Neal, P., and Roberts, G. O. (2009). Bayesian analysis for emerging infectious diseases. Bayesian Analysis, 4(3):465-496.
Bifolchi, N., Deardon, R., and Feng, Z. (2013). Spatial approximations of network-based individual level infectious disease models. Spatial and Spatio-temporal Epidemiology, 6:59-70.
Examples
set.seed(12345)
loc<- matrix(cbind(runif(50, 0, 10),runif(50, 0, 10)), ncol = 2, nrow = 50)
net1<- contactnet(type = "powerlaw", location = loc, beta = 1.5, nu = 0.5)
net2<- contactnet(type = "Cauchy", location = loc, beta = 0.5)
net3<- contactnet(type = "random", num.id = 50, beta = 0.08)
Generate epidemics from distance-based and/or network-based continuous-time ILMs.
Description
Generate epidemics from distance-based and/or network-based ILMs.
Usage
datagen(type, kerneltype, kernelmatrix, distancekernel = NULL,
initialepi = NULL, tmax = NULL, suspar = NULL, transpar = NULL,
powersus = NULL, powertrans = NULL, kernel.par = NULL, spark = NULL,
gamma = NULL, delta, suscov = NULL, transcov = NULL)
Arguments
| type | type of compartmental framework, with the choice of “SIR” for Susceptible-Infectious-Removed and “SINR” for Susceptible-Infectious-Notified-Removed. | 
| kerneltype | type of kernel function with choice of “distance” for a distance-based ILM, “network” for a contact network-based ILM and “both” for a combination of network- and distance-based ILM. | 
| kernelmatrix | a matrix of the XY coordinates of individuals when  | 
| distancekernel | the spatial kernel type when  | 
| initialepi | a matrix of the initial  | 
| tmax | the time at which the epidemic simulation ends. If not set the simulation is run until the epidemic dies out or all individuals are infected and then enter the removed state. | 
| suspar | parameter(s) for the susceptibility function (>0). Default value(s) is 1. | 
| transpar | parameter(s) for the transmissibility function (>0). Default value(s) is 1. | 
| powersus | the power parameter(s) of the susceptibility function (>0). Default value(s) is 1. | 
| powertrans | the power parameter(s) of the transmissibility function (>0). Default value(s) is 1. | 
| kernel.par | a scalar spatial parameter when  | 
| spark | spark parameter (>=0), representing random infections that are unexplained by other parts of the model. Default value is 0. | 
| gamma | the notification effect parameter for SINR model. The default value is 1. | 
| delta | a vector of the shape and rate parameters of the gamma-distributed infectious period (SIR) or a  | 
| suscov | covariate matrix of the susceptibility function, representing each covariate in a column. If intercept exists or in the case of no covariates, the first column is set to unity. | 
| transcov | covariate matrix of the transmissibility function, representing each covariate in a column. If intercept exists or in the case of no covariates, the first column is set to unity. | 
Details
We consider the simulation of epidemics from continuous-time ILMs in the following way. Each infected individual has an infection life history defined by their time of infection and the length of time spent in the infectious state. We are assuming the conditional intensity functions stay constant between events, so that the time to the next infected individual, given that the last infection occurred at time t, is given by the minimum W_{j} \sim Exp(\lambda_{jt}), where W_{j} represents the “waiting time” for susceptible individual j becoming infected.
Under both SIR and SINR ILMs option, an epidemic is simulated using the specified model starting with a randomly chosen infected individual k at time I_{1}, or as specified via the initialepi option. Under the SIR model, the rate of infection of each susceptible individual j at time t \in \rm I\!R^{+} follows the framework of Deardon et al. (2010):
 
where \mathcal{I}(t) is the set of infectious individual at time t. Under the SINR model, the rate of infection of each susceptible individual j at time t follows Jewell et al. (2009):
 
where \mathcal{N}^{-}{(t)} is the set of infectious individual at time t who have been infected but have not reached the notified state; \mathcal{N}^{+}{(t)} is the set of infectious individual at time t who have been infected and reached the notified state; \gamma is the notification effect parameter usually allowing for infectious risk reduction after notification (Jewell et al., 2009); \Omega_{S}(j) is a function of risk factors associated with susceptible individual j (i.e., susceptibility); and \Omega_{T}(i) is a function of risk factors associated with infectious individual i (i.e., transmissibility). The \Omega_{S}(j) and \Omega_{T}(i) are defined as:
 
where \mathbf{S} and \mathbf{T} are the parameters vectors of the susceptibility and transmissibility functions, respectively; \mathbf{X} and \mathbf{Z} are the susceptibility and transmissibility risk factor matrices, respectively; and \phi and \xi are vectors of the power parameters of the susceptibility and transmissibility functions, respectively. These power parameters allow for nonlinear relationships between the susceptibility and transmissibility risk factors and the infection rate (Deardon et al., 2010).
The infection kernel \kappa(i,j) allows for distance (spatial) and/or contact network-based mechanisms. In distance-based models, the kernel function \kappa(i,j) is a power-law or Cauchy function of distance. In network-based models, the kernel function \kappa(i,j) is the contact network elements (binary (c_{ij}) or weighted (w_{ij})). In both distance-network-based models, the kernel function \kappa(i,j) is represented by two terms: (1) spatial function, and (2) the contact network.
The optional kernel function formulae are as follows:
-  Distance-based ILMs: - Power-law spatial kernel: - \kappa(i,j) = d_{ij}^{-\beta}
- Cauchy spatial kernel: - \kappa(i,j) = \frac{\beta}{d_{ij}^{2}+\beta^{2}}
 
-  Network-based ILMs: -  \kappa(i,j) = c_{ij}for binary contact network or,
-  \kappa(i,j) = w_{ij}for weighted contact network.
 
-  
-  Both distance- and network-based ILMs: - With power-law spatial kernel: -  \kappa(i,j) = d_{ij}^{-\beta_{1}} +\beta_{2}c_{ij}with binary contact network or,
-  \kappa(i,j) = d_{ij}^{-\beta_{1}} +\beta_{2}w_{ij}with weighted contact network.
 
-  
- With Cauchy spatial kernel: -  \kappa(i,j) = \frac{\beta_{1}}{(d_{ij}^{2}+\beta_{1}^{2})} + \beta_{2}c_{ij}with binary contact network or,
-  \kappa(i,j) = \frac{\beta_{1}}{(d_{ij}^{2}+\beta_{1}^{2})} + \beta_{2}w_{ij}with weighted contact network.
 
-  
 
At time I_{s}, the waiting time until being infected is drawn for each susceptible individual j from W_{j} \sim Exp(\lambda_{jI_{s}}). The individual with minimum W is chosen as the next infected individual, and assigned infection time I_{s+1} = I_{s}+min(W_{j}). Under SIR model, this newly-infected individual is also assigned an infectious period D_{j} generated from the infectious period (exponential  or gamma) distribution f(D_{j};\delta). Thus, its removal time becomes R_{s+1} = I_{s+1}+D_{j}. Under SINR model, each infected individual is assigned an incubation period defining the time from infection to notification, and a delay period defining the time from notification to removal. Thus, this newly-infected individual is assigned an incubation and delay period D^{(inc)}_{j} and D^{(delay)}_{j}, generated from the (exponential  or gamma) incubation and delay periods distributions f(D^{(inc)}_{j};\delta^{(inc)}) and f(D^{(delay)}_{j};\delta^{(delay)}), respectively. Thus, its notification and removal times become N_{s+1} = I_{s+1}+D^{(inc)}_{j} and R_{s+1} = N_{s+1}+D^{(delay)}_{j}, respectively. The process is repeated until no infectives remain in the population, or until I_{s+1} > tmax if it is specified.
Value
The function datagen returns objects of class “datagen” containing the following:
- type:
- The specified type of the compartmental framework. 
- kerneltype:
- The specified type of the kernel function. 
- epidat:
- Under an SIR ILM, it is a matrix with four columns representing the id numbers of the individuals, removal times, infectious periods, and infection times, respectively. Under an SINR ILM, it is a matrix with six columns: the id numbers of the individuals, removal times, delay periods, notification times, incubation periods, and infection times. Uninfected individuals are assigned infinity values - (\infty)for both their removal and infection times. Note that the rows of- epidatis sorted according to the infection times in ascending order. The id numbers of the individuals is used here to respresnt the corresponding row number of- location, contact- network, and covariate matrices.
- location:
- A matrix of the XY coordinates of individuals if it is given in the function, otherwise, a zero matrix. 
- network:
- The contact network matrix if it is given in the function. 
References
Jewell, C. P., Kypraios, T., Neal, P., and Roberts, G. O. (2009). Bayesian analysis for emerging infectious diseases. Bayesian Analysis, 4(3):465-496.
Deardon, R., Brooks, S. P., Grenfell, B. T., Keeling, M. J., Tildesley, M. J., Savill, N. J., Shaw, D. J., and Woolhouse, M. E. (2010). Inference for individual-level models of infectious diseases in large populations. Statistica Sinica, 20(1):239.
See Also
loglikelihoodepiILM, contactnet, plot.datagen.
Examples
set.seed(3245)
loc<- matrix(cbind(runif(100, 1, 100),runif(100, 1, 100)), ncol = 2, nrow = 100)
net1<- contactnet(type = "powerlaw", location = loc, beta = 0.9)
cov <- cbind(rep(1, 100), runif(100, 1, 50))
#To simulate the epidemic using the network kernel:
epi.net <- datagen(type = "SIR", kerneltype = "network",
               kernelmatrix = net1, suspar = c(0.08, 0.05),
               delta = c(4, 2), suscov = cov)
#To simulate the epidemic using the distance kernel:
epi.dis <- datagen(type = "SIR", kerneltype = "distance",
               distancekernel = "powerlaw", kernelmatrix = loc,
               suspar = c(0.8, 0.5), kernel.par = 2,
               delta = c(4, 2), suscov = cov)
Markov Chain Monte Carlo-based tool for analyzing (SIR/SINR) distance-based/network-based individual-level disease data.
Description
Runs a Bayesian data augmented MCMC algorithm for fitting specified models (SIR or SINR) with three possible assumptions regarding the data set: 1. a completely observed epidemic; 2. unknown infection times but known removal times; or 3. unknown removal and infection times but known notification times (SINR only).
Usage
epictmcmc(object, distancekernel = NULL, datatype, blockupdate = NULL, nsim,
nchains = NULL, control.sus = NULL, control.trans = NULL, kernel.par = NULL,
spark.par = NULL, delta = NULL, gamma.par = NULL, periodproposal = NULL,
parallel = FALSE)
Arguments
| object | an object of class “datagen” that can be the output of  | 
| distancekernel | the spatial kernel type when  | 
| datatype | the ILM data set is analyzed based on three possible assumptions. The possible assumptions are “known epidemic” for a completely observed epidemic; “known removal” times for observing only the removal times for the SIR model, or removal and notified times for the SINR model; or “unknown removal” times for observing only the notified times which is applicable only when fitting the SINR model. | 
| blockupdate | a vector of the number of initially observed infection times and the size of blocks for updating the infection times/infectious periods (SIR model), or infection times/incubation periods and removal times/delay periods (SINR model). The default is observing only the first infection time and performing the MCMC updating infection time parameters via single parameter updates. | 
| nsim | the number of MCMC iterations to be carried out for a single chain. | 
| nchains | the number of MCMC chains to be run. Default is 1 (a single MCMC chain). | 
| control.sus | a list of arguments for updating the parameters of the susceptibility function (>0): 
 where  | 
| control.trans | a list of arguments with the same structure as  | 
| kernel.par | a list of arguments for updating the spatial parameter of the distance-based kernel. The first argument is a vector of initial values of the spatial parameter when  | 
| spark.par | a list of arguments for updating the spark parameter (>=0). The first argument is a vector of the initial values. The second argument is a vector of the required arguments for updating the spark parameter. It should be defined if  | 
| delta | a list of arguments for updating the infectious period rate for an SIR model, or for updating the incubation and delay periods rates for an SINR model (>0). The arguments for updating each rate are a vector of the fixed and known shape parameter(s) for the distribution of the period type, a vector (matrix) of initial values of the rate(s) of the infectious, incubation and/or delay period distributions, and a vector (matrix) of the shape and rate parameters of the gamma prior distribution for the rate parameter(s). Default = NULL means these parameters do not need to be updated, which is the case when  | 
| gamma.par | a list of arguments for updating the notification effect parameter (SINR) (>=0). The first argument is a vector of initial values. The second argument is a vector of the required arguments for updating the notification effect parameter. Default = NULL means the parameter is not updated and is assigned a value equal to 1. See details for a description of required arguments. | 
| periodproposal | a vector/matrix of the proposal distribution parameters of the independence sampler for updating the infectious period (SIR model), or the incubation and/or delay periods (SINR model). Here, we use a gamma proposal distribution. It is required when  | 
| parallel | if set to “TRUE”, multiple MCMC chains are running in parallel. Default is “FALSE” means chains (>1) are run sequentially. | 
Details
Bayesian MCMC is performed to obtain posterior estimates of the model parameters and latent variables. When the datatype is set to “known removal” or “unknown removal”, we assume the infectious periods (SIR model) or the incubation and/or delay periods (SINR model) follow gamma distributions with fixed shape and unknown rate parameters. We assign a gamma prior distribution for the rate parameter with shape a and rate b. This leads the rate parameter(s) to have a gamma conditional distribution.
Under the SIR model, the conditional distribution is:
 \delta|\theta,\boldsymbol{I},\boldsymbol{R} \sim \Gamma(m+a_{\delta},M+b_{\delta}), 
where \delta is the rate of the infectious period distribution; m is the number of infected individuals; M=\sum_{i=1}^{m}{(R_{i}-I_{i})}; and a_{\delta} and b_{\delta} are the prior parameters for the infectious period rate, respectively.
Under the SINR model, the conditional distribution is:
 \delta^{(inc)}|\theta,\boldsymbol{I},\boldsymbol{N},\boldsymbol{R} \sim \Gamma(m+a_{\delta^{(inc)}},M_{inc}+b_{\delta^{(inc)}}),
where \delta^{(inc)} is the rate of the incubation period distribution; M_{inc}=\sum_{i=1}^{m}{(N_{i}-I_{i})}; and a_{\delta^{(inc)}} and b_{\delta^{(inc)}} are the prior parameters for the incubation period rate, respectively; and
 \delta^{(delay)}|\theta,\boldsymbol{I},\boldsymbol{N},\boldsymbol{R} \sim \Gamma(m+a_{\delta^{(delay)}},M_{delay}+b_{\delta^{(delay)}}),
where \delta^{(delay)} is the rate parameter of the delay period distribution; M_{delay}=\sum_{i=1}^{m}{(R_{i}-N_{i})}; and a_{\delta^{(delay)}} and b_{\delta^{(delay)}} are the prior parameters for the delay period rate, respectively.
A Gibbs update (i.e., sampling from the conditional posterior distribution) is then used for the infectious period (SIR model) or the incubation and/or delay period rates (SINR model). The required information for each period distribution are entered via the delta argument. We assume each period type follows a gamma distribution with fixed shape and unknown rate. Thus, to update the rate parameter of each period, delta is a list containing a vector of the fixed shape value(s), a vector (matrix) of the initial values of the rate(s), and a vector (matrix) of the parameters of the prior distribution of the rate parameter(s). In the case of incubation and delay periods being estimated, the input of the initial values is a 2 \times \code{nchains} matrix, and the prior parameters are given by a 2 \times 2 matrix in which each row contains the required information for each period rate.
An independence sampler is used for updating the infection times and infectious periods (SIR model), or the infection and/or removal times, and the incubation and/or delay periods (SINR model). Under the SIR model, we update each infection time I_{i} by proposing infectious period D^{*}_{i} from a proposal distribution with tuning parameter, such that D_{i}\sim f(.). Then, the new infection time is just the difference between the fixed known removal time and the new infectious period of the i^{th} individual. Each infection time/infectious period is updated in this way in turn. The same procedure is applied for updating the missing event times and incubation and delay periods for the SINR model, with their corresponding parameters.
The control.sus and control.trans arguments provide all the information needed for the susceptibility and transmissibility functions. These arguments must be defined as a list of three objects. The first object is a list of: 1) a vector or matrix of initial values; and 2) a vector or matrix of the following arguments in order: initial value, prior distribution ("gamma", (positive) "half normal" or "uniform"), a vector of the prior distribution parameters, and the proposal variance. The second object is a matrix of the susceptibility or transmissibility risk factors. The third contains the power parameters of the susceptibility or transmissibility functions and has the same structure as the first object. The other model parameters kernel.par, spark.par and gamma.par also have the same structure as the first object. These model parameters, along with the model parameters of the susceptibility and transmissibility functions (control.sus and control.trans), are updated in turn using a random-walk Metropolis Hastings algorithm with normal proposals. The normal proposals must be tuned, via the proposal variance, by the user to achieve good mixing properties.
Note that, setting the variance of the normal proposal distribution to zero fixes a parameter at its initial value. This option allows the user to fix such a parameter in the MCMC procedure while updating others.
For faster run of the epictmcmc function, an option of running multiple chains on parallel can be performed, controlled via the two options nchains and parallel. If parallel is set to TRUE, the number of required cores is set to the minimum of nchains and the number of available cores on the user's computer.
Value
Returns an object of class epictmcmc that contains:
- compart.framework:
- the compartmental framework model used in the analysis. 
- kernel.type:
- the used - kernel.typein the function.
- data.assumption:
- the - datatype.
- parameter.samples:
- the MCMC output of the updated model parameters. 
- log.posterior:
- the log posterior densities. 
- acceptance.rate:
- the acceptance rates for MCMC updates of each parameter. 
- number.iteration:
- the number of iterations. 
- number.parameter:
- the number of the unknown model parameters. 
- number.chains:
- the number of the MCMC chains. 
- infection.times.samples:
- the updated infection times when - datatypeis set to “known removal”.
- Average.infectious.periods:
- the average infectious period when - typeis set to “SIR” and- datatypeis set to “known removal”.
- removal.times.samples:
- the updated removal times when - datatypeis set to “unknown removal”.
- Average.incubation.periods:
- the average incubation period when - typeis set to “SINR” and- datatypeis set to either “known removal” or “unknown removal”.
- Average.delay.periods:
- the average delay period when - typeis set to “SINR” and- datatypeis set to “unknown removal”.
See Also
print.epictmcmc, summary.epictmcmc, plot.epictmcmc, datagen, loglikelihoodepiILM.
Examples
## This is for testing; the number of MCMC iterations needs to be
## mucher higher in practice.
## distance-based SIR continuous-time ILMs ##
data(SpatialData)
## performing the MCMC-tool for analyzing the fully observed spatial data
## under the SIR distance-based continuous ILM:
suspar <- list(NULL)
suspar[[1]] <- list(2, c("gamma", 1, 0.01, 0.5))
suspar[[2]] <- rep(1, length(SpatialData$epidat[,1]))
kernel1 <- list(2, c("gamma", 1, 0.01, 0.5))
mcmcres2 <- epictmcmc(object = SpatialData,
distancekernel = "powerlaw", datatype = "known epidemic", nsim = 50,
control.sus = suspar, kernel.par = kernel1)
summary(mcmcres2)
## performing the MCMC-tool for analyzing the partially observed spatial
## data (unknown infection times) under the SIR distance-based
## continuous ILM:
suspar <- list(NULL)
suspar[[1]]<-list(2,c("gamma", 1, 0.01, 0.8))
suspar[[2]]<- rep(1,length(SpatialData$epidat[,1]))
kernel1 <- list(2, c("gamma", 1, 0.01, 0.5))
mcmcres22 <- epictmcmc(object = SpatialData,
distancekernel = "powerlaw", datatype = "known removal", nsim = 50,
control.sus = suspar, kernel.par = kernel1, delta = list(1,2,c(4,2)))
summary(mcmcres22)
## distance-based and network-based SIR ILMs ##
data(SpatialNetData)
## performing the MCMC-tool for analyzing the fully observed spatial and
## network data under the SIR distance-based and network-based
## continuous-time ILM:
suspar <- list(NULL)
suspar[[1]] <- list(NULL)
suspar[[1]][[1]] <- c(0.08, 0.2)
suspar[[1]][[2]] <- matrix(c("gamma", "gamma", 1, 1, 0.01, 0.01, 0.1, 0.5),
ncol = 4, nrow = 2)
suspar[[2]] <- SpatialNetData[[2]]
kernel1 <- list(NULL)
kernel1[[1]] <- c(5, 0.5)
kernel1[[2]] <- matrix(c("gamma", "gamma", 1, 1, 0.01, 0.01, 0.5, 1),
ncol = 4, nrow = 2)
mcmcres3 <- epictmcmc(object = SpatialNetData[[1]],
distancekernel = "powerlaw", datatype = "known epidemic", nsim = 50,
control.sus = suspar, kernel.par = kernel1)
summary(mcmcres3)
## network-based SIR ILMs ##
data(NetworkData)
## performing the MCMC-tool for analyzing the fully observed network data
## under the SIR network-based continuous-time ILM:
suspar <- list(NULL)
suspar[[1]] <- list(NULL)
suspar[[1]][[1]] <- c(0.08, 0.5)
suspar[[1]][[2]] <- matrix(c("gamma", "gamma", 1, 1, 1, 1, 0.1, 0.5),
ncol = 4, nrow = 2)
suspar[[2]] <- NetworkData[[2]]
mcmcres4 <- epictmcmc(object = NetworkData[[1]], datatype = "known epidemic",
nsim = 50, control.sus = suspar)
summary(mcmcres4)
Calculates the log likelihood
Description
Calculates the log likelihood for the specific compartmental framework of the continuous-time ILMs.
Usage
loglikelihoodepiILM(object, distancekernel = NULL, control.sus = NULL,
control.trans = NULL, kernel.par = NULL, spark = NULL, gamma = NULL,
delta = NULL)
Arguments
| object | an object of class “datagen” that can be the output of  | 
| distancekernel | the spatial kernel type when  | 
| control.sus | a list of values of the susceptibility function (>0): 
 where,  | 
| control.trans | it has the same structure as the  | 
| kernel.par | a scalar spatial parameter for the distance-based kernel (>0), or a vector of the spatial and network effect parameters of the network and distance-based kernel (both). It is not required when the  | 
| spark | spark parameter (>=0), representing random infections that are unexplained by other parts of the model. Default value is zero. | 
| gamma | the notification effect parameter for SINR model. The default value is 1. | 
| delta | a vector of the shape and rate parameters of the gamma-distributed infectious period (SIR) or a 2  | 
Details
We label the m infected individuals i = 1, 2, \dots, m corresponding to their infection (I_{i}) and removal (R_{i}) times; whereas the N-m individuals who remain uninfected are labeled i=m+1, m+2, \dots, N with I_{i}= R_{i} = \infty. We then denote infection and removal time vectors for the population as \boldsymbol{I} = \{I_{1}, \dots, I_{m}\} and \boldsymbol{R} = \{R_{1}, \dots, R_{m}\}, respectively. We assume that infectious periods follow a gamma distribution with shape and rate \delta. The likelihood of the general SIR continuous-time ILMs is then given as follows: 
 
 
where \theta is the vector of unknown parameters; f(.;\delta) indicates the density of the infectious period distribution; and D_{i} is the infectious period of infected individual i defined as D_{i}= R_{i}-I_{i}. The likelihood of the general SINR continuous-time ILMs is given by: 
 
 
where D^{inc}_i and D^{delay}_i are the incubation and delay periods such that D^{inc}_i = N_i - I_i and D^{delay}_i = R_i - N_i, and 
\lambda_{ij}^{-} = \Omega_{S}(j) \Omega_{T}(i) \kappa(i,j),
 for i \in I(t), j \in S(t), and
\lambda_{ij}^{+} = \gamma (\Omega_{S}(j) \Omega_{T}(i) \kappa(i,j)),
 for i \in N(t), j \in S(t).
Note, \lambda_{ij}^{+} is used only under the SINR model.	
Value
Returns the log likelihood value.
See Also
contactnet, datagen, epictmcmc.
 Plot the contact network of contactnet object
Description
plot.contactnet is an S3 method that plots the contact network of an S3 object of class contactnet. 
Usage
## S3 method for class 'contactnet'
plot(x, ...)
Arguments
| x | an S3 object of class  | 
| ... | additional arguments that are passed to the generic  | 
Value
Plot of the contact network.
See Also
Examples
set.seed(12345)
loc<- matrix(cbind(runif(50, 0, 10),runif(50, 0, 10)), ncol = 2, nrow = 50)
net1<- contactnet(type = "powerlaw", location = loc, beta = 1.5, nu = 0.5)
plot(net1)
net2<- contactnet(type = "Cauchy", location = loc, beta = 0.5)
plot(net2)
net3<- contactnet(type = "random", num.id = 50, beta = 0.08)
plot(net3)
# adding some options to the igraph plot:
plot(net3, vertex.color = "red", vertex.size = 8, edge.color = "black",
vertex.label.cex = 0.7, vertex.label.color = "black") 
S3 method to plot summary of epidemic.
Description
plot.datagen is an S3 method that provides different plots summarizing epidemic of class datagen.
Usage
## S3 method for class 'datagen'
plot(x, plottype, time.index = NULL, ...)
Arguments
| x | an object that has a class of  | 
| plottype | History or propagation plots of the epidemic. | 
| time.index | used for obtaining propagation plots at specific infection time points rather than at every infection time. A plot at the first time point is included in any chosen set of infection time points. The default is to provide propagation plot at every infection time point. It is not required when  | 
| ... | additional arguments that are passed to the generic  | 
Details
If plottype is set to “history”, the function produces epidemic curves of infection and removal times (SIR model), or infection, notification, and removal times (SINR model). If it is set to “propagation”, the function produces plots of the propagation of epidemic over time based on the setting option of the argument kerneltype. With the network kernel, the function plots all the connections between individuals (in gray) and overlays these with the epidemic pathway direction over time. With the distance kernel, the function plots the epidemic dispersion over time. It shows the changes in the individual status that related to the chosen compartmental framework in type.
Value
plot
See Also
 Plot the output of epictmcmc object
Description
plot.epictmcmc is an S3 method that plots the output of an S3 object of class epictmcmc. 
Usage
## S3 method for class 'epictmcmc'
plot(x, epi = NULL, plottype = NULL, start = NULL, end = NULL, 
thin = NULL, ...)
Arguments
| x | an S3 object of class  | 
| epi | epidemic data of class  | 
| plottype | determines which of three options to plot the output of the  | 
| start,end,thin | options for creating  | 
| ... | additional arguments that are passed to the generic  | 
Value
The argument plottype is used to specify the kind of plot produced. Trace and density plots of the posterior distribution of the model parameters can be obtained by setting plottype = “parameter”. Additionally, in the case of unobserved infection (removal) times, a plot of the average posterior and 95% percentile intervals of the inferred infection (removal) times are produced by setting plottype = “inf.times” (“rem.times”).
See Also
epictmcmc, print.epictmcmc, summary.epictmcmc, mcmc, plot.mcmc.
Prints the contents of an epictmcmc object to the console 
Description
print.epictmcmc is an S3 method that prints the content of an S3 object of class epictmcmc to the console. 
Usage
## S3 method for class 'epictmcmc'
print(x, digits = 6, ...)
Arguments
| x | an S3 object of class  | 
| digits | the number of printed digits of the estimates. Default value is 6. | 
| ... | additional arguments that are passed to the generic  | 
Value
Formatted output of a epictmcmc object.
See Also
epictmcmc, summary.epictmcmc, plot.epictmcmc.
Summary method for epictmcmc objects
Description
Summarize a epictmcmc object and return an object of class summary.epictmcmc.
Usage
## S3 method for class 'epictmcmc'
summary(object, digits = NULL, start = NULL, end = NULL, thin = NULL, ...)
## S3 method for class 'summary.epictmcmc'
print(x, digits, start, end, thin, ...)
Arguments
| x,object | an S3 object of class  | 
| digits | the number of printed digits of the estimates. Default value is 6. | 
| start,end,thin | options for creating  | 
| ... | potential further arguments (require by generic). | 
See Also
epictmcmc, print.epictmcmc, plot.epictmcmc.
Tomato Spotted Wilt Virus data
Description
Data extracted from plots in Hughes et al. (1997)
Usage
data(tswv)Format
A list of two objects of class “datagen” as follows:
- tswvsir:
- an object of class “datagen” for the “SIR” compartmental framework. 
- tswvsinr:
- an object of class “datagen” for the “SINR” compartmental framework. 
References
Hughes, G., McRoberts, N., Madden, L.V., Nelson, S. C. (1997). Validating mathematical models of plant disease progress in space and time. IMA Journal of Mathematics Applied in Medicine and Biology, 14, 85-112.