latentVariable: Bayesian hierarchical models for spatial extremes

Description Usage Arguments Details Value Warning Note Author(s) References Examples

Description

This function generates a Markov chain from a Bayesian hierarchical model for block maxima assuming conditional independence.

Usage

1
2
3
latent(data, coord, cov.mod = "powexp", loc.form, scale.form,
shape.form, marg.cov = NULL, hyper, prop, start, n = 5000, thin = 1,
burn.in = 0, use.log.link = FALSE)

Arguments

data

A matrix representing the data. Each column corresponds to one location.

coord

A matrix that gives the coordinates of each location. Each row corresponds to one location.

cov.mod

A character string corresponding to the covariance model for the Gaussian latent processes. Must be one of "gauss" for the Smith's model; "whitmat", "cauchy", "powexp" or "bessel" or for the Whittle-Matern, the Cauchy, the Powered Exponential and the Bessel correlation families.

loc.form, scale.form, shape.form

R formulas defining the spatial linear model for the mean of the latent processes.

marg.cov

Matrix with named columns giving additional covariates for the latent processes means. If NULL, no extra covariates are used.

hyper

A named list specifying the hyper-parameters — see Details.

prop

A named list specifying the jump sizes when a Metropolis–Hastings move is needed — see Details.

start

A named list specifying the starting values — see Details.

n

The effective length of the simulated Markov chain i.e., once the burnin period has been discarded and after thinning.

thin

An integer specifying the thinning length. The default is 1, i.e., no thinning.

burn.in

An integer specifying the burnin period. The default is 0, i.e., no burnin.

use.log.link

An integer. Should a log-link function should be use for the GEV scale parameters, i.e., assuming that the GEV scale parameters a drawn from a log-normal process rather than a gaussian process.

Details

This function generates a Markov chain from the following model. For each x in R^d, suppose that Y(x) is GEV distributed whose parameters {μ(x), σ(x), ξ(x)} vary smoothly for x in R^d according to a stochastic process S(x). We assume that the processes for each GEV parameters are mutually independent Gaussian processes. For instance, we take for the location parameter μ(x)

μ(x) = f_{μ(x)}(x;β_μ) + S_μ(x; α_μ, λ_μ, κ_μ)

where f_μ is a deterministic function depending on regression parameters β_μ, and S_μ is a zero mean, stationary Gaussian process with a prescribed covariance function with sill α_μ, range λ_μ and shape parameters κ_μ. Similar formulations for the scale σ(x) and the shape ξ(x) parameters are used. Then conditional on the values of the three Gaussian processes at the sites (x_1, …, x_K), the maxima are assumed to follow GEV distributions

Y_i(x_j) | {μ(x_j), σ(x_j), ξ(x_j)} ~ GEV{μ(x_j), σ(x_j), ξ(s_j)},

independently for each location (x_1, …, x_K).

A joint prior density must be defined for the sills, ranges, shapes parameters of the covariance functions as well as for the regression parameters β_μ,β_σ and β_ξ. Conjugate priors are used whenever possible, taking independent inverse Gamma and multivariate normal distributions for the sills and the regression parameters. No conjugate prior exist for λ and κ, for wich a Gamma distribution is assumed.

Consequently hyper is a named list with named components

sills

A list with three components named 'loc', 'scale' and 'shape' each of these is a 2-length vector specifying the shape and the scale of the inverse Gamma prior distribution for the sill parameter of the covariance functions;

ranges

A list with three components named 'loc', 'scale' and 'shape' each of these is a 2-length vector specifying the shape and the scale of the Gamma prior distribution for the range parameter of the covariance functions.

smooths

A list with three components named 'loc', 'scale' and 'shape' each of these is a 2-length vector specifying the shape and the scale of the Gamma prior distribution for the shape parameter of the covariance functions;

betaMean

A list with three components named 'loc', 'scale' and 'shape' each of these is a vector specifying the mean vector of the multivariate normal prior distribution for the regression parameters;

betaIcov

A list with three components named 'loc', 'scale' and 'shape' each of these is a matrix specifying the inverse of the covariance matrix of the multivariate normal prior distribution for the regression parameters.

As no conjugate prior exists for the GEV parameters and the range and shape parameters of the covariance functions, Metropolis–Hastings steps are needed. The proposals θ_[prop] are drawn from a proposal density q(. | θ_[cur], s) where θ_[cur] is the current state of the parameter and s is a parameter of the proposal density to be defined. These proposals are driven by prop which is a list with three named components

gev

A vector of length 3 specifying the standard deviations of the proposal distributions. These are taken to be normal distribution for the location and shape GEV parameters and a log-normal distribution for the scale GEV parameters;

ranges

A vector of length 3 specifying the jump sizes for the range parameters of the covariance functions — q(. | θ_[cur], s) is the log-normal density with mean θ_[cur] and standard deviation s both on the log-scale;

smooths

A vector of length 3 specifying the jump sizes for the shape parameters of the covariance functions — q(. | θ_[cur], s) is the log-normal density with mean θ_[cur] and standard deviation s both on the log-scale.

If one want to held fixed a parameter this can be done by setting a null jump size then the parameter will be held fixed to its starting value.

Finally start must be a named list with 4 named components

sills

A vector of length 3 specifying the starting values for the sill of the covariance functions;

ranges

A vector of length 3 specifying the starting values for the range of the covariance functions;

smooths

A vector of length 3 specifying the starting values for the shape of the covariance functions;

beta

A named list with 3 components 'loc', 'scale' and 'shape' each of these is a numeric vector specifying the starting values for the regression coefficients.

Value

A list

Warning

This function can be time consuming and makes an intensive use of BLAS routines so it is (much!) faster if you have an optimized BLAS.

The starting values will never be stored in the generated Markov chain even when burn.in=0.

Note

If you want to analyze the convergence ans mixing properties of the Markov chain, it is recommended to use the library coda.

Author(s)

Mathieu Ribatet

References

Banerjee, S., Carlin, B. P., and Gelfand, A. E. (2004). Hierarchical Modeling and Analysis for Spatial Data. Chapman & Hall/CRC, New York.

Casson, E. and Coles, S. (1999) Spatial regression models for extremes. Extremes 1,449–468.

Cooley, D., Nychka, D. and Naveau, P. (2007) Bayesian spatial modelling of extreme precipitation return levels Journal of the American Statistical Association 102:479, 824–840.

Davison, A.C., Padoan, S.A. and Ribatet, M. Statistical Modelling of Spatial Extremes. Submitted.

Examples

 1
 2
 3
 4
 5
 6
 7
 8
 9
10
11
12
13
14
15
16
17
18
19
20
21
22
23
24
25
26
27
28
29
30
31
32
33
34
35
36
37
38
39
40
41
42
43
44
## Not run: 
## Generate realizations from the model
n.site <- 30
n.obs <- 50
coord <- cbind(lon = runif(n.site, -10, 10), lat = runif(n.site, -10 , 10))

gp.loc <- rgp(1, coord, "powexp", sill = 4, range = 20, smooth = 1)
gp.scale <- rgp(1, coord, "powexp", sill = 0.4, range = 5, smooth = 1)
gp.shape <- rgp(1, coord, "powexp", sill = 0.01, range = 10, smooth = 1)

locs <- 26 + 0.5 * coord[,"lon"] + gp.loc
scales <- 10 + 0.2 * coord[,"lat"] + gp.scale
shapes <- 0.15 + gp.shape

data <- matrix(NA, n.obs, n.site)
for (i in 1:n.site)
  data[,i] <- rgev(n.obs, locs[i], scales[i], shapes[i])

loc.form <- y ~ lon
scale.form <- y ~ lat
shape.form <- y ~ 1

hyper <- list()
hyper$sills <- list(loc = c(1,8), scale = c(1,1), shape = c(1,0.02))
hyper$ranges <- list(loc = c(2,20), scale = c(1,5), shape = c(1, 10))
hyper$smooths <- list(loc = c(1,1/3), scale = c(1,1/3), shape = c(1, 1/3))
hyper$betaMeans <- list(loc = rep(0, 2), scale = c(9, 0), shape = 0)
hyper$betaIcov <- list(loc = solve(diag(c(400, 100))),
                       scale = solve(diag(c(400, 100))),
                       shape = solve(diag(c(10), 1, 1)))

## We will use an exponential covariance function so the jump sizes for
## the shape parameter of the covariance function are null.
prop <- list(gev = c(1.2, 0.08, 0.08), ranges = c(0.7, 0.8, 0.7), smooths = c(0,0,0))
start <- list(sills = c(4, .36, 0.009), ranges = c(24, 17, 16), smooths
              = c(1, 1, 1),  beta = list(loc = c(26, 0.5), scale = c(10, 0.2),
                               shape = c(0.15)))

mc <- latent(data, coord, loc.form = loc.form, scale.form = scale.form,
             shape.form = shape.form, hyper = hyper, prop = prop, start = start,
             n = 10000, burn.in = 5000, thin = 15)
mc

## End(Not run)

SpatialExtremes documentation built on Sept. 1, 2020, 3:01 a.m.