Title: | Tools for Two-Dimensional Monte-Carlo Simulations |
---|---|
Description: | A complete framework to build and study Two-Dimensional Monte-Carlo simulations, aka Second-Order Monte-Carlo simulations. Also includes various distributions (pert, triangular, Bernoulli, empirical discrete and continuous). |
Authors: | Regis Pouillot [aut, cre], Marie-Laure Delignette-Muller [ctb], Jean-Baptiste Denis [ctb], Yu Chen [ctb], Arie Havelaar [ctb] |
Maintainer: | Regis Pouillot <[email protected]> |
License: | GPL (>= 2) |
Version: | 0.2.1 |
Built: | 2024-11-03 07:15:27 UTC |
Source: | CRAN |
Density, distribution function, quantile function and random generation for the Bernoulli distribution with probability equals to ‘prob’.
dbern(x, prob=.5, log=FALSE) pbern(q, prob=.5, lower.tail=TRUE, log.p=FALSE) qbern(p, prob=.5, lower.tail=TRUE, log.p=FALSE) rbern(n, prob=.5)
dbern(x, prob=.5, log=FALSE) pbern(q, prob=.5, lower.tail=TRUE, log.p=FALSE) qbern(p, prob=.5, lower.tail=TRUE, log.p=FALSE) rbern(n, prob=.5)
x , q
|
vector of quantiles. |
p |
vector of probabilities. |
n |
number of observations. If ‘length(n) > 1’, the length is taken to be the number required. |
prob |
vector of probabilities of success of each trial. |
log , log.p
|
logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
lower.tail |
logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’. |
These functions use the corresponding functions from the
binomial
distribution with argument ‘size = 1’.
Thus, 1 is for success, 0 is for failure.
‘dbern’ gives the density, ‘pbern’ gives the distribution function, ‘qbern’ gives the quantile function, and ‘rbern’ generates random deviates.
rbern(n=10, prob=.5) rbern(n=3, prob=c(0, .5, 1))
rbern(n=10, prob=.5) rbern(n=3, prob=c(0, .5, 1))
Density, distribution function, quantile function and random generation for the Beta distribution defined on the ‘[min, max]’ domain with parameters ‘shape1’ and ‘shape2’ ( and optional non-centrality parameter ‘ncp’).
dbetagen(x, shape1, shape2, min=0, max=1, ncp=0, log=FALSE) pbetagen(q, shape1, shape2, min=0, max=1, ncp=0, lower.tail=TRUE, log.p=FALSE) qbetagen(p, shape1, shape2, min=0, max=1, ncp=0, lower.tail=TRUE, log.p=FALSE) rbetagen(n, shape1, shape2, min=0, max=1, ncp=0)
dbetagen(x, shape1, shape2, min=0, max=1, ncp=0, log=FALSE) pbetagen(q, shape1, shape2, min=0, max=1, ncp=0, lower.tail=TRUE, log.p=FALSE) qbetagen(p, shape1, shape2, min=0, max=1, ncp=0, lower.tail=TRUE, log.p=FALSE) rbetagen(n, shape1, shape2, min=0, max=1, ncp=0)
x , q
|
Vector of quantiles. |
p |
Vector of probabilities. |
n |
Number of observations. If ‘length(n) > 1’, the length is taken to be the number required. |
shape1 , shape2
|
Positive parameters of the Beta distribution. |
min |
Vector of minima. |
max |
Vector of maxima. |
ncp |
Non-centrality parameter of the Beta distribution. |
log , log.p
|
Logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
lower.tail |
Logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’. |
if
These functions use the Beta
distribution functions
after correct parameterization.
‘dbetagen’ gives the density, ‘pbetagen’ gives the distribution function, ‘qbetagen’ gives the quantile function, and ‘rbetagen’ generates random deviates.
curve(dbetagen(x, shape1=3, shape2=5, min=1, max=6), from = 0, to = 7) curve(dbetagen(x, shape1=1, shape2=1, min=2, max=5), from = 0, to = 7, lty=2, add=TRUE) curve(dbetagen(x, shape1=.5, shape2=.5, min=0, max=7), from = 0, to = 7, lty=3, add=TRUE)
curve(dbetagen(x, shape1=3, shape2=5, min=1, max=6), from = 0, to = 7) curve(dbetagen(x, shape1=1, shape2=1, min=2, max=5), from = 0, to = 7, lty=2, add=TRUE) curve(dbetagen(x, shape1=.5, shape2=.5, min=0, max=7), from = 0, to = 7, lty=3, add=TRUE)
Density, distribution function, quantile function and random generation for the "Beta Subjective" distribution
dbetasubj(x, min, mode, mean, max, log = FALSE) pbetasubj(q, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE ) qbetasubj(p, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE ) rbetasubj(n, min, mode, mean, max ) pbetasubj(q, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE) qbetasubj(p, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE) rbetasubj(n, min, mode, mean, max)
dbetasubj(x, min, mode, mean, max, log = FALSE) pbetasubj(q, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE ) qbetasubj(p, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE ) rbetasubj(n, min, mode, mean, max ) pbetasubj(q, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE) qbetasubj(p, min, mode, mean, max, lower.tail = TRUE, log.p = FALSE) rbetasubj(n, min, mode, mean, max)
x , q
|
Vector of quantiles. |
min |
continuous boundary parameter min < max |
mode |
continuous parameter |
mean |
continuous parameter min < mean < max |
max |
continuous boundary parameter |
log , log.p
|
Logical; if TRUE, probabilities p are given as log(p). |
lower.tail |
Logical; if TRUE (default), probabilities are |
p |
Vector of probabilities. |
n |
Number of observations. |
The Subjective beta distribution specifies a [stats::dbeta()] distribution defined by the minimum, most likely (mode), mean
and maximum values and can be used for fitting data for a variable that is bounded to the interval .
The shape parameters are calculated from the mode value and mean parameters. It can also be used to represent
uncertainty in subjective expert estimates.
Define
The subject beta distribution is a [stats::dbeta()] distribution defined on the domain
with parameter
and
.
# Hence, it has density #
# The cumulative distribution function is #
# where . Here B is the beta function and
is the incomplete beta function.
The parameter restrictions are:
If then
, else
.
Yu Chen
curve(dbetasubj(x, min=0, mode=1, mean=2, max=5), from=-1,to=6) pbetasubj(q = seq(0,5,0.01), 0, 1, 2, 5) qbetasubj(p = seq(0,1,0.01), 0, 1, 2, 5) rbetasubj(n = 1e7, 0, 1, 2, 5)
curve(dbetasubj(x, min=0, mode=1, mean=2, max=5), from=-1,to=6) pbetasubj(q = seq(0,5,0.01), 0, 1, 2, 5) qbetasubj(p = seq(0,1,0.01), 0, 1, 2, 5) rbetasubj(n = 1e7, 0, 1, 2, 5)
This function provides basic graphs to evaluate the convergence of a
node of a mc
or a mccut
object in the
variability or in the uncertainty dimension.
converg(x, node=length(x), margin=c("var", "unc"), nvariates=1, iter=1, probs=c(0.025, 0.975), lim=c(0.025, 0.975), griddim=NULL, log=FALSE)
converg(x, node=length(x), margin=c("var", "unc"), nvariates=1, iter=1, probs=c(0.025, 0.975), lim=c(0.025, 0.975), griddim=NULL, log=FALSE)
x |
|
node |
The node to be considered in a ‘mc’ object or a ‘mccut’ object, displayed either as the order number or the name of the node. By default: the last node of the object.The corresponding node should not be of type ‘"0"’ in a ‘mc’ object or of type ‘"0"’ or ‘"V"’ in a ‘mccut’ object. |
margin |
The margin used to plot the graph. ‘margin’ is used only if the node is a ‘"VU" mcnode’. |
nvariates |
The variates to be considered. ‘nvariates’ is used only for multivariates nodes. |
iter |
If ‘margin == "var"’ and the node is a ‘"VU" mcnode’, ‘iter’ specify the iteration in the uncertainty dimension to be used for the graph. |
probs |
The quantiles to be provided in the variability dimension. |
lim |
The quantiles to be used in the uncertainty dimension. |
griddim |
A vector of two integers, indicating the size of the grid of the graph. If ‘NULL’, the grid is calculated to produce a "nice" graph. |
log |
If ‘TRUE’, the data will be log transformed. |
If the node is of type ‘"V"’, the running mean, median and ‘probs’ quantiles according to the variability dimension will be provided. If the node is of type ‘"VU"’ and ‘margin="var"’, this graph will be provided on one simulation in the uncertainty dimension (chosen by ‘iter’).
If the node is of type ‘"U"’ the running mean, median and ‘lim’ quantiles according to the uncertainty dimension will be provided.
If the node is of type ‘"VU"’ (with ‘margin="unc"’ or from a ‘mccut’ object), one graph are provided for each of the mean, median and ‘probs’ quantiles calculated in the variability dimension.
This function may be used on a ‘mccut’ object only if a
‘summary.mc’ function was used in the third block of the
evalmccut
call. The values used as ‘probs’
arguments in ‘converg’ should have been used in the
‘summary.mc’ function of this third block.
data(total) converg(xVU, margin="var") converg(xVU, margin="unc")
data(total) converg(xVU, margin="var") converg(xVU, margin="unc")
This function builds a rank correlation structure between columns of a matrix or between ‘mcnode’ objects using the Iman and Conover method (1982).
cornode(..., target, outrank=FALSE, result=FALSE, seed=NULL)
cornode(..., target, outrank=FALSE, result=FALSE, seed=NULL)
... |
A matrix (each of its ‘n’ columns but the first one will be reordered) or ‘n mcnode’ objects (each elements but the first one will be reordered). |
target |
A scalar (only if ‘n=2’) or a ‘(n x n)’ matrix of correlation. |
outrank |
Should the order be returned? |
result |
Should the correlation eventually obtained be printed? |
seed |
The random seed used for building the correlation. If ‘NULL’ the ‘seed’ is unchanged. |
The arguments should be named.
The function accepts for ‘data’ a matrix or:
some ‘"V" mcnode’ objects separated by a comma;
some ‘"U" mcnode’ objects separated by a comma;
some ‘"VU" mcnode’ objects separated by a comma. In that case, the structure is built columns by columns (the first column of each ‘"VU" mcnode’ will have a correlation structure, the second ones will have a correlation structure, ....).
one ‘"V" mcnode’ as a first element and some ‘"VU" mcnode’ objects, separated by a comma. In that case, the structure is built between the ‘"V" mcnode’ and each column of the ‘"VU" mcnode’ objects. The correlation result (‘result = TRUE’) is not provided in that case.
The number of variates of the elements should be equal.
‘target’ should be a scalar (two columns only) or a real
symmetric positive-definite square matrix. Only the upper triangular
part of ‘target’ is used (see chol
).
The final correlation structure should be checked because it is not always possible to build the target correlation structure.
In a Monte-Carlo simulation, note that the order of the values within each ‘mcnode’ will be changed by this function (excepted for the first one of the list). As a consequence, previous links between variables will be broken. The ‘outrank’ option may help to rebuild these links (see the Examples).
If ‘rank = FALSE’: the matrix or a list of rearranged ‘mcnode’s.
If ‘rank = TRUE’: the order to be used to rearranged the matrix or the ‘mcnodes’ to build the desired correlation structure.
Iman, R. L., & Conover, W. J. (1982). A distribution-free approach to inducing rank correlation among input variables. Communication in Statistics - Simulation and Computation, 11(3), 311-334.
x1 <- rnorm(1000) x2 <- rnorm(1000) x3 <- rnorm(1000) mat <- cbind(x1, x2, x3) ## Target (corr <- matrix(c(1, 0.5, 0.2, 0.5, 1, 0.2, 0.2, 0.2, 1), ncol=3)) ## Before cor(mat, method="spearman") matc <- cornode(mat, target=corr, result=TRUE) ## The first row is unchanged all(matc[, 1] == mat[, 1]) ##Using mcnode and outrank cook <- mcstoc(rempiricalD, values=c(0, 1/5, 1/50), prob=c(0.027, 0.373, 0.600), nsv=1000) serving <- mcstoc(rgamma, shape=3.93, rate=0.0806, nsv=1000) roundserv <- mcdata(round(serving), nsv=1000) ## Strong relation between roundserv and serving (of course) cor(cbind(cook, roundserv, serving), method="spearman") ##The classical way to build the correlation structure matcorr <- matrix(c(1, 0.5, 0.5, 1), ncol=2) matc <- cornode(cook=cook, roundserv=roundserv, target=matcorr) ## The structure between cook and roundserv is OK but ... ## the structure between roundserv and serving is lost cor(cbind(cook=matc$cook, serv=matc$roundserv, serving), method="spearman") ##An alternative way to build the correlation structure matc <- cornode(cook=cook, roundserv=roundserv, target=matcorr, outrank=TRUE) ## Rebuilding the structure roundserv[] <- roundserv[matc$roundserv, , ] serving[] <- serving[matc$roundserv, , ] ## The structure between cook and roundserv is OK and ... ## the structure between roundserv and serving is preserved cor(cbind(cook, roundserv, serving), method="spearman")
x1 <- rnorm(1000) x2 <- rnorm(1000) x3 <- rnorm(1000) mat <- cbind(x1, x2, x3) ## Target (corr <- matrix(c(1, 0.5, 0.2, 0.5, 1, 0.2, 0.2, 0.2, 1), ncol=3)) ## Before cor(mat, method="spearman") matc <- cornode(mat, target=corr, result=TRUE) ## The first row is unchanged all(matc[, 1] == mat[, 1]) ##Using mcnode and outrank cook <- mcstoc(rempiricalD, values=c(0, 1/5, 1/50), prob=c(0.027, 0.373, 0.600), nsv=1000) serving <- mcstoc(rgamma, shape=3.93, rate=0.0806, nsv=1000) roundserv <- mcdata(round(serving), nsv=1000) ## Strong relation between roundserv and serving (of course) cor(cbind(cook, roundserv, serving), method="spearman") ##The classical way to build the correlation structure matcorr <- matrix(c(1, 0.5, 0.5, 1), ncol=2) matc <- cornode(cook=cook, roundserv=roundserv, target=matcorr) ## The structure between cook and roundserv is OK but ... ## the structure between roundserv and serving is lost cor(cbind(cook=matc$cook, serv=matc$roundserv, serving), method="spearman") ##An alternative way to build the correlation structure matc <- cornode(cook=cook, roundserv=roundserv, target=matcorr, outrank=TRUE) ## Rebuilding the structure roundserv[] <- roundserv[matc$roundserv, , ] serving[] <- serving[matc$roundserv, , ] ## The structure between cook and roundserv is OK and ... ## the structure between roundserv and serving is preserved cor(cbind(cook, roundserv, serving), method="spearman")
Provides the dimension (i.e. the number of simulations in the variability dimension, the number of simulations in the uncertainty dimension and the maximum number of variates of a ‘mcnode’ or a ‘mc’ object.
dimmcnode(x) dimmc(x)
dimmcnode(x) dimmc(x)
x |
a ‘mcnode’ or a ‘mc’ object. |
A vector of three scalars: the dimension of variability (1 for ‘"0"’ and ‘"U" mcnode’), the dimension of uncertainty (1 for ‘"0"’ and ‘"V" mcnode’) and the number of variates (the maximal number of variates for an ‘mc’ object.
This function does not test if the object is correctly built. See
is.mcnode
and is.mc
.
data(total) dimmcnode(xVUM2) dimmc(total)
data(total) dimmcnode(xVUM2) dimmc(total)
Density function and random generation from the Dirichlet distribution.
ddirichlet(x, alpha) rdirichlet(n, alpha)
ddirichlet(x, alpha) rdirichlet(n, alpha)
x |
A vector containing a single deviate or a matrix containing one random deviate per row. |
alpha |
A vector of shape parameters, or a matrix of shape parameters by rows. Recycling (by row) is permitted. |
n |
Number of random vectors to generate. If length(n) |
The Dirichlet distribution is the multidimensional generalization of the beta distribution. The original code was adapted to provide a kind of "vectorization" used in multivariates ‘mcnode’.
‘ddirichlet’ gives the density. ‘rdirichlet’ returns a matrix with ‘n’ rows, each containing a single Dirichlet random deviate.
Code is adapted from ‘MCMCpack’. It originates from Greg's Miscellaneous Functions (gregmisc).
dat <- c(1, 10, 100, 1000, 1000, 100, 10, 1) (alpha <- matrix(dat, nrow=4, byrow=TRUE)) round(x <- rdirichlet(4, alpha), 2) ddirichlet(x, alpha) ## rdirichlet used with mcstoc mcalpha <- mcdata(dat, type="V", nsv=4, nvariates=2) (x <- mcstoc(rdirichlet, type="V", alpha=mcalpha, nsv=4, nvariates=2)) unclass(x) x <- mcstoc(rdirichlet, type="VU", alpha=mcalpha, nsv=4, nsu=10, nvariates=2) unclass(x)
dat <- c(1, 10, 100, 1000, 1000, 100, 10, 1) (alpha <- matrix(dat, nrow=4, byrow=TRUE)) round(x <- rdirichlet(4, alpha), 2) ddirichlet(x, alpha) ## rdirichlet used with mcstoc mcalpha <- mcdata(dat, type="V", nsv=4, nvariates=2) (x <- mcstoc(rdirichlet, type="V", alpha=mcalpha, nsv=4, nvariates=2)) unclass(x) x <- mcstoc(rdirichlet, type="VU", alpha=mcalpha, nsv=4, nsu=10, nvariates=2) unclass(x)
Generate multinomially distributed random number vectors and compute multinomial probabilities.
dmultinomial(x, size=NULL, prob, log=FALSE) rmultinomial(n, size, prob)
dmultinomial(x, size=NULL, prob, log=FALSE) rmultinomial(n, size, prob)
x |
vector or matrix of length (or ncol) K of integers in ‘0:size’. |
n |
number of random vectors to draw. |
size |
a vector of integers, say N, specifying the total number of objects that are put into K boxes in the typical multinomial experiment. For ‘dmultinom’, it defaults to ‘sum(x)’. The first element correspond to the vector ‘prob’ or the first row of ‘prob’, ... |
prob |
Numeric non-negative vector of length K, or matrix of size ‘(x x K)’ specifying the probability for the K classes; is internally normalized to sum 1. |
log |
Logical; if TRUE, log probabilities are computed. |
These functions are the vectorized versions of
rmultinom
and dmultinom
. Recycling is
permitted.
x <- c(100, 200, 700) x1 <- matrix(c(100, 200, 700, 200, 100, 700, 700, 200, 100), byrow=TRUE, ncol=3) p <- c(1, 2, 7) p1 <- matrix(c(1, 2, 7, 2, 1, 7, 7, 2, 1), byrow=TRUE, ncol=3) dmultinomial(x1, prob=p) ## is equivalent to c( dmultinom(x1[1, ], prob=p), dmultinom(x1[2, ], prob=p), dmultinom(x1[3, ], prob=p)) dmultinomial(x1, prob=p1, log=TRUE) ## is equivalent to c( dmultinom(x1[1, ], prob=p1[1, ], log=TRUE), dmultinom(x1[2, ], prob=p1[2, ], log=TRUE), dmultinom(x1[3, ], prob=p1[3, ], log=TRUE)) dmultinomial(x, prob=p1, log=TRUE) ## is equivalent to c( dmultinom(x, prob=p1[1, ], log=TRUE), dmultinom(x, prob=p1[2, ], log=TRUE), dmultinom(x, prob=p1[3, ], log=TRUE)) prob <- c(1, 2, 7) rmultinomial(4, 1000, prob) rmultinomial(4, c(10, 100, 1000, 10000), prob) ## rmultinomial used with mcstoc ## (uncertain size and prob) s <- mcstoc(rpois, "U", lambda=50) p <- mcstoc(rdirichlet, "U", nvariates=3, alpha=c(4, 10, 20)) mcstoc(rmultinomial, "VU", nvariates=3, size=s, prob=p)
x <- c(100, 200, 700) x1 <- matrix(c(100, 200, 700, 200, 100, 700, 700, 200, 100), byrow=TRUE, ncol=3) p <- c(1, 2, 7) p1 <- matrix(c(1, 2, 7, 2, 1, 7, 7, 2, 1), byrow=TRUE, ncol=3) dmultinomial(x1, prob=p) ## is equivalent to c( dmultinom(x1[1, ], prob=p), dmultinom(x1[2, ], prob=p), dmultinom(x1[3, ], prob=p)) dmultinomial(x1, prob=p1, log=TRUE) ## is equivalent to c( dmultinom(x1[1, ], prob=p1[1, ], log=TRUE), dmultinom(x1[2, ], prob=p1[2, ], log=TRUE), dmultinom(x1[3, ], prob=p1[3, ], log=TRUE)) dmultinomial(x, prob=p1, log=TRUE) ## is equivalent to c( dmultinom(x, prob=p1[1, ], log=TRUE), dmultinom(x, prob=p1[2, ], log=TRUE), dmultinom(x, prob=p1[3, ], log=TRUE)) prob <- c(1, 2, 7) rmultinomial(4, 1000, prob) rmultinomial(4, c(10, 100, 1000, 10000), prob) ## rmultinomial used with mcstoc ## (uncertain size and prob) s <- mcstoc(rpois, "U", lambda=50) p <- mcstoc(rdirichlet, "U", nvariates=3, alpha=c(4, 10, 20)) mcstoc(rmultinomial, "VU", nvariates=3, size=s, prob=p)
The fictive example is as following:
A batch of ground beef is contaminated with E. coli, with a mean concentration ‘conc’.
Consumers may eat the beef "rare", "medium rare" or "well cooked". If "rare", no bacteria is killed. If "medium rare", 1/5 of bacteria survive. If "well cooked", 1/50 of bacteria survive.
The serving size is variable.
The risk of infection follows an exponential model.
For the one-dimensional model, it is assumed that:
conc <- 10
cook <- sample(n, x=c(1,1/5,1/50),replace=TRUE,prob=c(0.027,0.373,0.600))
serving <- rgamma(n, shape=3.93,rate=0.0806)
expo <- conc * cook * serving
dose <- rpois(n, lambda=expo)
risk <- 1-(1-0.001)^dose
For the two-dimensional model, it is assumed moreover that the concentration and the ‘r’ parameter of the dose response are uncertain.
conc <- rnorm(n,mean=10,sd=2)
r <- runif(n ,min=0.0005,max=0.0015)
data(ec)
data(ec)
A list of two expression to be passed in mcmodel
Fictive example
None
Density, distribution function and random generation for a continuous empirical distribution.
dempiricalC(x, min, max, values, prob=NULL, log=FALSE) pempiricalC(q, min, max, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) qempiricalC(p, min, max, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) rempiricalC(n, min, max, values, prob=NULL)
dempiricalC(x, min, max, values, prob=NULL, log=FALSE) pempiricalC(q, min, max, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) qempiricalC(p, min, max, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) rempiricalC(n, min, max, values, prob=NULL)
x , q
|
Vector of quantiles. |
p |
Vector of probabilities. |
n |
Number of random values. If ‘length(n) > 1’, the length is taken to be the number required. |
min |
A finite minimal value. |
max |
A finite maximal value. |
values |
Vector of numerical values. |
prob |
Optional vector of count or probabilities. |
log , log.p
|
logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
lower.tail |
logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’. |
Given , the distribution value for
with ‘i’ the rank
,
and
the
density is:
The ‘p’ values being normalized to give the distribution a unit area.
‘min’ and/or ‘max’ and/or ‘values’ and/or ‘prob’ may vary: in that case, ‘min’ and/or ‘max’ should be vector(s). ‘values’ and/or ‘prob’ should be matrixes, the first row being used for the first element of ‘x’, ‘q’, ‘p’ or the first random value, the second row for the second element of ‘x’, ‘q’, ‘p’ or random value, ... Recycling is permitted if the number of elements of ‘min’ or ‘max’ or the number of rows of ‘prob’ and ‘values’ are equal or equals one.
‘dempiricalC’ gives the density, ‘pempiricalC’ gives the distribution function, ‘qempiricalC’ gives the quantile function and ‘rempiricalC’ generates random deviates.
prob <- c(2, 3, 1, 6, 1) values <- 1:5 par(mfrow=c(1, 2)) curve(dempiricalC(x, min=0, max=6, values, prob), from=-1, to=7, n=1001) curve(pempiricalC(x, min=0, max=6, values, prob), from=-1, to=7, n=1001) ## Varying values (values <- matrix(1:10, ncol=5)) ## the first x apply to the first row ## the second x to the second one dempiricalC(c(1, 1), values, min=0, max=11) ##Use with mc2d val <- c(100, 150, 170, 200) pr <- c(6, 12, 6, 6) out <- c("min", "mean", "max") ##First Bootstrap in the uncertainty dimension ##with rempirical D (x <- mcstoc(rempiricalD, type = "U", outm = out, nvariates = 30, values = val, prob = pr)) ##Continuous Empirical distribution in the variability dimension mcstoc(rempiricalC, type = "VU", values = x, min=90, max=210)
prob <- c(2, 3, 1, 6, 1) values <- 1:5 par(mfrow=c(1, 2)) curve(dempiricalC(x, min=0, max=6, values, prob), from=-1, to=7, n=1001) curve(pempiricalC(x, min=0, max=6, values, prob), from=-1, to=7, n=1001) ## Varying values (values <- matrix(1:10, ncol=5)) ## the first x apply to the first row ## the second x to the second one dempiricalC(c(1, 1), values, min=0, max=11) ##Use with mc2d val <- c(100, 150, 170, 200) pr <- c(6, 12, 6, 6) out <- c("min", "mean", "max") ##First Bootstrap in the uncertainty dimension ##with rempirical D (x <- mcstoc(rempiricalD, type = "U", outm = out, nvariates = 30, values = val, prob = pr)) ##Continuous Empirical distribution in the variability dimension mcstoc(rempiricalC, type = "VU", values = x, min=90, max=210)
Density, distribution function and random generation for a discrete empirical distribution. This function is vectorized to accept different sets of ‘values’ or ‘prob’.
dempiricalD(x, values, prob=NULL, log=FALSE) pempiricalD(q, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) qempiricalD(p, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) rempiricalD(n, values, prob=NULL)
dempiricalD(x, values, prob=NULL, log=FALSE) pempiricalD(q, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) qempiricalD(p, values, prob=NULL, lower.tail=TRUE, log.p=FALSE) rempiricalD(n, values, prob=NULL)
x , q
|
Vector of quantiles. |
p |
Vector of probabilities. |
n |
Number of random values. If length(n) |
values |
Vector or matrix of numerical values. See details. |
prob |
Optional vector or matrix of count or probabilities. See details. |
log , log.p
|
logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
lower.tail |
logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’. |
If ‘prob’ is missing, the discrete distribution is obtained directly from the vector of ‘values’, otherwise ‘prob’ is used to weight the values. ‘prob’ is normalized before use. Thus, ‘prob’ may be the count of each ‘values’. ‘prob’ values should be non negative and their sum should not be 0.
‘values’ and/or ‘prob’ may vary: in that case, ‘values’ and/or ‘prob’ should be sent as matrixes, the first row being used for the first element of ‘x’, ‘q’, ‘p’ or the first random value, the second row for the second element of ‘x’, ‘q’, ‘p’ or random value, ... Recycling is permitted if the number of rows of ‘prob’ and ‘values’ are equal or if the number of rows of ‘prob’ and/or ‘values’ are one.
‘rempiricalD(n, values, prob)’ with ‘values’ and ‘prob’ as vectors is equivalent to ‘sample(x=values, size=n, replace=TRUE, prob=prob)’.
‘dempiricalD’ gives the density, ‘pempiricalD’ gives the distribution function, ‘qempiricalD’ gives the quantile function and ‘rempiricalD’ generates random deviates.
In the future, the functions should be written for non numerical values.
dempiricalD(1:6, 2:6, prob=c(10, 10, 70, 0, 10)) pempiricalD(1:6, 2:6, prob=c(10, 10, 70, 0, 10)) qempiricalD(seq(0, 1, 0.1), 2:6, prob=c(10, 10, 70, 0, 10)) table(rempiricalD(10000, 2:6, prob=c(10, 10, 70, 0, 10))) ## Varying values (values <- matrix(1:10, ncol=5)) ## the first x apply to the first row : p = 0.2 ## the second x to the second one: p = 0 dempiricalD(c(1, 1), values) ##Use with mc2d ##Non Parameteric Bootstrap val <- c(100, 150, 170, 200) pr <- c(6, 12, 6, 6) out <- c("min", "mean", "max") ##First Bootstrap in the uncertainty dimension (x <- mcstoc(rempiricalD, type = "U", outm = out, nvariates = 30, values = val, prob = pr)) ##Second one in the variability dimension mcstoc(rempiricalD, type = "VU", values = x)
dempiricalD(1:6, 2:6, prob=c(10, 10, 70, 0, 10)) pempiricalD(1:6, 2:6, prob=c(10, 10, 70, 0, 10)) qempiricalD(seq(0, 1, 0.1), 2:6, prob=c(10, 10, 70, 0, 10)) table(rempiricalD(10000, 2:6, prob=c(10, 10, 70, 0, 10))) ## Varying values (values <- matrix(1:10, ncol=5)) ## the first x apply to the first row : p = 0.2 ## the second x to the second one: p = 0 dempiricalD(c(1, 1), values) ##Use with mc2d ##Non Parameteric Bootstrap val <- c(100, 150, 170, 200) pr <- c(6, 12, 6, 6) out <- c("min", "mean", "max") ##First Bootstrap in the uncertainty dimension (x <- mcstoc(rempiricalD, type = "U", outm = out, nvariates = 30, values = val, prob = pr)) ##Second one in the variability dimension mcstoc(rempiricalD, type = "VU", values = x)
Evaluates a mcmodel
object (or a valid expression)
using a specified number of simulations and with (or without) a
specified seed.
evalmcmod(expr, nsv=ndvar(), nsu=ndunc(), seed=NULL)
evalmcmod(expr, nsv=ndvar(), nsu=ndunc(), seed=NULL)
expr |
A model of class |
nsv |
The number of simulations in the dimension of variability used in the evaluation. |
nsu |
The number of simulations in the dimension of uncertainty used in the evaluation. |
seed |
The random seed used for the evaluation. If ‘NULL’ the ‘seed’ is unchanged. |
The model is evaluated. The intermediate variables used to build the ‘mc’ object are not stored.
The results of the evaluation. It should be a ‘mc’ object.
The seed is set at the beginning of the evaluation. Thus, the complete similarity of two evaluations with similar seed is not certain, depending on the structure of your model.
evalmccut
to evaluate high dimension Monte Carlo Model
in a loop.
data(ec) ec$modEC1 evalmcmod(ec$modEC1, nsv=100, nsu=100, seed=666)
data(ec) ec$modEC1 evalmcmod(ec$modEC1, nsv=100, nsu=100, seed=666)
‘extractvar’ extracts one variate from a multivariate node.
‘addvar’ adds consistent ‘mcnode’s to build a multivariate ‘mcnode’ .
extractvar(x, which=1) addvar(...)
extractvar(x, which=1) addvar(...)
x |
a multivariates ‘mcnode’. |
which |
a vector. which variate(s) should be extracted? |
... |
‘mcnode’s to be gathered in a multivariate ‘mcnode’. These ‘mcnode’s should be of same type and dimension. |
The ‘outm’ attribute of the output of ‘addvar’ will be the one of the first element.
The new built ‘mcnode’.
mcnode
for ‘mcnode’ objects.
x <- mcdata(0:3, "0", nvariates = 4) y <- extractvar(x, c(1, 3)) y addvar(x, y)
x <- mcdata(0:3, "0", nvariates = 4) y <- extractvar(x, c(1, 3)) y addvar(x, y)
Shows histogram of a ‘mcnode’ or a ‘mc’ object by ggplot framework.
gghist(x, ...) ## S3 method for class 'mcnode' gghist( x, griddim = NULL, xlab = names(x), ylab = "Frequency", main = "", bins = 30, which = NULL, ... ) ## S3 method for class 'mc' gghist( x, griddim = NULL, xlab = names(x), ylab = "Frequency", main = "", bins = 30, ... )
gghist(x, ...) ## S3 method for class 'mcnode' gghist( x, griddim = NULL, xlab = names(x), ylab = "Frequency", main = "", bins = 30, which = NULL, ... ) ## S3 method for class 'mc' gghist( x, griddim = NULL, xlab = names(x), ylab = "Frequency", main = "", bins = 30, ... )
x |
an 'mc' or an 'mcnode' object |
... |
Further arguments to be passed to geom_histogram() |
griddim |
A vector of two integers, indicating the size of the grid of the graph. If 'NULL', the grid is calculated to produce a "nice" graph. |
xlab |
Vector of labels for the x-axis. If 'NULL', use the name of the node. |
ylab |
Vector of labels for the y-axis. |
main |
Vector of main titles of the graph |
bins |
Number of bins. Defaults to 30. |
which |
An argument used for a multivariate 'mcnode'. Can specify which variate plot to display. When variates are more than one, the output will be saved in a plot list by default or use the number of which variate to display. |
a ggplot object.
Yu Chen and Regis Pouillot
[hist.mc()]
data(total) # When mcnode has one variate gghist(xV) # When mcnode has two variates, the two plots will be saved in a list # if affected to a variable gplots <- gghist(xVUM) # show the first variate plot of xVUM mcnode gplots[[1]] # directly show the first variate plot of xVUM mcnode gghist(xVUM, which = 1) #directly show the first variate plot of xVUM mcnode # Post process gplots[[1]] + ggplot2::geom_histogram(color = "red",fill="blue")
data(total) # When mcnode has one variate gghist(xV) # When mcnode has two variates, the two plots will be saved in a list # if affected to a variable gplots <- gghist(xVUM) # show the first variate plot of xVUM mcnode gplots[[1]] # directly show the first variate plot of xVUM mcnode gghist(xVUM, which = 1) #directly show the first variate plot of xVUM mcnode # Post process gplots[[1]] + ggplot2::geom_histogram(color = "red",fill="blue")
Plots the empirical cumulative distribution function of a [mcnode] or a [mc] object ("'0'" and "'V'" nodes) or the empirical cumulative distribution function of the estimate of a [mcnode] or [mc] object ("'U'" and "'VU'" nodes) based on [ggplot2::ggplot] package.
ggplotmc(x, ...) ## S3 method for class 'mcnode' ggplotmc( x, prec = 0.001, stat = c("median", "mean"), lim = c(0.025, 0.25, 0.75, 0.975), na.rm = TRUE, griddim = NULL, xlab = NULL, ylab = "Fn(x)", main = "", paint = TRUE, xlim = NULL, ylim = NULL, which = NULL, ... ) ## S3 method for class 'mc' ggplotmc( x, prec = 0.001, stat = c("median", "mean"), lim = c(0.025, 0.25, 0.75, 0.975), na.rm = TRUE, griddim = NULL, xlab = NULL, ylab = "Fn(x)", main = "", paint = TRUE, xlim = NULL, ylim = NULL, ... )
ggplotmc(x, ...) ## S3 method for class 'mcnode' ggplotmc( x, prec = 0.001, stat = c("median", "mean"), lim = c(0.025, 0.25, 0.75, 0.975), na.rm = TRUE, griddim = NULL, xlab = NULL, ylab = "Fn(x)", main = "", paint = TRUE, xlim = NULL, ylim = NULL, which = NULL, ... ) ## S3 method for class 'mc' ggplotmc( x, prec = 0.001, stat = c("median", "mean"), lim = c(0.025, 0.25, 0.75, 0.975), na.rm = TRUE, griddim = NULL, xlab = NULL, ylab = "Fn(x)", main = "", paint = TRUE, xlim = NULL, ylim = NULL, ... )
x |
and 'mc' or an 'mcnode' object |
... |
further arguments to be passed to [ggplot2::stat_ecdf()] |
prec |
the precision of the plot. 0.001 will provide an ecdf using the 0.000, 0.001, .002, ..., 1.000 quantiles. |
stat |
the function used for estimates (2D 'mc' or 'mcnode'). By default the median. |
lim |
a vector of numbers (between 0 and 1) indicating the envelope (2D 'mc' or 'mcnode') . Maybe NULL or empty. |
na.rm |
Should 'NA' values be discarded |
griddim |
a vector of two integers, indicating the size of the grid of the graph. If NULL, the grid is calculated to produce a "nice" graph. |
xlab |
vector of labels for the x-axis. If 'NULL', the name of the node is used. |
ylab |
vector of labels for the y-axis. |
main |
vector of main titles of the graph |
paint |
Should the envelopes be filled? |
xlim |
x coordinate range. 'xlim' is either a vector of length 2, used for each graph, or a list of vectors of length 2, whose ith element is used for the ith graph. By default, the data range is used as xlim. |
ylim |
y coordinate range. 'ylim' is either a vector of length 2, used for each graph, or a list of vectors of length 2, whose ith element is used for the ith graph. By default, the data range is 0-1. |
which |
An argument used for an 'mcnode' with multivariates. Can specify which variate plot to display. When variates are more than one, the output will be saved in a plot list by default or use the number of which variate to display. |
a ggplot object.
Yu Chen and Regis Pouillot
[plot.mc()]
data(total) # When mcnode has one variate ggplotmc(xV) # Post process ggplotmc(xV) + ggplot2::ggtitle("post processed") # When mcnode has two variates gplots <- ggplotmc(xVUM) #will save two plots in a list gplots[[1]] # show the first variate plot of xVUM mcnode ggplotmc(xVUM, which = 1) #directly show the first variate plot of xVUM mcnode
data(total) # When mcnode has one variate ggplotmc(xV) # Post process ggplotmc(xV) + ggplot2::ggtitle("post processed") # When mcnode has two variates gplots <- ggplotmc(xVUM) #will save two plots in a list gplots[[1]] # show the first variate plot of xVUM mcnode ggplotmc(xVUM, which = 1) #directly show the first variate plot of xVUM mcnode
Use ggplot to draw spaghetti plots for the [mc] or [mcnode] objects.
ggspaghetti(x, ...) ## S3 method for class 'mc' ggspaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", maxlines = 100, ... ) ## S3 method for class 'mcnode' ggspaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", which = NULL, maxlines = 100, ... )
ggspaghetti(x, ...) ## S3 method for class 'mc' ggspaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", maxlines = 100, ... ) ## S3 method for class 'mcnode' ggspaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", which = NULL, maxlines = 100, ... )
x |
an 'mc' or an 'mcnode' object |
... |
further arguments to be passed to [ggplot2::stat_ecdf()] |
griddim |
a vector of two integers, indicating the size of the grid of the graph. If 'NULL', the grid is calculated to produce a "nice" graph. |
xlab |
vector of labels for the x-axis. If 'NULL', use the name of the node. |
ylab |
vector of labels for the y-axis. |
main |
vector of main titles of the graph |
maxlines |
the maximum number of ecdf to draw. |
which |
An argument used for an 'mcnode' with multivariates. Can specify which variate plot to display. When variates are more than one, the output will be saved in a plot list by default or use the number of which variate to display. |
Yu Chen and Regis Pouillot
data(ec) EC2 <- evalmcmod(ec[[2]]) # When the input is mc object ggspaghetti(EC2) # When the input is mcnode object data(total) # mcnode has one variate ggspaghetti(xV) # This mcnode has two variates, will save two plots in a list gplots <- ggplotmc(xVUM) #will save two plots in a list # show the first variate plot of xVUM mcnode gplots[[1]] # directly show the first variate plot of xVUM mcnode ggspaghetti(xVUM, which = 1)
data(ec) EC2 <- evalmcmod(ec[[2]]) # When the input is mc object ggspaghetti(EC2) # When the input is mcnode object data(total) # mcnode has one variate ggspaghetti(xV) # This mcnode has two variates, will save two plots in a list gplots <- ggplotmc(xVUM) #will save two plots in a list # show the first variate plot of xVUM mcnode gplots[[1]] # directly show the first variate plot of xVUM mcnode ggspaghetti(xVUM, which = 1)
Draws a Tornado chart as provided by tornado.
## For class 'tornado' ggtornado(x, which=1, name=NULL, stat=c("median","mean"), xlab="method", ylab="" ) ## For class 'tornadounc' ggtornadounc(x, which=1, stat="median", name=NULL, xlab="method", ylab="" ) ggtornadounc( x, which = 1, stat = "median", name = NULL, xlab = "method", ylab = "" )
## For class 'tornado' ggtornado(x, which=1, name=NULL, stat=c("median","mean"), xlab="method", ylab="" ) ## For class 'tornadounc' ggtornadounc(x, which=1, stat="median", name=NULL, xlab="method", ylab="" ) ggtornadounc( x, which = 1, stat = "median", name = NULL, xlab = "method", ylab = "" )
x |
A tornado object as provided by the |
which |
Which output to print -for multivariates output-. |
name |
Vector of name of input variables. If NULL, the name will be given from the name of the elements. |
stat |
The name of the statistics of the output to be considered. For a tornado object: "median" or "mean". For a tornadounc object: the value should match one row name of the tornadounc object. Alternatively, for a tornadounc object, the number of the row may be used. |
xlab |
Label of the x axis. Default is to use the correlation method used in the tornado object. |
ylab |
Label of the y axis. Default is empty. |
data(ec) x <- evalmcmod(ec$modEC2, nsv=100, nsu=100, seed=666) tor <- tornado(x, 7) ggtornado(tor) data(total) ggtornado(tornadounc(total, 10, use="complete.obs"), which=1)
data(ec) x <- evalmcmod(ec$modEC2, nsv=100, nsu=100, seed=666) tor <- tornado(x, 7) ggtornado(tor) data(total) ggtornado(tornadounc(total, 10, use="complete.obs"), which=1)
Shows histogram of a ‘mcnode’ or a ‘mc’ object.
## S3 method for class 'mc' hist(x, griddim=NULL, xlab=names(x), ylab="Frequency", main="", ...) ## S3 method for class 'mcnode' hist(x, ...)
## S3 method for class 'mc' hist(x, griddim=NULL, xlab=names(x), ylab="Frequency", main="", ...) ## S3 method for class 'mcnode' hist(x, ...)
x |
An ‘mcnode’ or an ‘mc’ object. |
griddim |
A vector of two integers, indicating the size of the grid of plots. If ‘NULL’, the grid is calculated to produce a "nice" graph. |
xlab |
A vector of labels for the x-axis for drawn histograms (those whose ‘outm(x)!="none"’). May be recycled. |
ylab |
A vector of labels for the y-axis for drawn histograms. May be recycled. |
main |
A vector of main title of histograms for drawn histograms. May be recycled. |
... |
Other arguments to be passed to all calls of ‘hist’. |
For Two-dimensional ‘mc’, the histogram is based on all data (variability and uncertainty) pooled together.
data(total) hist(xVUM3) hist(total)
data(total) hist(xVUM3) hist(total)
‘is.mc’ tests ‘mc’ objects and ‘is.mcnode’ tests ‘mcnode’ objects.
is.mc(x) is.mcnode(x)
is.mc(x) is.mcnode(x)
x |
An ‘mc’ or a ‘mcnode’ object. |
‘is.mc’ tests if ‘x’ is a list of ‘mcnode’, each elements being of compatible dimension. It tests if the class ‘"mc"’ is affected to the object.
‘is.mcnode’ tests if ‘x’ is an array of numeric or logical, if it has a "type" attribute and compatible dimensions, and if the class ‘"mcnode"’ is affected to the object.
‘TRUE’ or ‘FALSE’
data(total) is.mcnode(xVU) is.mcnode(total) is.mc(total)
data(total) is.mcnode(xVU) is.mcnode(total) is.mc(total)
Creates a Latin Hypercube Sample (LHS) of the specified distribution.
lhs(distr="runif", nsv=ndvar(), nsu=ndunc(), nvariates=1, ...)
lhs(distr="runif", nsv=ndvar(), nsu=ndunc(), nvariates=1, ...)
distr |
The function for generating random sample or its name. If ‘distr’ is "rdist", the function "qdist" must be the quantile function of this distribution with argument ‘p’ as a vector of probabilities, as all univariates distributions of the ‘stat’ library. |
nsv |
The number of rows of the final matrix. |
nsu |
The number of columns of the final matrix |
nvariates |
The number of variates |
... |
All arguments to be passed to ‘distr’ except the size of the sample. |
A ‘nsv x nsu’ matrix of random variates.
The resulting lhs is in fact a latin hypersquare sampling: the lhs is provided only in the first 2 dimensions.
It is not possible to send truncated distribution with
rtrunc
. Use mcstoc
for this purpose, with
‘lhs=TRUE’ and ‘rtrunc=TRUE’.
The ... arguments will be recycled.
adapted from a code of Rob Carnell (library ‘lhs’)
ceiling(lhs(runif, nsu=10, nsv=10)*10)
ceiling(lhs(runif, nsu=10, nsv=10)*10)
Density, distribution function, quantile function and random generation for a log normal distribution whose arithmetic mean equals to ‘mean’ and standard deviation equals to ‘sd’.
dlnormb(x, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), log = FALSE) plnormb( q, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), lower.tail = TRUE, log.p = FALSE ) qlnormb( p, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), lower.tail = TRUE, log.p = FALSE ) rlnormb(n, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)))
dlnormb(x, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), log = FALSE) plnormb( q, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), lower.tail = TRUE, log.p = FALSE ) qlnormb( p, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)), lower.tail = TRUE, log.p = FALSE ) rlnormb(n, mean = exp(0.5), sd = sqrt(exp(2) - exp(1)))
x , q
|
vector of quantiles. |
mean |
the mean of the distribution. |
sd |
the standard deviation of the distribution. |
log , log.p
|
logical. if 'TRUE' probabilities 'p' are given as 'log(p)'. |
lower.tail |
logical. if 'TRUE', probabilities are |
p |
vector of probabilities. |
n |
number of observations. If 'length(n) > 1', the length is taken to be the number required. |
This function calls the corresponding density, distribution function, quantile function and random generation
from the log normal (see Lognormal
) after evaluation of and
‘dlnormb’ gives the density, ‘plnormb’ gives the distribution function, ‘qlnormb’ gives the quantile function, and ‘rlnormb’ generates random deviates. The length of the result is determined by ‘n’ for ‘rlnorm’, and is the maximum of the lengths of the numerical arguments for the other functions. The numerical arguments other than ‘n’ are recycled to the length of the result. Only the first elements of the logical arguments are used.
The default ‘mean’ and ‘sd’ are chosen to provide a distribution close to a lognormal with ‘meanlog = 0’ and ‘sdlog = 1’.
x <- rlnormb(1E5,3,6) mean(x) sd(x) dlnormb(1) == dnorm(0) dlnormb(1) == dlnorm(1)
x <- rlnormb(1E5,3,6) mean(x) sd(x) dlnormb(1) == dnorm(0) dlnormb(1) == dlnorm(1)
Creates ‘mc’ objects from mcnode
or ‘mc’
objects.
mc(..., name=NULL, devname=FALSE)
mc(..., name=NULL, devname=FALSE)
... |
‘mcnode’ and/or ‘mc’ object(s) to be gathered in a ‘mc’ object separated by a coma. |
name |
Vector of character of the same length of the final ‘mc’ object. If NULL, the name will be given from the name of the elements. |
devname |
Develop the name from the name of the ‘mc’ objects, if any. |
A ‘mc’ object is a list of mcnode
objects.
‘mcnode’ objects must be of coherent dimensions.
If one of the arguments is a ‘mc’ object, the name of the elements of this ‘mc’ object are used. ‘devname = TRUE’ will develop the name, using as a prefix the name of the ‘mc’ object.
Finally, names are transformed to be unique.
An object of class ‘mc’.
mcnode
, the basic element of a ‘mc’ object.
To evaluate ‘mc’ objects: mcmodel
,
evalmcmod
, evalmccut
Informations about an ‘mc’ object: is.mc
,
dimmc
To study ‘mc’ objects: print.mc
,
summary.mc
, plot.mc
,
converg
, hist.mc
, tornado
,
tornadounc.mc
x <- mcstoc(runif) y <- mcdata(3, type="0") z <- x * y (m <- mc(x, y, z, name=c('n1', 'n2', 'n3'))) mc(m, x, devname=TRUE)
x <- mcstoc(runif) y <- mcdata(3, type="0") z <- x * y (m <- mc(x, y, z, name=c('n1', 'n2', 'n3'))) mc(m, x, devname=TRUE)
Sets or retrieves the default number of simulations.
ndvar(n) ndunc(n)
ndvar(n) ndunc(n)
n |
Number of simulations. |
‘ndvar()’ gets and ‘ndvar(n)’ sets the default number of simulation in the 1D simulations or the number of simulation in the variability dimension in the 2D simulations.
‘ndunc()’ gets and ‘ndunc(n)’ sets the number of simulations in the uncertainty dimension in the 2D simulations.
‘n’ is rounded to its ceiling value.
The default values when loaded are 1001 for ‘ndvar’ and 101 for ‘ndunc’.
The current value, AFTER modification if ‘n’ is present (!= ‘options’).
(oldvar <- ndvar()) (oldunc <- ndunc()) mcstoc(runif, type="VU") ndvar(12) ndunc(21) mcstoc(runif, type="VU") ndvar(oldvar) ndunc(oldunc)
(oldvar <- ndvar()) (oldunc <- ndunc()) mcstoc(runif, type="VU") ndvar(12) ndunc(21) mcstoc(runif, type="VU") ndvar(oldvar) ndunc(oldunc)
Apply a function on all values or over a given dimension of an ‘mcnode’ object. May be used for all ‘mcnode’ of an ‘mc’ object.
mcapply(x, margin=c("all", "var", "unc", "variates"), fun, ...)
mcapply(x, margin=c("all", "var", "unc", "variates"), fun, ...)
x |
A ‘mc’ or a ‘mcnode’ object. |
margin |
The dimension on which applying the function. Maybe ‘"all"’ (default) to apply the function on all values, ‘"var"’ to apply the function on the variability dimension, ‘"unc"’ to apply the function on the uncertainty dimension, or ‘"variates"’ to apply the function on the variates. Watch out: do not use 'var' for 'variates' |
fun |
The function to be applied. When applied to a vector of length ‘n’, ‘fun’ should return a vector of length ‘n’ or ‘1’. |
... |
Optional arguments to ‘fun’. |
If ‘fun’ returns a function of length ‘n’ or if ‘margin="all"’, the returned ‘mcnode’s are of type and dimension of ‘x’. In other cases, the type of ‘mcnode’ is changed.
data(total) xVUM mcapply(xVUM, "unc", sum) mcapply(xVUM, "var", sum) mcapply(xVUM, "all", sum) mcapply(xVUM, "variates", sum) mcapply(total, "all", exp)
data(total) xVUM mcapply(xVUM, "unc", sum) mcapply(xVUM, "var", sum) mcapply(xVUM, "all", sum) mcapply(xVUM, "variates", sum) mcapply(total, "all", exp)
‘evalmccut’ evaluates a Two-Dimensional Monte Carlo model using a loop on the uncertainty dimension. Within each loop, it calculates statistics in the variability dimension and stores them for further analysis. It allows to evaluate very high dimension models using (unlimited?) time instead of (limited) memory.
‘mcmodelcut’ builds a ‘mcmodelcut’ object that can be sent to ‘evalmccut’.
evalmccut(model, nsv=ndvar(), nsu=ndunc(), seed=NULL, ind="index") ## S3 method for class 'mccut' print(x, lim=c(0.025, 0.975), digits=3, ...) mcmodelcut(x, is.expr=FALSE)
evalmccut(model, nsv=ndvar(), nsu=ndunc(), seed=NULL, ind="index") ## S3 method for class 'mccut' print(x, lim=c(0.025, 0.975), digits=3, ...) mcmodelcut(x, is.expr=FALSE)
model |
a ‘mcmodelcut’ object obtained using ‘mcmodelcut’ function or (directly) a valid call including three blocks. See Details and Examples for the structure of the call. |
x |
a call or an expression (if ‘is.expr=TRUE’) including three blocks. See Details and Examples for the structure of the call. |
nsv |
The number of simulations for variability used in the evaluation. |
nsu |
The number of simulations for uncertainty used in the evaluation. |
seed |
The random seed used for the evaluation. If ‘NULL’ the ‘seed’ is unchanged. |
ind |
The variable name used in ‘model’ to refers to the uncertainty. see Details and Example. |
is.expr |
‘FALSE’ to send a call, ‘TRUE’ to send an
expression (see |
lim |
A vector of values used for the quantile function (uncertainty dimension). |
digits |
Number of digits in the print. |
... |
Additional arguments to be passed in the final print function. |
This function should be used for high dimension Two-Dimensional Monte-Carlo simulations, when the memory limits of R are attained. The use of a loop will take (lots of) time, but less memory.
‘x’ (or ‘model’ if a call is used directly in ‘evalmccut’) should be built as three blocks, separated by ‘{’.
The first block is evaluated once (and only once) before the first loop (step 1).
The second block, which should lead to an ‘mc’ object, is evaluated using ‘nsu = 1’ (step 2).
The third block is evaluated on the ‘mc’ object. All resulting statistics are stored (step 3).
The steps 2 and 3 are repeated ‘nsu’ times. At each iteration, the values of the loop index (from 1 to ‘nsu’) is given to the variable specified in ‘ind’.
Finally, the ‘nsu’ statistics are returned in an invisible object of class ‘mccut’.
Understanding this, the call should be built like this: ‘{{block 1}{block 2}{block 3}}’
The first block (maybe empty) is an expression that will be evaluated only once. This block should evaluate all ‘"V" mcnode’ and ‘"0" mcnode’s. It may evaluate and ‘"U" mcnode’ that will be sent in the second and third block by column, and, optionaly, some other codes (even ‘"VU" mcnode’, sent by columns) that can not be evaluated if ‘ndunc=1’ (e.g. sampling without replacement in the uncertainty dimension).
The second block is an expression that leads to the ‘mc’ object. It must end with an expression as ‘mymc <- mc(...)’. The variable specified as ‘ind’ may be helpful to refer to the uncertainty dimension in this step
The last block should build a list of statistics refering to
the ‘mc’ object. The function ‘summary’ should be used if a
summary, a tornado on uncertainty (tornadounc.mccut
) or
a convergence diagnostic converg
is needed, the
function plot.mc
should be used if a plot is needed,
the function tornado
should be used if a tornado is
needed. Moreover, any other function that leads to a vector, a
matrix, or a list of vector/matrix of statistics evaluated from the
‘mc’ object may be used. list are time consuming.
IMPORTANT WARNING: do not forget to affect the results, since the print method provide only a summary of the results while all data may be stored in an ‘mccut’ object.
An object of class ‘mccut’. This is a list including statistics evaluated within the third block. Each list consists of all the ‘nsu’ values obtained. The ‘print.mccut’ method print the median, the mean, the ‘lim’ quantiles estimated on each statistics on the uncertainty dimension.
The methods and functions available on the ‘mccut’ object is function of the statistics evaluated within the third block:
a print.mccut
is available as soon as one
statistic is evaluated within the third block;
a summary.mccut
and a
tornadounc.mccut
are available if a
summary.mc
is evaluated within the third block;
converg
may be used if a summary.mc
is evaluated within the third block;
a plot.mccut
is available if a
plot.mc
is evaluated within the third block. (Do not
forget to use the argument ‘draw = FALSE’ in the third block);
a tornado
is available if a tornado
is evaluated within the third block.
The seed is set at the beginning of the evaluation. Thus, the
complete similarity of two evaluations is not certain, depending of
the structure of your model. Moreover, with a similar seed, the
simulation will not be equal to the one obtained with
evalmcmod
since the random samples will not be obtained
in the same order.
In order to avoid conflicts between the ‘model’ evaluation and the function, the function uses upper case variables. Do not use upper case variables in your model.
The function should be re-adapted if a new function to be applied on ‘mc’ objects is written.
modEC3 <- mcmodelcut({ ## First block: ## Evaluates all the 0, V and U nodes. { cook <- mcstoc(rempiricalD, type = "V", values = c(0, 1/5, 1/50), prob = c(0.027, 0.373, 0.6)) serving <- mcstoc(rgamma, type = "V", shape = 3.93, rate = 0.0806) conc <- mcstoc(rnorm, type = "U", mean = 10, sd = 2) r <- mcstoc(runif, type = "U", min = 5e-04, max = 0.0015) } ## Second block: ## Evaluates all the VU nodes ## Leads to the mc object. { expo <- conc * cook * serving dose <- mcstoc(rpois, type = "VU", lambda = expo) risk <- 1 - (1 - r)^dose res <- mc(conc, cook, serving, expo, dose, r, risk) } ## Third block: ## Leads to a list of statistics: summary, plot, tornado ## or any function leading to a vector (et), a list (minmax), ## a matrix or a data.frame (summary) { list( sum = summary(res), plot = plot(res, draw=FALSE), minmax = lapply(res, range) ) } }) x <- evalmccut(modEC3, nsv = 101, nsu = 101, seed = 666) summary(x)
modEC3 <- mcmodelcut({ ## First block: ## Evaluates all the 0, V and U nodes. { cook <- mcstoc(rempiricalD, type = "V", values = c(0, 1/5, 1/50), prob = c(0.027, 0.373, 0.6)) serving <- mcstoc(rgamma, type = "V", shape = 3.93, rate = 0.0806) conc <- mcstoc(rnorm, type = "U", mean = 10, sd = 2) r <- mcstoc(runif, type = "U", min = 5e-04, max = 0.0015) } ## Second block: ## Evaluates all the VU nodes ## Leads to the mc object. { expo <- conc * cook * serving dose <- mcstoc(rpois, type = "VU", lambda = expo) risk <- 1 - (1 - r)^dose res <- mc(conc, cook, serving, expo, dose, r, risk) } ## Third block: ## Leads to a list of statistics: summary, plot, tornado ## or any function leading to a vector (et), a list (minmax), ## a matrix or a data.frame (summary) { list( sum = summary(res), plot = plot(res, draw=FALSE), minmax = lapply(res, range) ) } }) x <- evalmccut(modEC3, nsv = 101, nsu = 101, seed = 666) summary(x)
Specify a ‘mcmodel’, without evaluating it, for a further
evaluation using evalmcmod
.
mcmodel(x, is.expr=FALSE)
mcmodel(x, is.expr=FALSE)
x |
An R call or an expression. |
is.expr |
‘FALSE’ to send a call, ‘TRUE’ to send an expression (see Examples) |
The model should be put between ‘{’ and the last line should be of the form ‘mc(...)’. Any reference to the number of simulation in the dimension of variability should be done via ‘ndvar()’ or (preferred) ‘nsv’. Any reference to the number of simulations in the dimension of uncertainty should be done via ‘ndunc()’ or (preferred) ‘nsu’.
an R expression, with class ‘mcmodel’
evalmcmod
to evaluate the model.
mcmodelcut
to evaluate high Dimension Monte Carlo
Model in a loop.
modEC1 <- mcmodel({ conc <- mcdata(10, "0") cook <- mcstoc(rempiricalD, values=c(0, 1/5, 1/50), prob=c(0.027, 0.373, 0.600)) serving <- mcstoc(rgamma, shape=3.93, rate=0.0806) expo <- conc * cook * serving dose <- mcstoc(rpois, lambda=expo) risk <- 1-(1-0.001)^dose mc(conc, cook, serving, expo, dose, risk) }) evalmcmod(modEC1, nsv=100, nsu=100)
modEC1 <- mcmodel({ conc <- mcdata(10, "0") cook <- mcstoc(rempiricalD, values=c(0, 1/5, 1/50), prob=c(0.027, 0.373, 0.600)) serving <- mcstoc(rgamma, shape=3.93, rate=0.0806) expo <- conc * cook * serving dose <- mcstoc(rpois, lambda=expo) risk <- 1-(1-0.001)^dose mc(conc, cook, serving, expo, dose, risk) }) evalmcmod(modEC1, nsv=100, nsu=100)
Creates a ‘mcnode’ object from a vector, an array or a ‘mcnode’.
mcdata(data, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each") mcdatanocontrol(data, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each")
mcdata(data, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each") mcdatanocontrol(data, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each")
data |
The numeric/logical vector/matrix/array of data or the ‘mcnode’ object. |
type |
The type of node to be built. By default, a ‘"V"’ node. |
nsv |
The variability dimension (‘type="V"’ or
‘type="VU"’) of the node. By default: the current value in
|
nsu |
The uncertainty dimension (‘type="U"’ or
‘type="VU"’) of the node. By default: the current value in
|
nvariates |
The number of variates. By default: 1 |
outm |
The output of the ‘mcnode’ for multivariates nodes.
May be "each" (default) if output should be provided for each
variates considered independently, "none" for no output or a vector
of name of function(s) (as a character string) that will be applied
on the variates dimension before any output (ex: ‘"mean"’,
‘"median"’, ‘c("min", "max")’). The function should have no
other arguments and send one value per vector of values (ex. do not
use ‘"range"’). Note that the ‘outm’ attribute may be
changed at any time using the |
A ‘mcnode’ object is the basic element of a mc
object. It is an array of dimension ‘(nsv x nsu x nvariates)’.
Four types of ‘mcnode’ exists:
‘"V" mcnode’, for "Variability", are arrays of dimension ‘(nsv x 1 x nvariates)’. The alea in the data should reflect variability of the parameter.
‘"U" mcnode’, for "Uncertainty", are arrays of dimension ‘c(1 x nsu x nvariates)’. The alea in the data should reflect uncertainty of the parameter.
‘"VU" mcnode’, for "Variability and Uncertainty", are arrays of dimension ‘(nsv x nsu x nvariates)’. The alea in the data reflects separated variability (in rows) and uncertainty (in columns) of the parameter.
‘"0" mcnode’, for "Neither Variability or Uncertainty", are arrays of dimension ‘(1 x 1 x nvariates)’. No alea is considered for these nodes. ‘"0" mcnode’ are not necessary in the univariate context (use scalar instead) but may be useful for operations on multivariate nodes.
Multivariate nodes (i.e. ‘nvariates != 1’) should be used for
multivariate distributions implemented in ‘mc2d’
(rmultinomial
, rmultinormal
,
rempiricalD
and rdirichlet
).
For security, recycling rules are limited to fill the array using ‘data’. The general rules is that recycling is only permitted to fill a dimension from 1 to the final size of the dimension.
If the final dimension of the node is ‘(nsv x nsu x nvariates)’ (with ‘nsv = 1’ and ‘nsu = 1’ for ‘"0"’ nodes, ‘nsu = 1’ for ‘"V"’ nodes and ‘nsv = 1’ for ‘"U"’ nodes), ‘mcdata’ accepts :
Vectors of length ‘1’ (recycled on all dimensions), vectors of length ‘(nsv * nsu)’ (filling first the dimension of variability, then the dimension of uncertainty then recycling on nvariates), or vectors of length ‘(nsv * nsu * nvariates)’ (filling first the dimension of variability, then the uncertainty, then the variates).
Matrixes of dimensions ‘(nsv x nsu)’, recycling on variates.
Arrays of dimensions ‘(nsv x nsu x nvariates)’ or ‘(nsv x nsu x 1)’, recycling on variates.
For ‘data’ as ‘mcnode’, recycling is dealt to proper fill the array:
a ‘"V"’ node accepts a ‘"0"’ node of dimension ‘(1 x 1 x nvariates)’ (recycling on variability) or of dimension ‘(1 x 1 x 1)’ (recycling on variability and variates), or a ‘"V"’ node of dimension ‘(nsv x 1 x nvariates)’ or ‘(nsv x 1 x 1)’ (recycling on variates),
a ‘"U"’ node accepts a ‘"0"’ node of dimension ‘(1 x 1 x nvariates)’ (recycling on uncertainty) or of dimension ‘(1 x 1 x 1)’ (recycling on uncertainty and variates), or a ‘"U"’ node of dimension ‘(1 x nsu x nvariates)’, or ‘(1 x nsu x 1)’ (recycling on variates),
a ‘"VU"’ node accepts a ‘"0"’ node of dimension ‘(1 x 1 x nvariates)’ (recycling on variability and uncertainty) or of dimension ‘(1 x 1 x 1)’ (recycling on variability, uncertainty and variates), a ‘"U"’ node of dimension ‘(1 x nsu x nvariates)’(recycling "by row" on the variability dimension), or of dimension ‘(1 x nsu x 1)’(recycled "by row" on the variability dimension then on variates), a ‘"V"’ node of dimension ‘(nsv x 1 x nvariates)’(recycling on the uncertainty dimension) or of dimension ‘(nsv x 1 x 1)’(recycled on the uncertainty dimension then on variates), and a ‘"VU"’ node of dimension ‘(nsv x nsu x nvariates)’ or of dimension ‘(nsv x nsu x 1)’ (recycling on variates).
a ‘"0"’ node accepts a ‘"0"’ node of dimension ‘(1 x 1 x nvariates)’ or ‘(1 x 1 x 1)’ (recycling on variates).
‘mcdatanocontrol’ is a dangerous version of ‘mcnode’ which forces the dimension of data to be ‘(nsv x nsu x nvariates)’ and gives the attributes and the class without any control. This function is useful when your model is tested since it is much more quicker.
An ‘mcnode’ object.
mcstoc
to build a stochastic ‘mcnode’ object,
mcprobtree
to build a stochastic node fro a probability
tree.
Ops.mcnode
for operations on ‘mcnode’ objects.
mc
to build a Monte-Carlo object.
Informations about an mcnode: is.mcnode
,
dimmcnode
, typemcnode
.
To build a correlation structure between ‘mcnode’:
cornode
.
To study ‘mcnode’ objects: print.mcnode
,
summary.mcnode
, plot.mcnode
,
converg
, hist.mcnode
To modify ‘mcnode’ objects: NA.mcnode
oldvar <- ndvar() oldunc <- ndunc() ndvar(3) ndunc(5) (x0 <- mcdata(100, type="0")) mcdata(matrix(100), type="0") (xV <- mcdata(1:ndvar(), type="V")) mcdata(matrix(1:ndvar(), ncol=1), type="V") (xU <- mcdata(10*1:ndunc(), type="U")) mcdata(matrix(10*1:ndunc(), nrow=1), type="U") (xVU <- mcdata(1:(ndvar()*ndunc()), type="VU")) mcdata(matrix(1:(ndvar()*ndunc()), ncol=5, nrow=3), type="VU") ##Do not use ## Not run: mcdata(matrix(1:5, nrow=1), type="VU") ## End(Not run) ##use instead mcdata(mcdata(matrix(1:ndunc(), nrow=1), type="U"), "VU") ##or mcdata(matrix(1:ndunc(), nrow=1), type="U") + mcdata(0, "VU") mcdata(x0, type="0") mcdata(x0, type="V") mcdata(xV, type="V") mcdata(x0, type="U") mcdata(xU, type="U") mcdata(x0, type="VU") mcdata(xU, type="VU") mcdata(xV, type="VU") ##Multivariates (x0M <- mcdata(1:2, type="0", nvariates=2)) mcdata(1, type="0", nvariates=2) (xVM <- mcdata(1:(2*ndvar()), type="V", nvariates=2)) mcdata(1:ndvar(), type="V", nvariates=2) mcdata(array(1:(2*ndvar()), dim=c(3, 1, 2)), type="V", nvariates=2) mcdata(1, type="V", nvariates=2) mcdata(x0, type="V", nvariates=2) mcdata(x0M, type="V", nvariates=2) mcdata(xV, type="V", nvariates=2) mcdata(xVM, type="V", nvariates=2) (xUM <- mcdata(10*(1:(2*ndunc())), type="U", nvariates=2)) mcdata(array(10*(1:(2*ndunc())), dim=c(1, 5, 2)), type="U", nvariates=2) mcdata(1, type="U", nvariates=2) mcdata(x0, type="U", nvariates=2) mcdata(x0M, type="U", nvariates=2) mcdata(xU, type="U", nvariates=2) mcdata(xUM, type="U", nvariates=2) (xVUM <- mcdata(1:(ndvar()*ndunc()), type="VU", nvariates=2)) mcdata(array(1:(ndvar()*ndunc()), dim=c(3, 5, 2)), type="VU", nvariates=2) mcdata(1, type="VU", nvariates=2) mcdata(x0, type="VU", nvariates=2) mcdata(x0M, type="VU", nvariates=2) mcdata(xV, type="VU", nvariates=2) mcdata(xVM, type="VU", nvariates=2) mcdata(xU, type="VU", nvariates=2) mcdata(xUM, type="VU", nvariates=2) mcdata(xVU, type="VU", nvariates=2) mcdata(xVUM, type="VU", nvariates=2) ndvar(oldvar) ndunc(oldunc)
oldvar <- ndvar() oldunc <- ndunc() ndvar(3) ndunc(5) (x0 <- mcdata(100, type="0")) mcdata(matrix(100), type="0") (xV <- mcdata(1:ndvar(), type="V")) mcdata(matrix(1:ndvar(), ncol=1), type="V") (xU <- mcdata(10*1:ndunc(), type="U")) mcdata(matrix(10*1:ndunc(), nrow=1), type="U") (xVU <- mcdata(1:(ndvar()*ndunc()), type="VU")) mcdata(matrix(1:(ndvar()*ndunc()), ncol=5, nrow=3), type="VU") ##Do not use ## Not run: mcdata(matrix(1:5, nrow=1), type="VU") ## End(Not run) ##use instead mcdata(mcdata(matrix(1:ndunc(), nrow=1), type="U"), "VU") ##or mcdata(matrix(1:ndunc(), nrow=1), type="U") + mcdata(0, "VU") mcdata(x0, type="0") mcdata(x0, type="V") mcdata(xV, type="V") mcdata(x0, type="U") mcdata(xU, type="U") mcdata(x0, type="VU") mcdata(xU, type="VU") mcdata(xV, type="VU") ##Multivariates (x0M <- mcdata(1:2, type="0", nvariates=2)) mcdata(1, type="0", nvariates=2) (xVM <- mcdata(1:(2*ndvar()), type="V", nvariates=2)) mcdata(1:ndvar(), type="V", nvariates=2) mcdata(array(1:(2*ndvar()), dim=c(3, 1, 2)), type="V", nvariates=2) mcdata(1, type="V", nvariates=2) mcdata(x0, type="V", nvariates=2) mcdata(x0M, type="V", nvariates=2) mcdata(xV, type="V", nvariates=2) mcdata(xVM, type="V", nvariates=2) (xUM <- mcdata(10*(1:(2*ndunc())), type="U", nvariates=2)) mcdata(array(10*(1:(2*ndunc())), dim=c(1, 5, 2)), type="U", nvariates=2) mcdata(1, type="U", nvariates=2) mcdata(x0, type="U", nvariates=2) mcdata(x0M, type="U", nvariates=2) mcdata(xU, type="U", nvariates=2) mcdata(xUM, type="U", nvariates=2) (xVUM <- mcdata(1:(ndvar()*ndunc()), type="VU", nvariates=2)) mcdata(array(1:(ndvar()*ndunc()), dim=c(3, 5, 2)), type="VU", nvariates=2) mcdata(1, type="VU", nvariates=2) mcdata(x0, type="VU", nvariates=2) mcdata(x0M, type="VU", nvariates=2) mcdata(xV, type="VU", nvariates=2) mcdata(xVM, type="VU", nvariates=2) mcdata(xU, type="VU", nvariates=2) mcdata(xUM, type="VU", nvariates=2) mcdata(xVU, type="VU", nvariates=2) mcdata(xVUM, type="VU", nvariates=2) ndvar(oldvar) ndunc(oldunc)
This function builds an ‘mcnode’ as a mixture ‘mcnode’ objects.
mcprobtree(mcswitch, mcvalues, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each", seed=NULL)
mcprobtree(mcswitch, mcvalues, type=c("V", "U", "VU", "0"), nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each", seed=NULL)
mcswitch |
A vector of probabilities/weights or an ‘mcnode’. |
mcvalues |
A named list of ‘mcnode’s, ‘mcdata’ functions or ‘mcstoc’ functions, or a combination of those objects. Each element should be or lead to a compatible ‘mcnode’ (see Details). |
type |
The type of ‘mcnode’ to be built. By default, a
‘"V"’ node. see |
nsv |
The number of simulations in the variability dimension of the final node. |
nsu |
The number of simulations in the uncertainty dimension of the final node. |
nvariates |
The number of variates of the final ‘mcnode’. |
outm |
The default output of the ‘mcnode’ for multivariates
nodes. see |
seed |
The random seed used for the evaluation. If ‘NULL’ the ‘seed’ is unchanged. |
‘mcswitch’ may be either:
a vector of weights. They need not sum to one, but they should be nonnegative and not all zero. The length of this vector should equal the number of elements in the list ‘mcvalues’. Each elements of ‘mcvalues’ will appear in the final sample a random number of times with probability as specified by this vector.
a ‘"0 mcnode"’ to build any type of node.
a ‘"V mcnode"’ to build a ‘"V mcnode"’ or a ‘"VU mcnode"’.
a ‘"U mcnode"’ to build a ‘"U mcnode"’ or a ‘"VU mcnode"’.
a ‘"VU mcnode"’ to build a ‘"VU mcnode"’.
Each elements of ‘mcvalues’ may be either:
a ‘"0 mcnode"’ to build any type of node.
a ‘"V mcnode"’ to build a ‘"V mcnode"’ or a ‘"VU mcnode"’.
a ‘"U mcnode"’ to build a ‘"U mcnode"’ or a ‘"VU mcnode"’.
a ‘"VU mcnode"’ to build a ‘"VU mcnode"’.
Their name should correspond to the values in ‘mcswitch’, specified as character (See Examples). These elements will be evaluated only if needed : if the corresponding value is not present in ‘mcswitch’, the element will not be evaluated.
An ‘mcnode’ object.
## A mixture of normal (prob=0.75), uniform (prob=0.20) and constant (prob=0.05) conc1 <- mcstoc(rnorm, type="VU", mean=10, sd=2) conc2 <- mcstoc(runif, type="VU", min=-6, max=-5) conc3 <- mcdata(0, type="VU") ## Randomly in the cells whichdist <- mcstoc(rempiricalD, type="VU", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Which is equivalent to mcprobtree(c(.75, .20, .05), list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Not that there is no control on the exact number of occurences. ## Randomly by colums (Uncertainty) whichdist <- mcstoc(rempiricalD, type="U", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Randomly by line (Variability) whichdist <- mcstoc(rempiricalD, type="V", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## The elements of mcvalues may be of various (but compatible) type conc1 <- mcstoc(rnorm, type="V", mean=10, sd=2) conc2 <- mcstoc(runif, type="U", min=-6, max=-5) conc3 <- mcdata(0, type="0") whichdist <- mcstoc(rempiricalD, type="VU", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU")
## A mixture of normal (prob=0.75), uniform (prob=0.20) and constant (prob=0.05) conc1 <- mcstoc(rnorm, type="VU", mean=10, sd=2) conc2 <- mcstoc(runif, type="VU", min=-6, max=-5) conc3 <- mcdata(0, type="VU") ## Randomly in the cells whichdist <- mcstoc(rempiricalD, type="VU", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Which is equivalent to mcprobtree(c(.75, .20, .05), list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Not that there is no control on the exact number of occurences. ## Randomly by colums (Uncertainty) whichdist <- mcstoc(rempiricalD, type="U", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## Randomly by line (Variability) whichdist <- mcstoc(rempiricalD, type="V", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU") ## The elements of mcvalues may be of various (but compatible) type conc1 <- mcstoc(rnorm, type="V", mean=10, sd=2) conc2 <- mcstoc(runif, type="U", min=-6, max=-5) conc3 <- mcdata(0, type="0") whichdist <- mcstoc(rempiricalD, type="VU", values=1:3, prob= c(.75, .20, .05)) mcprobtree(whichdist, list("1"=conc1, "2"=conc2, "3"=conc3), type="VU")
Provides measures of variability, uncertainty, and both combined for an ‘mc’ or an ‘mcnode’ object.
mcratio(x, pcentral=.5, pvar=.975, punc=.975, na.rm=FALSE)
mcratio(x, pcentral=.5, pvar=.975, punc=.975, na.rm=FALSE)
x |
an ‘mc’ or an ‘mcnode’ object |
pcentral |
the quantile for the central tendency. |
.
pvar |
the quantile for the measure of variability. |
punc |
the quantile for the measure of uncertainty. |
na.rm |
a logical value indicating whether NA values should be stripped before the computation proceeds. |
The function evaluates three ratios for each ‘mcnode’. Given:
the ‘(100 * pcentral)’th percentile of uncertainty (by default the median) for the ‘(100 * pcentral)’th percentile of variability
the ‘(100 * pcentral)’th percentile of uncertainty for the ‘(100 * pvar)’th percentile of variability
the ‘(100 * punc)’th percentile of uncertainty for the ‘(100 * pcentral)’th percentile of variability
the ‘(100 * punc)’th percentile of uncertainty for the ‘(100 * pvar)’th percentile of variability
The following ratio are estimated
Variability Ratio: B / A
Uncertainty Ratio: C / A
Overall Uncertainty Ratio: D / A
For multivariate nodes, the statistics are evaluate on each dimension or on statistics according to the corresponding ‘outm’ value.
A matrix.
Ozkaynak, H., Frey, H.C., Burke, J., Pinder, R.W. (2009) "Analysis of coupled model uncertainties in source-to-dose modeling of human exposures to ambient air pollution: A PM2.5 case study", Atmospheric environment, Volume 43, Issue 9, March 2009, Pages 1641-1649.
data(total) mcratio(total, na.rm=TRUE)
data(total) mcratio(total, na.rm=TRUE)
Creates a mcnode
object using a random generating
function.
mcstoc(func=runif, type=c("V", "U", "VU", "0"), ..., nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each", nsample="n", seed=NULL, rtrunc=FALSE, linf=-Inf, lsup=Inf, lhs=FALSE)
mcstoc(func=runif, type=c("V", "U", "VU", "0"), ..., nsv=ndvar(), nsu=ndunc(), nvariates=1, outm="each", nsample="n", seed=NULL, rtrunc=FALSE, linf=-Inf, lsup=Inf, lhs=FALSE)
func |
A function providing random data or its name as character. |
type |
The type of ‘mcnode’ to be built. By default, a
‘"V"’ node. see |
... |
All other arguments but the size of the sample to be passed to ‘func’. These arguments should be vectors or ‘mcnode’s (arrays prohibited). |
nsv |
The number of simulations in the variability dimension. |
nsu |
The number of simulations in the uncertainty dimension. |
nvariates |
The number of variates of the output. |
outm |
The output of the ‘mcnode’ for multivariates nodes.
May be "each" (default) if an output should be provided for each
variates considered independently, "none" for no output or a vector
of functions (as a character string) that will be applied on the
variates dimension before any output (ex: ‘"mean"’,
‘"median"’, ‘c("min","max")’). Each function should return
1 value when applied to 1 value (ex. do not use ‘"range"’). Note
that the ‘outm’ attribute may be changed further using the
|
nsample |
The name of the parameter of the function giving the size of the vector. By default, ‘n’, as in most of the random sampling distributions of the ‘stats’ library (with the exceptions of ‘rhyper’ and ‘rwilcox’ where ‘nsample="nn"’ should be used). |
seed |
The random seed used for the evaluation. If ‘NULL’ the ‘seed’ is unchanged. |
rtrunc |
Should the distribution be truncated? See
|
linf |
If truncated: lower limit. May be a scalar, an array or a mcnode. |
lsup |
If truncated: upper limit. May be a scalar, an array or a mcnode. ‘lsup’ should be pairwise strictly greater then ‘linf’ |
lhs |
Should a Random Latin Hypercube Sampling be used? see
|
Note that arguments after ... must match exactly.
Any function who accepts vectors/matrix as arguments may be used (notably: all current random generator of the ‘stats’ package). The arguments may be sent classically but it is STRONGLY recommended to use consistent ‘mcnode’s if arguments should be recycled, since a very complex recycling is handled for ‘mcnode’ and not for vectors. The rules for compliance of ‘mcnode’ arguments are as following (see below for special functions):
accepts ‘"0" mcnode’ of dimension ‘(1 x 1 x nvariates)’ or of dimension ‘(1 x 1 x 1)’ (recycled) and ‘"V" mcnode’ of dimension ‘(nsv x 1 x nvariates)’ or ‘(nsv x 1 x 1)’ (recycled).
accepts ‘"0" mcnode’ of dimension ‘(1 x 1 x nvariates)’ or of dimension ‘(1 x 1 x 1)’ (recycled) and ‘"U" mcnode’ of dimension ‘(1 x nsu x nvariates)’ or of dimension ‘(1 x nsu x 1)’ (recycled).
accepts ‘"0" mcnode’ of dimension ‘(1 x 1 x nvariates)’ or of dimension ‘(1 x 1 x 1)’ (recycled), ‘"V" mcnode’ of dimension ‘(nsv x 1 x nvariates)’ (recycled classically) or ‘(nsv x 1 x 1)’ (recycled classically), ‘"U" mcnode’ of dimension ‘(1 x nsu x nvariates)’ (recycled by rows) or ‘(1 x nsu x 1)’ (recycled by row on the uncertainty dimension and classically on variates), ‘"VU" mcnode’ of dimension ‘(nsv x nsu x nvariates)’ or of dimension ‘(nsv x nsu x 1)’ (recycled).
accepts ‘"0" mcnode’ of dimension ‘(1 x 1 x nvariates)’ or ‘(1 x 1 x 1)’ (recycled).
Multivariate nodes and multivariate distributions:
The number of variates should be provided (not guesses by the function). A multivariates node may be built using a univariate distribution and ‘nvariates!=1’. See examples.
rdirichlet
needs for ‘alpha’ a vector or a
multivariates nodes and returns a multivariate node.
rmultinomial
needs for ‘size’ and ‘prob’
vectors and/or multivariate nodes and return a univariate or a
multivariate node. rmultinormal
needs for ‘mean’
and ‘sigma’ vectors and/or multivariate nodes and return a
multivariate node. rempiricalD
needs for ‘values’
and ‘prob’ vectors and/or multivariate nodes and return a a
univariate or a multivariate node. See examples.
‘trunc=TRUE’ is valid for univariates distributions only. The distribution will be truncated on ‘(linf, lsup]’. The function 'func' should have a 'q' form (with first argument 'p') and a 'p' form, as all current random generator of the ‘stats’ library. Example : 'rnorm' (has a 'qnorm' and a 'pnorm' form), 'rbeta', 'rbinom', 'rgamma', ...
If ‘lhs=TRUE’, a Random Hypercube Sampling will be used on ‘nsv’ and ‘nsu’ The function 'func' should have a 'q' form (with argument 'p'). ‘lhs=TRUE’ is thus not allowed on multivariates distributions.
An ‘mcnode’ object.
mcnode
for a description of ‘mcnode’ object,
methods and functions on ‘mcnode’ objects.
Ops.mcnode
for operations on ‘mcnode’ objects.
rtrunc
for important warnings on the use of the
‘trunc’ option.
Oldnvar <- ndvar() Oldnunc <- ndunc() ndvar(5) ndunc(4) ## compatibility with mcdata as arguments x0 <- mcstoc(runif, type="0") xV <- mcstoc(runif, type="V") xU <- mcstoc(runif, type="U") xVU <- mcstoc(runif, type="VU") ## "0" accepts mcdata "0" mcstoc(runif, type="0", min=-10, max=x0) ## "V" accepts "0" mcdata and "V" mcdata mcstoc(rnorm, type="V", mean=x0, sd=xV) ## "U" accepts "0" mcdata and "U" mcdata mcstoc(rnorm, type="U", mean=x0, sd=xU) ## "VU" accepts "0" mcdata, "U" mcdata ## "V" mcdata and "U" mcdata with correct recycling mcstoc(rnorm, type="VU", mean=x0, sd=xVU) mcstoc(rnorm, type="VU", mean=xV, sd=xU) ## any function giving a set (vector/matrix) of value of length 'size' works f <- function(popi) 1:popi mcstoc(f, type="V", nsample="popi") ##Multivariates ndvar(2) ndunc(5) ##Build a multivariate node with univariate distribution mcstoc(rnorm, "0", nvariates=3) mcstoc(rnorm, "V", nvariates=3) mcstoc(rnorm, "U", nvariates=3) mcstoc(rnorm, "VU", nvariates=3) ##Build a multivariate node with multivariates distribution alpha <- mcdata(c(1, 1000, 10, 100, 100, 10, 1000, 1), "V", nvariates=4) (p <- mcstoc(rdirichlet, "V", alpha=alpha, nvariates=4)) mcstoc(rmultinomial, "VU", size=10, p, nvariates=4) ##Build a univariates node with "multivariates" distribution size <- mcdata(c(1:5), "U") mcstoc(rmultinomial, "VU", size, p, nvariates=1) #since a multinomial return one value ##Build a multivariates node with "multivariates" distribution mcstoc(rmultinomial, "VU", size, p, nvariates=4) #sent 4 times to fill the array ##Use of rempiricalD with nodes ##A bootstrap ndunc(5) ndvar(5) dataset <- c(1:9) (b <- mcstoc(rempiricalD, "U", nvariates=9, values=dataset)) unclass(b) ##Then we build a VU node by sampling in each set of bootstrap (node <- mcstoc(rempiricalD, "VU", values=b)) unclass(node) ## truncated ndvar(2) ndunc(5) linf <- mcdata(-1:3, "U") x <- mcstoc(rnorm, "VU", rtrunc=TRUE, linf=linf) unclass(round(x)) linf <- mcdata(1:5, "U") mcstoc(rnorm, "VU", nsv=100, rtrunc=TRUE, linf=linf, lhs=TRUE) ndvar(Oldnvar) ndunc(Oldnunc)
Oldnvar <- ndvar() Oldnunc <- ndunc() ndvar(5) ndunc(4) ## compatibility with mcdata as arguments x0 <- mcstoc(runif, type="0") xV <- mcstoc(runif, type="V") xU <- mcstoc(runif, type="U") xVU <- mcstoc(runif, type="VU") ## "0" accepts mcdata "0" mcstoc(runif, type="0", min=-10, max=x0) ## "V" accepts "0" mcdata and "V" mcdata mcstoc(rnorm, type="V", mean=x0, sd=xV) ## "U" accepts "0" mcdata and "U" mcdata mcstoc(rnorm, type="U", mean=x0, sd=xU) ## "VU" accepts "0" mcdata, "U" mcdata ## "V" mcdata and "U" mcdata with correct recycling mcstoc(rnorm, type="VU", mean=x0, sd=xVU) mcstoc(rnorm, type="VU", mean=xV, sd=xU) ## any function giving a set (vector/matrix) of value of length 'size' works f <- function(popi) 1:popi mcstoc(f, type="V", nsample="popi") ##Multivariates ndvar(2) ndunc(5) ##Build a multivariate node with univariate distribution mcstoc(rnorm, "0", nvariates=3) mcstoc(rnorm, "V", nvariates=3) mcstoc(rnorm, "U", nvariates=3) mcstoc(rnorm, "VU", nvariates=3) ##Build a multivariate node with multivariates distribution alpha <- mcdata(c(1, 1000, 10, 100, 100, 10, 1000, 1), "V", nvariates=4) (p <- mcstoc(rdirichlet, "V", alpha=alpha, nvariates=4)) mcstoc(rmultinomial, "VU", size=10, p, nvariates=4) ##Build a univariates node with "multivariates" distribution size <- mcdata(c(1:5), "U") mcstoc(rmultinomial, "VU", size, p, nvariates=1) #since a multinomial return one value ##Build a multivariates node with "multivariates" distribution mcstoc(rmultinomial, "VU", size, p, nvariates=4) #sent 4 times to fill the array ##Use of rempiricalD with nodes ##A bootstrap ndunc(5) ndvar(5) dataset <- c(1:9) (b <- mcstoc(rempiricalD, "U", nvariates=9, values=dataset)) unclass(b) ##Then we build a VU node by sampling in each set of bootstrap (node <- mcstoc(rempiricalD, "VU", values=b)) unclass(node) ## truncated ndvar(2) ndunc(5) linf <- mcdata(-1:3, "U") x <- mcstoc(rnorm, "VU", rtrunc=TRUE, linf=linf) unclass(round(x)) linf <- mcdata(1:5, "U") mcstoc(rnorm, "VU", nsv=100, rtrunc=TRUE, linf=linf, lhs=TRUE) ndvar(Oldnvar) ndunc(Oldnunc)
Density, distribution function, quantile function and random generation for Minimum Quantile Information distribution.
dmqi(x, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, log = FALSE) pmqi(q, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) qmqi(p, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) rmqi(n, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k=0.1, intrinsic = NA ) pmqi( q, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) qmqi( p, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) rmqi( n, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA )
dmqi(x, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, log = FALSE) pmqi(q, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) qmqi(p, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) rmqi(n, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k=0.1, intrinsic = NA ) pmqi( q, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) qmqi( p, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA, lower.tail = TRUE, log.p = FALSE ) rmqi( n, mqi, mqi.quantile = c(0.05, 0.5, 0.95), realization = NULL, k = 0.1, intrinsic = NA )
x , q
|
Vector of quantiles |
mqi |
Minimum quantile information |
mqi.quantile |
The quantile of ‘mqi'. It’s a vector of length 3. Default is 'c(0.05, 0.5, 0.95)', that is the 5th, 50th and 95th. |
realization |
Default is 'NULL'. If not 'NULL', used to define 'L' or 'U' (see details). |
k |
Overshot, default value is 0.1. |
intrinsic |
Use to specify a prior bounds of the intrinsic range. Default = 'NA'. |
log , log.p
|
Logical; if 'TRUE', probabilities 'p' are given as 'log(p)'. |
lower.tail |
Logical; if 'TRUE' (default), probabilities are 'P[X <= x]' otherwise, 'P[X > x]'. |
p |
Vector of probabilities. |
n |
Number of observations. |
,
, and
are percentiles of a distribution with
.
The interval
is given with:
The support of minimum quantile information distribution is determined by the intrinsic range:
where denotes an overshoot and is chosen by the analyst (usually
, which is the default value).
Given the three values of quantile, ,
and
,
and define
,
,
and
the minimum quantile information distribution is given by:
Probability density function
Cumulative distribution function
This distribution is usually used for expert elicitation.
If experts have realization information, then the range is given by:
For some questions, experts may have information for the intrinsic range and set a prior intrinsic range ( and
).
NOTE that the function is vectorized only for x, q, p, n. As a consequence, it can't be used for variable other parameters.
Yu Chen and Arie Havelaar
Hanea, A. M., & Nane, G. F. (2021). An in-depth perspective on the classical model. In International Series in Operations Research & Management Science (pp. 225–256). Springer International Publishing.
curve(dmqi(x, mqi=c(40,50,60), intrinsic=c(0,100)), from=0, to=100, type = "l", xlab="x",ylab="pdf") curve(pmqi(x, mqi=c(40,50,60), intrinsic=c(0,100)), from=0, to=100, type = "l", xlab="x",ylab="cdf") rmqi(n = 10, mqi=c(555, 575, 586))
curve(dmqi(x, mqi=c(40,50,60), intrinsic=c(0,100)), from=0, to=100, type = "l", xlab="x",ylab="pdf") curve(pmqi(x, mqi=c(40,50,60), intrinsic=c(0,100)), from=0, to=100, type = "l", xlab="x",ylab="cdf") rmqi(n = 10, mqi=c(555, 575, 586))
This function is the vectorized version of the ‘rmvnorm’ from the ‘mvtnorm’ library. It provides a random number generator for the multivariate normal distribution with varying vectors of means and varying covariance matrixes.
rmultinormal(n, mean, sigma, method=c("eigen", "svd", "chol")) dmultinormal(x, mean, sigma, log=FALSE)
rmultinormal(n, mean, sigma, method=c("eigen", "svd", "chol")) dmultinormal(x, mean, sigma, log=FALSE)
x |
Vector or matrix of quantiles. If x is a matrix, each row is taken to be a quantile. |
n |
Number of observations. If ‘length(n) > 1’, the length is taken to be the number required. |
mean |
Vector or matrix of means. If a matrix, each row is taken to be a quantile. Default is a vector of 0 of convenient length. |
sigma |
Covariance vector corresponding to the coercion of the covariance matrix into a vector (if unique for all ‘n’ or ‘x’) or array of covariance vectors (if varying according to ‘n’ or ‘x’). default is a diagonal matrix of convenient size. |
method |
Matrix decomposition used to determine the matrix root of sigma, possible methods are eigenvalue decomposition ("eigen", default), singular value decomposition ("svd"), and Cholesky decomposition ("chol"). |
log |
Logical; if ‘TRUE’, densities d are given as log(d). |
‘rmvnorm(n, m, s)’ is equivalent to ‘rmultinormal(n, m, as.vector(s))’. ‘dmvnorm(x, m, s)’ is equivalent to ‘dmultinormal(x, m, as.vector(s))’.
If ‘mean’ and/or ‘sigma’ is a matrix, the first random deviate will use the first row of ‘mean’ and/or ‘sigma’, the second random deviate will use the second row of ‘mean’ and/or ‘sigma’, ... recycling being permitted by raw. If ‘mean’ is a vector of length ‘l’ or is a matrix with ‘l’ columns, ‘sigma’ should be a vector of length ‘l x l’ or a matrix of number of ‘l x 2’ columns.
The use of a varying sigma may be very time consuming.
## including equivalence with dmvnorm ## mean and sigma as vectors (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10), ncol=2)) sigma <- as.vector(sigma) (x <- matrix(c(9, 8, 1, -1), ncol=2)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x, mean, matrix(sigma, ncol=2)) ## mean as matrix (mean <- matrix(c(10, 0, 0, 10), ncol=2)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean[1, ], matrix(sigma, ncol=2)) dmvnorm(x[2, ], mean[2, ], matrix(sigma, ncol=2)) ## sigma as matrix (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean, matrix(sigma[1, ], ncol=2)) dmvnorm(x[2, ], mean, matrix(sigma[2, ], ncol=2)) ## mean and sigma as matrix (mean <- matrix(c(10, 0, 0, 10), ncol=2)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean[1, ], matrix(sigma[1, ], ncol=2)) dmvnorm(x[2, ], mean[2, ], matrix(sigma[2, ], ncol=2)) (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) x <- rmultinormal(1000, mean, sigma) plot(x)
## including equivalence with dmvnorm ## mean and sigma as vectors (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10), ncol=2)) sigma <- as.vector(sigma) (x <- matrix(c(9, 8, 1, -1), ncol=2)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x, mean, matrix(sigma, ncol=2)) ## mean as matrix (mean <- matrix(c(10, 0, 0, 10), ncol=2)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean[1, ], matrix(sigma, ncol=2)) dmvnorm(x[2, ], mean[2, ], matrix(sigma, ncol=2)) ## sigma as matrix (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean, matrix(sigma[1, ], ncol=2)) dmvnorm(x[2, ], mean, matrix(sigma[2, ], ncol=2)) ## mean and sigma as matrix (mean <- matrix(c(10, 0, 0, 10), ncol=2)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) round(rmultinormal(10, mean, sigma)) dmultinormal(x, mean, sigma) ## Eq dmvnorm(x[1, ], mean[1, ], matrix(sigma[1, ], ncol=2)) dmvnorm(x[2, ], mean[2, ], matrix(sigma[2, ], ncol=2)) (mean <- c(10, 0)) (sigma <- matrix(c(1, 2, 2, 10, 10, 2, 2, 1), nrow=2, byrow=TRUE)) x <- rmultinormal(1000, mean, sigma) plot(x)
‘is.na’, ‘is.nan’, ‘is.finite’ and ‘is.infinite’ return a logical ‘mcnode’ of the same dimension as ‘x’.
## S3 method for class 'mcnode' is.na(x) ## S3 method for class 'mcnode' is.nan(x) ## S3 method for class 'mcnode' is.finite(x) ## S3 method for class 'mcnode' is.infinite(x)
## S3 method for class 'mcnode' is.na(x) ## S3 method for class 'mcnode' is.nan(x) ## S3 method for class 'mcnode' is.finite(x) ## S3 method for class 'mcnode' is.infinite(x)
x |
A ‘mcnode’ object. |
A logical ‘mcnode’ object.
x <- log(mcstoc(rnorm, nsv=1001)) x is.na(x)
x <- log(mcstoc(rnorm, nsv=1001)) x is.na(x)
This function alters the way operations are performed on ‘mcnode’ objects for a better consistency of the theory.
## S3 method for class 'mcnode' Ops(e1, e2)
## S3 method for class 'mcnode' Ops(e1, e2)
e1 |
An ‘mcnode’ object, a vector or an array. |
e2 |
An optional ‘mcnode’ object, a vector or a matrix with at least one of both objects as an ‘mcnode’. |
This method will be used for any of the Group Ops
functions.
The rules are as following (illustrated with a ‘+’ function and ignoring the ‘nvariates’ dimension):
‘0 + 0 = 0’;
‘0 + V = V’: classical recycling of the scalar;
‘0 + U = U’: classical recycling of the scalar;
‘0 + VU = VU’: classical recycling of the scalar;
‘V + V = V’: if both of the same ‘(nsv)’ dimension;
‘V + U = VU’: the ‘U’ object will be recycled "by row". The ‘V’ object will be recycled classically "by column";
‘V + VU = VU’: if the dimension of the ‘V’ is ‘(nsv)’ and the dimension of the ‘VU’ is ‘(nsv x nsu)’. The ‘V’ object will be recycled classically "by column";
‘U + U = U’: if both of the same ‘(nsu)’ dimension;
‘U + VU = VU’: if the dimension of the ‘U’ is ‘(nsu)’ and the dimension of the ‘VU’ is ‘(nsv x nsu)’. The ‘U’ object will be recycled "by row";
‘VU + VU = VU’: if the dimension of the ‘VU’ nodes is ‘(nsu x nsv)’;
A vector or an array may be combined with an ‘mcnode’ of size
‘(nsv x nsu)’ if an ‘mcnode’ of this dimension may be built
from this vector/array using the ‘mcdata’ function. See
mcdata
for the rules.
The ‘outm’ attribute is transferred as following: ‘each +
each = each’; ‘none + other = other’; ‘other1 + other2 =
other1’. The ‘outm’ attribute of the resulting node may be
changed using the outm
function.
For multivariate nodes, a recycling on the ‘nvariates’ dimension is done if a ‘(nsu x nsv x nvariates)’ node is combined with a ‘(nsu x nsv x 1)’ node.
The results as a ‘mcnode’ object.
oldvar <- ndvar() oldunc <- ndunc() ndvar(30) ndunc(20) ## Given x0 <- mcdata(3, type="0") xV <- mcdata(1:ndvar(), type="V") xU <- mcdata(1:ndunc(), type="U") xVU <- mcdata(1:(ndunc()*ndvar()), type="VU") x0M <- mcdata(c(5, 10), type="0", nvariates=2) xVM <- mcdata(1:(2*ndvar()), type="V", nvariates=2) xUM <- mcdata(1:(2*ndunc()), type="U", nvariates=2) xVUM <- mcdata(1:(2*(ndunc()*ndvar())), type="VU", nvariates=2) ## All possible combinations ## "0" -x0 x0 + 3 ## "V" -xV 3 + xV xV * (1:ndvar()) xV * x0 xV - xV ## "U" -xU xU + 3 (1:ndunc()) * xU xU * x0 xU - xU ## Watch out the resulting type xV + xU xU + xV ## "VU" -xVU 3 + xVU (1:(ndunc()*ndvar())) * xVU xVU + xV x0 + xVU xU + xVU xVU - xVU ## Some Multivariates x0M+3 xVM * (1:ndvar()) xVM - xV xUM - xU xVUM - xU
oldvar <- ndvar() oldunc <- ndunc() ndvar(30) ndunc(20) ## Given x0 <- mcdata(3, type="0") xV <- mcdata(1:ndvar(), type="V") xU <- mcdata(1:ndunc(), type="U") xVU <- mcdata(1:(ndunc()*ndvar()), type="VU") x0M <- mcdata(c(5, 10), type="0", nvariates=2) xVM <- mcdata(1:(2*ndvar()), type="V", nvariates=2) xUM <- mcdata(1:(2*ndunc()), type="U", nvariates=2) xVUM <- mcdata(1:(2*(ndunc()*ndvar())), type="VU", nvariates=2) ## All possible combinations ## "0" -x0 x0 + 3 ## "V" -xV 3 + xV xV * (1:ndvar()) xV * x0 xV - xV ## "U" -xU xU + 3 (1:ndunc()) * xU xU * x0 xU - xU ## Watch out the resulting type xV + xU xU + xV ## "VU" -xVU 3 + xVU (1:(ndunc()*ndvar())) * xVU xVU + xV x0 + xVU xU + xVU xVU - xVU ## Some Multivariates x0M+3 xVM * (1:ndvar()) xVM - xV xUM - xU xVUM - xU
Changes the output of Nodes
outm(x, value="each", which.node=1)
outm(x, value="each", which.node=1)
x |
A ‘mcnode’ or a ‘mc’ object. |
value |
The output of the ‘mcnode’ for multivariates nodes. May be "each" (default) if output should be provided for each variates considered independently, "none" for no output or a vector of name of function(s) (as a character string) that will be applied on the variates dimension before any output (ex: ‘"mean"’, ‘"median"’, ‘c("min","max")’). The function should have no other arguments and send one value per vector of values (ex. do not use ‘"range"’). |
which.node |
which node should be changed in a ‘mc’ object |
‘x’ with a modified ‘outm’ attribute.
data(total) total$xVUM2 ## since outm = NULL summary(total$xVUM2) x <- outm(total$xVUM2, c("min")) summary(x)
data(total) total$xVUM2 ## since outm = NULL summary(total$xVUM2) x <- outm(total$xVUM2, c("min")) summary(x)
Density, distribution function, quantile function and random generation for the PERT (aka Beta PERT) distribution with minimum equals to ‘min’, mode equals to ‘mode’ (or, alternatively, mean equals to ‘mean’) and maximum equals to ‘max’.
dpert(x, min = -1, mode = 0, max = 1, shape = 4, log = FALSE, mean = 0) ppert( q, min = -1, mode = 0, max = 1, shape = 4, lower.tail = TRUE, log.p = FALSE, mean = 0 ) qpert( p, min = -1, mode = 0, max = 1, shape = 4, lower.tail = TRUE, log.p = FALSE, mean = 0 ) rpert(n, min = -1, mode = 0, max = 1, shape = 4, mean = 0)
dpert(x, min = -1, mode = 0, max = 1, shape = 4, log = FALSE, mean = 0) ppert( q, min = -1, mode = 0, max = 1, shape = 4, lower.tail = TRUE, log.p = FALSE, mean = 0 ) qpert( p, min = -1, mode = 0, max = 1, shape = 4, lower.tail = TRUE, log.p = FALSE, mean = 0 ) rpert(n, min = -1, mode = 0, max = 1, shape = 4, mean = 0)
x , q
|
Vector of quantiles. |
min |
Vector of minima. |
mode |
Vector of modes. |
max |
Vector of maxima. |
shape |
Vector of scaling parameters. Default value: 4. |
log , log.p
|
Logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
mean |
Vector of means, can be specified in place of ‘mode’ as an alternative parametrization. |
lower.tail |
Logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’ |
p |
Vector of probabilities |
n |
Number of observations. If length(n) > 1, the length is taken to be the number required. |
The PERT distribution is a Beta
distribution extended to the domain ‘[min, max]’ with mean
The underlying beta distribution is specified by and
defined as
‘mode’ or ‘mean’ can be specified, but not both. Note: ‘mean’ is the last parameter for back-compatibility. A warning will be provided if some combinations of ‘min’, ‘mean’ and ‘max’ leads to impossible mode.
David Vose (See reference) proposed a modified PERT distribution with a shape parameter different from 4.
The PERT distribution is frequently used (with the triangular distribution) to translate expert estimates of the min, max and mode of a random variable in a smooth parametric distribution.
‘dpert’ gives the density, ‘ppert’ gives the distribution function, ‘qpert’ gives the quantile function, and ‘rpert’ generates random deviates.
Regis Pouillot and Matthew Wiener
Vose D. Risk Analysis - A Quantitative Guide (2nd and 3rd editions, John Wiley and Sons, 2000, 2008).
curve(dpert(x,min=3,mode=5,max=10,shape=6), from = 2, to = 11, lty=3,ylab="density") curve(dpert(x,min=3,mode=5,max=10), from = 2, to = 11, add=TRUE) curve(dpert(x,min=3,mode=5,max=10,shape=2), from = 2, to = 11, add=TRUE,lty=2) legend(x = 8, y = .30, c("Default: 4","shape: 2","shape: 6"), lty=1:3) ## Alternatie parametrization using mean curve(dpert(x,min=3,mean=5,max=10), from = 2, to = 11, lty=2 ,ylab="density") curve(dpert(x,min=3,mode=5,max=10), from = 2, to = 11, add=TRUE) legend(x = 8, y = .30, c("mode: 5","mean: 5"), lty=1:2)
curve(dpert(x,min=3,mode=5,max=10,shape=6), from = 2, to = 11, lty=3,ylab="density") curve(dpert(x,min=3,mode=5,max=10), from = 2, to = 11, add=TRUE) curve(dpert(x,min=3,mode=5,max=10,shape=2), from = 2, to = 11, add=TRUE,lty=2) legend(x = 8, y = .30, c("Default: 4","shape: 2","shape: 6"), lty=1:3) ## Alternatie parametrization using mean curve(dpert(x,min=3,mean=5,max=10), from = 2, to = 11, lty=2 ,ylab="density") curve(dpert(x,min=3,mode=5,max=10), from = 2, to = 11, add=TRUE) legend(x = 8, y = .30, c("mode: 5","mean: 5"), lty=1:2)
Plots the empirical cumulative distribution function of a ‘mcnode’ or a ‘mc’ object ("0" and "V" nodes) or the empirical cumulative distribution function of the estimate of a ‘mcnode’ or ‘mc’ object ("U" and "VU" nodes).
## S3 method for class 'mc' plot(x, prec=0.001, stat=c("median", "mean"), lim=c(0.025, 0.25, 0.75, 0.975), na.rm=TRUE, griddim=NULL, xlab=NULL, ylab="Fn(x)", main="", draw=TRUE, paint=TRUE, xlim=NULL, ylim=NULL, ...) ## S3 method for class 'mcnode' plot(x, ...) ## S3 method for class 'plotmc' plot(x, ...) ## S3 method for class 'mccut' plot(x, stat=c("median", "mean"), lim=c(0.025, 0.25, 0.75, 0.975), griddim=NULL, xlab=names(x), ylab="Fn(x)", main="", draw=TRUE, ...)
## S3 method for class 'mc' plot(x, prec=0.001, stat=c("median", "mean"), lim=c(0.025, 0.25, 0.75, 0.975), na.rm=TRUE, griddim=NULL, xlab=NULL, ylab="Fn(x)", main="", draw=TRUE, paint=TRUE, xlim=NULL, ylim=NULL, ...) ## S3 method for class 'mcnode' plot(x, ...) ## S3 method for class 'plotmc' plot(x, ...) ## S3 method for class 'mccut' plot(x, stat=c("median", "mean"), lim=c(0.025, 0.25, 0.75, 0.975), griddim=NULL, xlab=names(x), ylab="Fn(x)", main="", draw=TRUE, ...)
x |
a ‘mcnode’ or a ‘mc’ objects |
prec |
the precision of the plot. 0.001 will provide an ecdf from the 0.000, 0.001, .002, ..., 1.000 quantiles. |
stat |
the function used for estimates (2D ‘mc’ or ‘mcnode’). By default the median. |
lim |
a vector of numbers (between 0 and 1) indicating the envelope (2D ‘mc’ or ‘mcnode’) . Maybe ‘NULL’ or empty. |
na.rm |
Should NA values be discarded |
griddim |
a vector of two integers, indicating the size of the grid of the graph. If ‘NULL’, the grid is calculated to produce a "nice" graph. |
xlab |
vector of labels for the x-axis. If ‘NULL’, use the name of the node. |
ylab |
vector of labels for the y-axis. |
main |
vector of main titles of the graph. |
draw |
Should the plot be drawn? |
paint |
Should the envelopes be filled? |
xlim |
x coordinate range. ‘xlim’ is either a vector of length 2, used for each graph, or a list of vectors of length 2, whose ith element is used for the ith graph. By default, the data range is used as ‘xlim’. |
ylim |
y coordinate range. ‘ylim’ is either a vector of length 2, used for each graph, or a list of vectors of length 2, whose ith element is used for the ith graph. By default, the data range is 0-1. |
... |
further arguments to be passed to ‘plot.stepfun’. |
‘plot.mcnode’ is a user-friendly function that send the ‘mcnode’ to ‘plot.mc’.
For ‘"VU"’ and ‘"U"’ ‘mcnode’s, quantiles are
calculated using quantile.mc
within each of the
‘nsu’ simulations (i.e. by columns of each ‘mcnode’). The
medians (but may be the means using ‘stat="mean"’) calculated
from the ‘nsu’ values are plotted. The 0.025 and 0.975
quantiles, and the 0.25 and 0.75 quantiles (default values of
‘lim’) of these quantiles are used as the envelope.
A ‘plot.mc’ object, list of the quantiles used to plot the draw.
Cullen AC and Frey HC (1999) Probabilistic techniques in exposure assessment. Plenum Press, USA, pp. 81-155.
data(total) plot(xVUM3) ## only one envelope corresponding to quantiles 0.025 and 0.975 plot(xVUM3, lim=c(0.025, 0.975)) ## only one envelope not painted plot(xVUM3, lim=c(0.025, 0.975), paint=FALSE) def.par <- par(no.readonly = TRUE) par(mar=c(4, 4, 1, 1)) plot(total) par(def.par)
data(total) plot(xVUM3) ## only one envelope corresponding to quantiles 0.025 and 0.975 plot(xVUM3, lim=c(0.025, 0.975)) ## only one envelope not painted plot(xVUM3, lim=c(0.025, 0.975), paint=FALSE) def.par <- par(no.readonly = TRUE) par(mar=c(4, 4, 1, 1)) plot(total) par(def.par)
Draws a Tornado chart as provided by ‘tornado’.
## S3 method for class 'tornado' plot(x, which=1, name=NULL, stat=c("median", "mean"), xlab="method", ylab="", ...) ## S3 method for class 'tornadounc' plot(x, which=1, stat="median", name=NULL, xlab="method", ylab="", ...)
## S3 method for class 'tornado' plot(x, which=1, name=NULL, stat=c("median", "mean"), xlab="method", ylab="", ...) ## S3 method for class 'tornadounc' plot(x, which=1, stat="median", name=NULL, xlab="method", ylab="", ...)
x |
A |
which |
Which output to print -for multivariates output-. |
name |
Vector of name of input variables. If NULL, the name will be given from the name of the elements. |
stat |
The name of the statistics of the output to be considered. For a ‘tornado’ object: "median" or "mean". For a ‘tornadounc’ object: the value should match one row name of the ‘tornadounc’ object. Alternatively, for a ‘tornadounc’ object, the number of the row may be used. |
xlab |
Label of the x axis. if "method", use the correlation method used in the ‘tornado’ object. |
ylab |
Label of the y axis. |
... |
Further arguments to be passed to the ‘plot’ function. |
A point is drawn at the estimate and the segment reflects the uncertainty around this estimate.
NULL
data(ec) x <- evalmcmod(ec$modEC2, nsv=100, nsu=100, seed=666) tor <- tornado(x, 7) plot(tor)
data(ec) x <- evalmcmod(ec$modEC2, nsv=100, nsu=100, seed=666) tor <- tornado(x, 7) plot(tor)
Returns the parallel maxima and minima of the input values.
## S3 method for class 'mcnode' pmin(..., na.rm=FALSE) ## S3 method for class 'mcnode' pmax(..., na.rm=FALSE)
## S3 method for class 'mcnode' pmin(..., na.rm=FALSE) ## S3 method for class 'mcnode' pmax(..., na.rm=FALSE)
... |
One or more ‘mcnodes’s or one or more ‘mcnode’s and vector(s) of compatible size. Note that one ‘mcnode’ must be at the first place. |
na.rm |
a logical indicating whether missing values should be removed. |
‘pmax’ and ‘pmin’ take one or more ‘mcnode’ and/or
vectors as arguments and return a ‘mcnode’ of adequate type and
size giving the "parallel" maxima (or minima) of the ‘mcnode’
and/or vectors. Note that the first element of ... should be an
‘mcnode’. The resulting type of ‘mcnode’ is variable
according to the elements that are passed. The same rules as in
Ops.mcnode
are applied.
an ‘mcnode’ of adequate type and dimension.
ndvar(10);ndunc(21) x <- mcstoc(rnorm, "V") pmin(x, 0) y <- mcdata(rep(c(-1, 1), length=ndunc()), "U") unclass(pmin(x, y))
ndvar(10);ndunc(21) x <- mcstoc(rnorm, "V") pmin(x, 0) y <- mcdata(rep(c(-1, 1), length=ndunc()), "U") unclass(pmin(x, y))
Print a description of the structure of the ‘mc’ or the ‘mcnode’ object.
## S3 method for class 'mc' print(x, digits=3, ...) ## S3 method for class 'mcnode' print(x, ...)
## S3 method for class 'mc' print(x, digits=3, ...) ## S3 method for class 'mcnode' print(x, ...)
x |
a ‘mcnode’ or a ‘mc’ object. |
digits |
Number of digits to be used. |
... |
Further arguments to be passed to the print function. |
An invisible data frame.
mcnode
for ‘mcnode’ objects. mc
for
‘mc’ objects.
Evaluates quantiles of a ‘mc’ object. This function is used by ‘plot.mc’
## S3 method for class 'mc' quantile(x, probs=seq(0, 1, 0.01), lim=c(0.025, 0.975), na.rm=TRUE, ...) ## S3 method for class 'mcnode' quantile(x, ...)
## S3 method for class 'mc' quantile(x, probs=seq(0, 1, 0.01), lim=c(0.025, 0.975), na.rm=TRUE, ...) ## S3 method for class 'mcnode' quantile(x, ...)
x |
a ‘mc’ objects |
probs |
the quantiles to be calculated |
na.rm |
TRUE or FALSE |
lim |
a vector of numbers (between 0 and 1) indicating the envelope. Maybe ‘NULL’ or empty. |
... |
For generic method consistency. |
The quantiles are evaluated in the variability dimension. Then, the median, the mean and the ‘lim’ quantiles are evaluated for each of these quantiles.
A list of quantiles.
data(total) quantile(total$xVUM3) quantile(total)
data(total) quantile(total$xVUM3) quantile(total)
Provides samples from classical R distributions and ‘mc2d’ specific distributions truncated between ‘linf’ (excluded) and ‘lsup’ (included).
rtrunc(distr=runif, n, linf=-Inf, lsup=Inf, ...)
rtrunc(distr=runif, n, linf=-Inf, lsup=Inf, ...)
distr |
A function providing random data or its name as character. The function 'rdistr' should have a 'qdistr' form (with argument 'p') and a 'pdistr' form (with argument 'q'). Example : 'rnorm' (has a 'qnorm' and a 'pnorm' form), 'rbeta', 'rbinom', 'rgamma', ... |
n |
The size of the sample. |
.
linf |
A vector of lower bounds. |
lsup |
A vector of upper bounds, with ‘lsup < linf’ (strictly). |
... |
All arguments to be passed to ‘pdistr’ and ‘qdistr’. |
The function 1) evaluates the ‘p’ values corresponding to ‘linf’ and ‘lsup’ using ‘pdistr’; 2) samples ‘n’ values using ‘runif(n, min=pinf, max=psup)’, and 3) takes the ‘n’ corresponding quantiles from the specified distribution using ‘qdistr’.
All distributions (but sample) implemented in the stats library could be used. The arguments in ... should be named. Do not use 'log' or 'log.p' or 'lower.tail'. For discrete distribution, rtrunc sample within ‘(linf, lsup]’. See example.
A vector of ‘n’ values.
The inversion of the quantile function leads to time consuming functions for some distributions. WARNING: The method is flexible, but can lead to problems linked to rounding errors in some extreme situations. The function checks that the values are in the expected range and returns an error if not. It also warns some extreme situation that could lead to unexpected results. See Examples.
rtrunc("rnorm", n=10, linf=0) range(rtrunc(rnorm, n=1000, linf=3, lsup=5, sd=10)) ## Discrete distributions range(rtrunc(rpois, 1000, linf=2, lsup=4, lambda=1)) ##Examples of rounding problems. ##The first one will provide a warning while the results are unexpected, ##The second will provide an error. ## Not run: table(rtrunc(rbinom, n=1000, size=10, prob=1-1E-20, lsup=9)) table(rtrunc(rbinom, n=1000, size=10, prob=1E-14, linf=0)) ## End(Not run)
rtrunc("rnorm", n=10, linf=0) range(rtrunc(rnorm, n=1000, linf=3, lsup=5, sd=10)) ## Discrete distributions range(rtrunc(rpois, 1000, linf=2, lsup=4, lambda=1)) ##Examples of rounding problems. ##The first one will provide a warning while the results are unexpected, ##The second will provide an error. ## Not run: table(rtrunc(rbinom, n=1000, size=10, prob=1-1E-20, lsup=9)) table(rtrunc(rbinom, n=1000, size=10, prob=1E-14, linf=0)) ## End(Not run)
Use plot to draw spaghetti plots for the mc/mcnode objects.
spaghetti(x, ...) ## S3 method for class 'mc' spaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", maxlines = 100, ... ) ## S3 method for class 'mcnode' spaghetti(x, ...)
spaghetti(x, ...) ## S3 method for class 'mc' spaghetti( x, griddim = NULL, xlab = names(x), ylab = "F(n)", main = "", maxlines = 100, ... ) ## S3 method for class 'mcnode' spaghetti(x, ...)
x |
mc/mcnode object |
... |
further arguments to be passed to plot.stepfun() |
griddim |
a vector of two integers, indicating the size of the grid of the graph. If NULL, the grid is calculated to produce a "nice" graph. |
xlab |
vector of labels for the x-axis. If NULL, use the name of the node. |
ylab |
vector of labels for the y-axis. |
main |
vector of main titles of the graph. |
maxlines |
the maximum number of ecdf to draw. |
data(total) spaghetti(mc(xVUM)) spaghetti(xVUM)
data(total) spaghetti(mc(xVUM)) spaghetti(xVUM)
Provides a summary of a ‘mcnode’, a ‘mc’ or a ‘mccut’ object.
## S3 method for class 'mc' summary(object, probs=c(0, 0.025, 0.25, 0.5, 0.75, 0.975, 1), lim=c(0.025, 0.975), ...) ## S3 method for class 'mcnode' summary(object, probs=c(0, 0.025, 0.25, 0.5, 0.75, 0.975, 1), lim=c(0.025, 0.975), digits=3, ...) ## S3 method for class 'mc' print.summary(x, digits=3, ...) ## S3 method for class 'mccut' summary(object, lim=c(0.025, 0.975), ...)
## S3 method for class 'mc' summary(object, probs=c(0, 0.025, 0.25, 0.5, 0.75, 0.975, 1), lim=c(0.025, 0.975), ...) ## S3 method for class 'mcnode' summary(object, probs=c(0, 0.025, 0.25, 0.5, 0.75, 0.975, 1), lim=c(0.025, 0.975), digits=3, ...) ## S3 method for class 'mc' print.summary(x, digits=3, ...) ## S3 method for class 'mccut' summary(object, lim=c(0.025, 0.975), ...)
object |
a ‘mcnode’ or a ‘mc’ object or a ‘mccut’ object. |
x |
A ‘summary.mc’ object as provided by the ‘summary.mc’ function. |
probs |
A vector of values used for the quantile function (variability dimension). |
digits |
Number of digits in the print. |
lim |
A vector of values used for the quantile function (uncertainty dimension). |
... |
For generic functions consistency. |
The mean, the standard deviation and the ‘probs’ quantiles will be evaluated in the variability dimension. The median, the mean and the ‘lim’ quantiles will then be evaluated on these statistics in the uncertainty dimension.
Multivariate nodes:
If the ‘"outm"’ attributes of the mcnode is "none", the node is not evaluated, if it is "each" the variates are evaluated one by one, if it is a function (e.g. "mean"), the function is applied on the ‘nvariates’ dimension before providing a classical output.
a list.
mcnode
for mcnode objects, mc
for mc
objects, mccut
for mccut objects,
quantile
data(total) summary(xVUM3) summary(total)
data(total) summary(xVUM3) summary(total)
Provides statistics for a tornado chart. Evaluates correlations between output and inputs of a ‘mc’ object.
tornado(mc, output=length(mc), use="all.obs", method=c("spearman", "kendall", "pearson"), lim=c(0.025, 0.975)) ## S3 method for class 'tornado' print(x, ...)
tornado(mc, output=length(mc), use="all.obs", method=c("spearman", "kendall", "pearson"), lim=c(0.025, 0.975)) ## S3 method for class 'tornado' print(x, ...)
mc |
|
x |
A ‘tornado’ object as provided by the ‘tornado’ function. |
output |
(for ‘mc’ objects only). The rank or the name of the output to be considered. By default: the last element of the ‘mc’. |
use |
(for ‘mc’ objects only). An optional character string
giving a method for computing covariances in the presence of missing
values. This must be (an abbreviation of) one of the strings
"all.obs", "complete.obs" or "pairwise.complete.obs" (see
|
method |
(for ‘mc’ objects only). A character string
indicating which correlation coefficient (or covariance) is to be
computed. One of "spearman" (default), "kendall" or "pearson", can be
abbreviated (see |
lim |
A vector of quantiles used to compute the credible interval in two-dimensional models. |
... |
Further arguments to be passed to the final print function. |
The tornado function computes the spearman's rho statistic. It is used to estimate a rank-based measure of association between one set of random variable of a ‘mc’ object (the output) and the others (the inputs).
‘tornado’ may be applied on a ‘mccut’ object if a
‘tornado’ function was used in the third block of the
evalmccut
call.
If "output" refers to a ‘"0" mcnode’, it is an error. If "output" refers to a ‘"V" mcnode’, correlations are only provided for other ‘"V" mcnode’s. If "output" refers to a ‘"U" mcnode’, correlations are only provided for other ‘"U" mcnode’s. If "output" refers to a ‘"VU" mcnode’, correlations are only provided for other ‘"VU" mcnode’s and ‘"V" mcnode’s.
If use is "all.obs", then the presence of missing observations will produce an error. If use is "complete.obs" then missing values are handled by casewise deletion. Finally, if use has the value "pairwise.complete.obs" then the correlation between each pair of variables is computed using all complete pairs of observations on those variables.
An invisible object of class tornado. A tornado object is a list of objects containing the following objects:
value |
the value of correlation coefficients |
output |
the name of the output |
method |
the method used |
use |
the use parameter |
cor
.
plot.tornado
to draw the results.
data(total) tornado(total, 2, "complete.obs", "spearman", c(0.025, 0.975)) tornado(total, 4, "pairwise.complete.obs", "spearman", c(0.025, 0.975)) tornado(total, 6, "complete.obs", "kendall", c(0.025, 0.975)) tornado(total, 8, "complete.obs", "spearman", c(0.025, 0.975)) (y <- tornado(total, 10, "complete.obs", "spearman", c(0.025, 0.975))) plot(y)
data(total) tornado(total, 2, "complete.obs", "spearman", c(0.025, 0.975)) tornado(total, 4, "pairwise.complete.obs", "spearman", c(0.025, 0.975)) tornado(total, 6, "complete.obs", "kendall", c(0.025, 0.975)) tornado(total, 8, "complete.obs", "spearman", c(0.025, 0.975)) (y <- tornado(total, 10, "complete.obs", "spearman", c(0.025, 0.975))) plot(y)
Provides statistics for a tornado chart. Evaluates correlations between output and inputs of a ‘mc’ object in the uncertainty dimension.
## S3 method for class 'mc' tornadounc(mc, output=length(mc), quant=c(0.5, 0.75, 0.975), use="all.obs", method=c("spearman", "kendall", "pearson"), ...) ## Default S3 method: tornadounc(mc, ...) ## S3 method for class 'tornadounc' print(x, ...) ## S3 method for class 'mccut' tornadounc(mc, output=length(mc), quant=c(0.5, 0.75, 0.975), use="all.obs", method=c("spearman", "kendall", "pearson"), ...)
## S3 method for class 'mc' tornadounc(mc, output=length(mc), quant=c(0.5, 0.75, 0.975), use="all.obs", method=c("spearman", "kendall", "pearson"), ...) ## Default S3 method: tornadounc(mc, ...) ## S3 method for class 'tornadounc' print(x, ...) ## S3 method for class 'mccut' tornadounc(mc, output=length(mc), quant=c(0.5, 0.75, 0.975), use="all.obs", method=c("spearman", "kendall", "pearson"), ...)
mc |
a ‘mc’ object. |
x |
a ‘tornadounc’ object. |
output |
The rank or the name of the output to be considered. Should be a ‘"VU"’ or a ‘"U" type mcnode’. By default: the last element of ‘mc’. |
quant |
The vector of quantiles used in the variability dimension. |
use |
An optional character string giving a method for computing
covariances in the presence of missing values. This must be (an
abbreviation of) one of the strings "all.obs", "complete.obs" or
"pairwise.complete.obs" (see |
method |
A character string indicating which correlation
coefficient (or covariance) is to be computed. One of "spearman"
(default), "kendall" or "pearson", can be abbreviated (see
|
... |
Further arguments to be passed to the final print function. |
The ‘tornadounc.mc’ function computes the spearman's rho statistic between
values (‘"U" type mcnode’) or statistics calculated in the variability dimension (‘"VU" type mcnode’) of inputs and
values (‘"U" type mcnode’) or statistics calculated in the variability dimension (‘"VU" type mcnode’) of one output.
The statistics are the mean, the median and the quantiles specified by ‘quant’.
It is useful to estimate a rank-based measure of association between one set of random variable of a ‘mc’ object (the output) and the others in the uncertainty dimension.
‘tornadounc.mccut’ may be applied on a mccut
object if a ‘summary.mc’ function was used in the third block of
the evalmccut
call.
If output refers to a ‘"0"’ or ‘"V" mcnode’, it is an error.
If use is "all.obs", then the presence of missing observations will produce an error. If use is "complete.obs" then missing values are handled by casewise deletion. Finally, if use has the value "pairwise.complete.obs" then the correlation between each pair of variables is computed using all complete pairs of observations on those variables.
An invisible object of class ‘tornadounc’. A ‘tornadounc’ object is a list of objects containing the following objects:
value |
a matrix of values of correlation coefficients. Each row are the value or the statistics of inputs, each columns the value or the statistics of outputs. |
output |
the name of the output |
method |
the method used |
use |
the ‘use’ parameter |
cor
.
tornado
for tornado in the variability dimension.
plot.tornadounc
to draw the results.
data(total) tornadounc(total, 3) tornadounc(total, 4, use="complete") tornadounc(total, 7, use="complete.obs") tornadounc(total, 8, use="complete.obs") (y <- tornadounc(total, 10, use="complete.obs")) plot(y, 1, 1)
data(total) tornadounc(total, 3) tornadounc(total, 4, use="complete") tornadounc(total, 7, use="complete.obs") tornadounc(total, 8, use="complete.obs") (y <- tornadounc(total, 10, use="complete.obs")) plot(y, 1, 1)
An example for each kind of ‘mcnode’s. They are used in some ‘mc2d’ examples. They have been built using the following code:
ndvar(101)
ndunc(51)
x0 <- mcstoc(type="0")
xV <- mcstoc(type="V")
xU <- mcstoc(type="U")
xVU <- mcstoc(type="VU")
x0M <- mcstoc(type="0",nvariates=2)
xVM <- mcstoc(type="V",nvariates=2)
xUM <- mcstoc(type="U",nvariates=2)
xVUM <- mcstoc(type="VU",nvariates=2)
xVUM[c(1,12,35)] <- NA
xVUM2 <- mcstoc(type="VU",nvariates=2,outm="none")
xVUM3 <- mcstoc(type="VU",nvariates=2,outm=c("mean","min"))
total <- mc(x0,xV,xU,xVU,x0M,xVM,xUM,xVUM,xVUM2,xVUM3)
data(total)
data(total)
Some ‘mcnode’ objects and one ‘mc’ object.
None
None
Density, distribution function, quantile function and random generation for the triangular distribution with minimum equal to ‘min’, mode equal ‘mode’ (alternatively, mean equal ‘mean’) and maximum equal to ‘max’.
dtriang(x, min = -1, mode = 0, max = 1, log = FALSE, mean = 0) ptriang( q, min = -1, mode = 0, max = 1, lower.tail = TRUE, log.p = FALSE, mean = 0 ) qtriang( p, min = -1, mode = 0, max = 1, lower.tail = TRUE, log.p = FALSE, mean = 0 ) rtriang(n, min = -1, mode = 0, max = 1, mean = 0)
dtriang(x, min = -1, mode = 0, max = 1, log = FALSE, mean = 0) ptriang( q, min = -1, mode = 0, max = 1, lower.tail = TRUE, log.p = FALSE, mean = 0 ) qtriang( p, min = -1, mode = 0, max = 1, lower.tail = TRUE, log.p = FALSE, mean = 0 ) rtriang(n, min = -1, mode = 0, max = 1, mean = 0)
x , q
|
vector of quantiles. |
min |
vector of minima. |
mode |
vector of modes. |
max |
vector of maxima. |
log , log.p
|
logical; if ‘TRUE’, probabilities ‘p’ are given as ‘log(p)’. |
mean |
Vector of means, can be specified in place of ‘mode’ as an alternative parametrization. |
lower.tail |
logical; if ‘TRUE’ (default), probabilities are ‘P[X <= x]’, otherwise, ‘P[X > x]’. |
p |
vector of probabilities. |
n |
number of observations. If length(n) > 1, the length is taken to be the number required. |
If ‘min == mode == max’, there is no density in that case and
‘dtriang’ will return ‘NaN’ (the error condition) (Similarity with Uniform
).
‘mode’ or ‘mean’ can be specified, but not both. Note: ‘mean’ is the last parameter for back-compatibility. A warning will be provided if some combinations of ‘min’, ‘mean’ and ‘max’ leads to impossible mode.
‘dtriang’ gives the density, ‘ptriang’ gives the distribution function, ‘qtriang’ gives the quantile function, and ‘rtriang’ generates random deviates.
curve(dtriang(x, min=3, mode=6, max=10), from = 2, to = 11, ylab="density") ## Alternative parametrization curve(dtriang(x, min=3, mean=6, max=10), from = 2, to = 11, add=TRUE, lty=2) ##no density when min == mode == max dtriang(c(1,2,3),min=2,mode=2,max=2)
curve(dtriang(x, min=3, mode=6, max=10), from = 2, to = 11, ylab="density") ## Alternative parametrization curve(dtriang(x, min=3, mean=6, max=10), from = 2, to = 11, add=TRUE, lty=2) ##no density when min == mode == max dtriang(c(1,2,3),min=2,mode=2,max=2)
Provide the type of a ‘mcnode’ object.
typemcnode(x, index=FALSE)
typemcnode(x, index=FALSE)
x |
a ‘mcnode’ object |
index |
if ‘TRUE’ give the index of the type rather than the type. |
‘"0", "V","U" or "VU"’ or the corresponding index if ‘index=TRUE’.
‘NULL’ if none of this element is found.
This function does not test if the object is correct. See
is.mcnode
.
data(total) typemcnode(total$xVUM2)
data(total) typemcnode(total$xVUM2)
Unclasses the ‘mc’ object in a list of arrays or the ‘mcnode’ object in an array.
unmc(x, drop=TRUE)
unmc(x, drop=TRUE)
x |
A ‘mc’ or a ‘mcnode’ object. |
drop |
Should the dimensions of size 1 be dropped (see
|
if x is an ‘mc’ object: a list of arrays. If ‘drop=TRUE’, a list of vectors, matrixes and arrays. if x is an ‘mcnode’ object: an array. If ‘drop=TRUE’, a vector, matrix or array.
data(total) ## A vector unmc(total$xV, drop=TRUE) ## An array unmc(total$xV, drop=FALSE)
data(total) ## A vector unmc(total$xV, drop=TRUE) ## An array unmc(total$xV, drop=FALSE)