| Version: | 0.1-12 | 
| Date: | 2023-11-17 | 
| Encoding: | UTF-8 | 
| Title: | Bayesian Model Averaging with INLA | 
| Author: | Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>, Roger Bivand <Roger.Bivand@nhh.no> | 
| Maintainer: | Virgilio Gómez-Rubio <virgilio.gomez@uclm.es> | 
| Depends: | R(≥ 2.15.0), parallel, sp | 
| Imports: | Matrix, spdep, methods | 
| Suggests: | INLA | 
| Description: | Fit Spatial Econometrics models using Bayesian model averaging on models fitted with INLA. The INLA package can be obtained from https://www.r-inla.org. | 
| License: | GPL-2 | GPL-3 [expanded from: GPL (≥ 2)] | 
| Additional_repositories: | https://inla.r-inla-download.org/R/stable/ | 
| RoxygenNote: | 6.0.1 | 
| NeedsCompilation: | no | 
| Packaged: | 2023-11-17 20:54:25 UTC; virgil | 
| Repository: | CRAN | 
| Date/Publication: | 2023-11-18 14:20:05 UTC | 
Compute BMA of fitted.values from a list of INLA objects
Description
This functions performs a weighted average of the component
fitted.values from a list of INLA objects.
Usage
BMArho(models, rho, logrhoprior = rep(1, length(rho)))
Arguments
| models | List of INLA models fitted for different values of  | 
| rho | Vector fo values of  | 
| logrhoprior | Log-prior density for each value of  | 
Details
The different fitted.values are weighted using the values of the
marginal likelihood of the fitted models and the prior of parameter
rho. rho is a parameter that is fixed when computing
models and that have a log-prior density  defined in pogrhoprior.
Value
Vector of averaged fitted values.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2014). Approximate Bayesian inference for spatial econometrics models. Spatial Statistics, Volume 9, 146-165.
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2015). Spatial Data Analysis with R-INLA with Some Extensions. Journal of Statistical Software, 63(20), 1-31. URL http://www.jstatsoft.org/v63/i20/.
See Also
Perform complete Bayesian Model Averaging on some Spatial Econometrics models
Description
This function performs Bayesian Model Averaging on a list of 
different Spatial Econometrics models. These models have been computed
under different values of the spatial autocorrelation parameter rho.
Usage
INLABMA(models, rho, logrhoprior = rep(1, length(rho)), impacts = FALSE, 
 usenormal = FALSE)
Arguments
| models | List of INLA models, computed for different values of  | 
| rho | A vector with the values of  | 
| logrhoprior | Vector with the values of the log-prior density of  | 
| impacts | Logical. Whether impacts should be computed. | 
| usenormal | Logical. Whether the posterior marginal of  | 
Details
This functions perfomrs BMA on most of the compponents of an INLA model
using the marginal likelihoods of the models and the provided
log-prior density of rho. 
Value
A list with the averaged components. Another component called
rho is added, with its posterior marginal and some other
summary information.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2014). Approximate Bayesian inference for spatial econometrics models. Spatial Statistics, Volume 9, 146-165.
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2015). Spatial Data Analysis with R-INLA with Some Extensions. Journal of Statistical Software, 63(20), 1-31. URL http://www.jstatsoft.org/v63/i20/.
See Also
Perform INLA with MCMC.
Description
This function implements the Metropolis-Hastings algorithm using repeated calls to R-INLA to fint conditional model on the current state of the MCMC simulations.
Usage
INLAMH(d, fit.inla, b.init, rq, dq, prior, n.sim = 200, n.burnin = 100,
  n.thin = 1, n.errors = 20, verbose = FALSE)
Arguments
| d | Data.frame with the data used to fit the model with R-INLA. | 
| fit.inla | A function used to fit the model with R-INLA. It should take at least two arguments: a data.frame (first) and an object with the actual value of the sampled parameters. This function must return a vector of two components: model.sim (an 'inla' object with the fitted model) and 'mlik' (the marginal likelihood as returned by INLA in model.sim$mlik). | 
| b.init | Initial values of the model parameters for the Metropolis-Hastings algorithm. | 
| rq | Sampling from the proposal distribution. It must take one argument: the current state of the Markov chain. | 
| dq | Density of the proposal distribution. It takes two arguments: current state and proposed new state. | 
| prior | Prior distribution of the model parameters. | 
| n.sim | Total of simulations to be done. | 
| n.burnin | Number of burn-in simulation (thinning is ignored here). | 
| n.thin | Thinning to be applied to the simulations after burn-in. | 
| n.errors | This is the number of errores allowed when calling inla(). | 
| verbose | Whether to show some running information or not (defaut to FALSE). | 
Details
This function implements the Metropolis-Hastings algorithm using INLA (i.e., INLA within MCMC) at every step. In practice, only a few of the model parameters are sampled in the MCMC steps and the posterior marginal of the remainder of parameters is obtained by Bayesian model averaging of the conditional marginals returned by R-INLA at each step of the Metropolis-Hastings algorithm.
Value
A list with three components:
| acc.sim | A vector of logical values (of length 'n.sim') showing whether a given proposal has been accepted or not. This is useful to compute the acceptance rate. | 
| model.sim | A list with the models fitted, as returned by fit.inla(). | 
| b.sim | List of all sampled values of the models parameters. It is a list beacuse the sampled values can be vectors. | 
Author(s)
Virgilio Gómez-Rubio.
References
Virgilio Gómez-Rubio and Haavard Rue (2017). Markov Chain Monte Carlo with the Integrated Nested Laplace Approximation. doi:10.1007/s11222-017-9778-y.
Fit posterior marginal distributions to points
Description
Compute (and re-scale, if necessary) the marginal from a set of
points x and values of log-likelihood logy and 
log-prior density logp.
Usage
fitmarg(x, logy, logp = 0, usenormal = FALSE)
Arguments
| x | Values of the random variable. | 
| logy | Log-likelihood. | 
| logp | Log-prior density. | 
| usenormal | Whether use a Normal distribution for the fitted marginal. | 
Details
Fits a marginal at a set of points x from their log-likelihood
and log-prior. The fitted marginal is re-scaled to integrate one if
necessary. If usenormal=TRUE then the fitted marginal is supposed
to be Normal, which is computed using the posterior mean and standard
deviation of x.
Value
A function with the fitted marginal is returned.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
See Also
fitmargBMA, fitmargBMA2,mysplinefun
Compute marginals using Bayesian Model Averaging
Description
fitmargBMA takes a list of marginal distributions and weights 
(presumably, based on some marginal likelihoods) and computes a 
final distribution by weighting.
fitmargBMA2 takes a list of INLA models and computes Bayesian
Model Averaging on some of their components.
fitmatrixBMA performs  averaging on a list of matrices.
fitlistBMA performs averaging of elements in lists.
Usage
fitmargBMA(margs, ws, len = 100)
fitmargBMA2(models, ws, item)
fitmatrixBMA(models, ws, item)
fitlistBMA(models, ws, item)
Arguments
| margs | List of 2-column matrices with the values of the (marginal) distributions. | 
| models | List of INLA models to be averaged. | 
| ws | Vector of weights. They do not need to sum up to one. | 
| len | Length of the x-vector to compute the weighted distribution. | 
| item | Name of the elements of an INLA object to be used in the Model Averaging. | 
Details
For fitmargBMA, distributions provided are averaging according to the
weights provided.  A new probability distribution is obtained.  
fitmargBMA2 uses a list of INLA models to compute Model Averaging
on some of their components (for example, the fitted values).
fitmatrixBMA performs  averaging on a list of matrices.
fitlistBMA performs  averaging of a list of a list of matrices.
Value
fitmargBMA returns a 2-column matrix with the weighted marginal 
distribution.
fitmargBMA2 returns a list of weighted components.
fitmatrixBMA returns a matrix.
fitlistBMA returns a list.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
Fit Leroux et al's spatial model.
Description
This function fits the model by Leroux et al. for a given value
of the parameter lambda, i.e., the mixture parameter that
appears in the variance..
Usage
leroux.inla(formula, d, W, lambda, improve = TRUE, fhyper = NULL, ...)
Arguments
| formula | Formula of the fixed effects. | 
| d | A data.frame with the data to be used. | 
| W | Adjacency matrix. | 
| lambda | Parameter used in the mixture of the two precission matrices. | 
| improve | Logical. Whether to improve the fitted models to obtain better estimates of the marginal likelihoods. | 
| fhyper | Extra arguments passed to the definition of the hyperparameters. | 
| ... | Extra arguments passed to function  | 
Details
This function fits the model proposed by Leroux et al. (1999)
for a given value of parameter lambda. This parameter
controls the mixture between a diagonal precission (lambda=1) 
and an intrinsic CAR precission (lambda=0).
The marginal log-likelihood is corrected to add half the log-determinant of the precission matrix.
Value
An INLA object.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
Leroux B, Lei X, Breslow N (1999). Estimation of Disease Rates in Small Areas: A New Mixed Model for Spatial Dependence. In M Halloran, D Berry (eds.), Statistical Models in Epidemiology, the Environment and Clinical Trials, pp. 135-178. Springer-Verlag, New York.
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2014). Approximate Bayesian inference for spatial econometrics models. Spatial Statistics, Volume 9, 146-165.
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2015). Spatial Data Analysis with R-INLA with Some Extensions. Journal of Statistical Software, 63(20), 1-31. URL http://www.jstatsoft.org/v63/i20/.
See Also
Log-prior density for the spatial autocorrelation parameter rho
Description
Compute log-prior density for rho
Usage
logprrho(rho)
Arguments
| rho | The value to compute the log-density. | 
Details
This function computes the log-density of the prior for rho
according to logit(rho) ~ N(0, prec=.1). THis is one of the default
priors in R-INLA for spatial autocorrelation parameters.
Value
Numerical.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
Examples
rrho<-seq(.01, .99, length.out=100)
plot(rrho, exp(logprrho(rrho)))
Compute spline function
Description
This function is similar to splinefun but it returns 0
outside the range of x.
Usage
mysplinefun(x, y = NULL, method = c("fmm", "periodic", "natural", "monoH.FC")[1],
   ties = mean)
Arguments
| x | x-values to use in the interpolation. | 
| y | y-values to use in the interpolation (optional). | 
| method | Method used to compute the spline. See  | 
| ties | Handling of tied 'x' values. See  | 
Details
This function calls splinefun and returns a function
with the fitted spline. The main difference is that this new function
returns 0 outside the range of 0.
Value
Returns a function with x and deriv arguments.  See splinefun for details.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
See Also
Recompute the impact summaries from the marginals
Description
This functions recomputes the impacts summaries using the (approximated) marginals rather than by weighting on the different summaries.
Usage
recompute.impacts(obj, impacts = c("total", "direct", "indirect"))
Arguments
| obj | Object with a resulting model obtained by Bayesian Model Averaging with INLABMA. | 
| impacts | Types of impacts to recompute. | 
Details
This function uses the impacts marginals to compute some summary statistics.
By default, the summary of the impacts is obtained by weighting the different
summaries used in Bayesian MOdel Averaging with function INLABMA.
Value
Original object with the updated summary statistics of the impacts.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
Bivand et al. (2013)
See Also
Re-scale marginal distribution to compute the distribution of w*x
Description
This function takes a marginal distribution (represetend by a 2-column matrix) and computes the marginal distribution of w*x.
Usage
rescalemarg(xx, w)
Arguments
| xx | 2-column matrix with x and y-values. | 
| w | Weight to re-scale the y-values. | 
Details
This function simply re-scales
Value
A 2-column matrix with the new values of w*x and their associated
probability densities. This is also an object of classes inla.marginal.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
INLA
See Also
inla.tmarginal
Examples
if(requireNamespace("INLA", quietly = TRUE)) {
require(INLA)
x<-seq(-3,3, by=.01)
xx<-cbind(x, dnorm(x))
xx2<-rescalemarg(xx, 3)
plot(xx, type="l", xlim=c(-9,9))
lines(xx2, col="red")
}
Fit spatial econometrics models with INLA
Description
These functions fit some spatial econometrics models for a given
value of rho (the spatial autocorrelation parameter).
sem.inla fits a spatial error model, slm fits a spatial lag model
and sdm.inla fits a spatial Durbin model.
Usage
sem.inla(formula, d, W, rho, improve = TRUE, impacts = FALSE, fhyper = NULL, 
   probit = FALSE, ...)
slm.inla(formula, d, W, rho, mmatrix = NULL, improve = TRUE, impacts = FALSE, 
   fhyper = NULL, probit = FALSE, ...)
sdm.inla(formula, d, W, rho, mmatrix = NULL, intercept = TRUE, impacts = FALSE,
   improve = TRUE, fhyper = NULL, probit = FALSE, ...)
sac.inla(formula, d, W.rho, W.lambda, rho, lambda, mmatrix = NULL, 
   improve = TRUE, impacts = FALSE, fhyper = NULL, probit = FALSE, ...)
Arguments
| formula | Formula with the response variable, the fixed effects and, possibly, other non-linear effects. | 
| d | Data.frame with the data. | 
| W | Adjacency matrix. | 
| rho | Value of the spatial autocorrelation parameter. For the SAC model, spatial autocorrelation term on the response. | 
| W.rho | For the SAC model, adjacency matrix associated to the autocorrelation on the response. | 
| W.lambda | For the SAC model, adjacency matrix associated to the autocorrelation on the error term. | 
| lambda | For the SAC model, spatial autocorrelation of the error term. | 
| mmatrix | Design matrix of fixed effects. | 
| intercept | Logical. Whether an intercept has been included in the model. | 
| improve | Logical. Whether improve model fitting (this may require more computing time). | 
| impacts | Logical. Whether impacts are computed. | 
| fhyper | Options to be passed to the definition of the hyper-parameters in the spatial effects. | 
| probit | Logical. Whether a probit model is used. Note this is only used
when computing the impacts and that argument  | 
| ... | Other arguments passed to function  | 
Details
These functions fit a spatial econometrics model with a fixed value
of the spatial autocorrelation parameter rho. 
In addition, the marginal -log-likelihood is corrected to account for the variance-covariance matrix of the error term or random effects.
Value
An inla object.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2014). Approximate Bayesian inference for spatial econometrics models. Spatial Statistics, Volume 9, 146-165.
Roger S. Bivand, Virgilio Gómez-Rubio, Hĺvard Rue (2015). Spatial Data Analysis with R-INLA with Some Extensions. Journal of Statistical Software, 63(20), 1-31. URL http://www.jstatsoft.org/v63/i20/.
Virgilio Gómez-Rubio and Francisco-Palmí Perales (2016). Spatial Models with the Integrated Nested Laplace Approximation within Markov Chain Monte Carlo. Submitted.
See Also
Examples
## Not run: 
if(requireNamespace("INLA", quietly = TRUE)) {
require(INLA)
require(spdep)
data(columbus)
lw <- nb2listw(col.gal.nb, style="W")
#Maximum Likelihood (ML) estimation
colsemml <- errorsarlm(CRIME ~ INC + HOVAL, data=columbus, lw, method="eigen", 
	quiet=FALSE)
colslmml <- lagsarlm(CRIME ~ INC + HOVAL, data=columbus, lw, method="eigen", 
	type="lag", quiet=FALSE)
colsdmml <- lagsarlm(CRIME ~ INC + HOVAL, data=columbus, lw, method="eigen", 
	type="mixed", quiet=FALSE)
#Define grid on rho
rrho<-seq(-1, .95, length.out=40)
#Adjacency matrix
W <- as(as_dgRMatrix_listw(nb2listw(col.gal.nb)), "CsparseMatrix")
#Index for spatial random effects
columbus$idx<-1:nrow(columbus)
#Formula
form<- CRIME ~ INC + HOVAL
zero.variance = list(prec=list(initial = 25, fixed=TRUE))
seminla<-mclapply(rrho, function(rho){
                sem.inla(form, d=columbus, W=W, rho=rho,
                        family = "gaussian", impacts=FALSE,
                        control.family = list(hyper = zero.variance),
                        control.predictor=list(compute=TRUE),
                        control.compute=list(dic=TRUE, cpo=TRUE),
                        control.inla=list(print.joint.hyper=TRUE), 
				#tolerance=1e-20, h=1e-6),
			verbose=FALSE
                )
})
slminla<-mclapply(rrho, function(rho){
                slm.inla(form, d=columbus, W=W, rho=rho,
                        family = "gaussian", impacts=FALSE,
                        control.family = list(hyper = zero.variance),
                        control.predictor=list(compute=TRUE),
                        control.compute=list(dic=TRUE, cpo=TRUE),
                        control.inla=list(print.joint.hyper=TRUE), 
				#tolerance=1e-20, h=1e-6),
			verbose=FALSE
                )
})
sdminla<-mclapply(rrho, function(rho){
                sdm.inla(form, d=columbus, W=W, rho=rho,
                        family = "gaussian", impacts=FALSE,
                        control.family = list(hyper = zero.variance),
                        control.predictor=list(compute=TRUE),
                        control.compute=list(dic=TRUE, cpo=TRUE),
                        control.inla=list(print.joint.hyper=TRUE), 
				#tolerance=1e-20, h=1e-6),
			verbose=FALSE
                )
})
#BMA using a uniform prior (in the log-scale) and using a Gaussian 
#approximation to the marginal
sembma<-INLABMA(seminla, rrho, 0, usenormal=TRUE)
slmbma<-INLABMA(slminla, rrho, 0, usenormal=TRUE)
sdmbma<-INLABMA(sdminla, rrho, 0, usenormal=TRUE)
#Display results
plot(sembma$rho$marginal, type="l", ylim=c(0,5))
lines(slmbma$rho$marginal, lty=2)
lines(sdmbma$rho$marginal, lty=3)
#Add ML estimates
abline(v=colsemml$lambda, col="red")
abline(v=colslmml$rho, col="red", lty=2)
abline(v=colsdmml$rho, col="red", lty=3)
#Legend
legend(-1,5, c("SEM", "SLM", "SDM"), lty=1:3)
}
## End(Not run)
Compute trace of (I-rho*W)^{-1} matrix
Description
This function computes (or estimates) the trace of matrix (I-rho*W)^{-1}, which is often needed when computing impacts in some spatial econometrics models.
Usage
trIrhoWinv(W, rho, offset = 0, order = 20, direct = TRUE, Df = Matrix::Diagonal(nrow(W)))
Arguments
| W | Adjacency matrix. Usually, it is row-standardised. | 
| rho | Value of spatial autocorrelation parameter  | 
| offset | Number of times (I-rho*W)^{-1} is multiplied by W (for sdm model). | 
| order | Order of Taylor expansion used in the approximation of the trace. | 
| direct | Use direct method, i.e., matrix multiplication, etc. | 
| Df | Diagonal matrix used to compute the impacts in the Probit model only used if direct=TRUE. | 
Details
This function computes the trace of (I-rho*W)^{-1}, which is later used to computed the impacts. This is an internal function.
Value
Numerica value.
Author(s)
Virgilio Gómez-Rubio <virgilio.gomez@uclm.es>
References
LeSage and Page (2008) Bivand et al. (2013)