For most of the classical distributions, base R provides
probability distribution functions (p), density functions (d), quantile functions
(q), and random number generation (r).
Beyond this basic functionality, many CRAN packages provide
additional useful distributions. In particular, multivariate distributions as well as copulas
are available in contributed packages.
Ultimate bibles on probability distributions are
-
different volumes of N. L. Johnson, S. Kotz and N. Balakrishnan books, e.g. Continuous Univariate Distributions, Vol. 1,
-
Thesaurus of univariate discrete probability distributions by G. Wimmer and G. Altmann.
-
Statistical Distributions by M. Evans, N. Hastings, B. Peacock.
-
Distributional Analysis with L-moment Statistics using the R Environment for Statistical Computing, Asquith (2011).
The maintainer greatfully acknowledged Achim Zeileis, David Luethi, Tobias Verbeke, Robin
Hankin, Mathias Kohl, G. Jay Kerns, Kjetil Halvorsen, William Asquith for their useful comments/suggestions.
If you think information is not accurate
or not complete, please let me know.
Base functionality:
-
Base R provides probability distribution functions
p
foo
()
density functions
d
foo
(), quantile functions
q
foo
(), and random number generation
r
foo
()
where
foo
indicates the type
of distribution:
beta (
foo
=
beta),
binomial
binom,
Cauchy
cauchy,
chi-squared
chisq,
exponential
exp,
Fisher F
f,
gamma
gamma,
geometric
geom,
hypergeometric
hyper,
logistic
logis,
lognormal
lnorm,
negative binomial
nbinom,
normal
norm,
Poisson
pois,
Student t
t,
uniform
unif,
Weibull
weibull.
Following the same naming scheme, but somewhat less standard are the following distributions
in base R: probabilities of coincidences (also known as "birthday paradox")
birthday
(only p and q), studentized range distribution
tukey
(only p and q), Wilcoxon signed rank distribution
signrank, Wilcoxon
rank sum distribution
wilcox.
-
On base R distributions,
prob
provides the characteristic function, while
graphical methods for illustrating probability distributions can be found
in
denstrip.
Discrete distributions:
-
Basic distributions
: The binomial distribution (in particular
Bernoulli distribution) is already implemented in base R.
The discrete uniform
distribution can be easily obtained with the basic functions.
Dirac distribution is provided by
distr. Truncated versions of
the binomial and Poisson distributions as well as zero-inflated
versions of the binomial, Poisson and negative binomial distributions
are implemented in
VGAM. Zero-inflated Poisson distribution
is available in
gamlss.dist.
-
Conway-Maxwell-Poisson distribution
: This can be found in
compoisson.
-
Delaporte distribution
: This can be found in
gamlss.dist
and
Delaporte.
-
Hypergeometric distributions
: Extented hypergeometric distribution
can be found in
BiasedUrn
package, which provides
not only p, d, q, r functions but also mean, variance, mode functions.
Generalized hypergeometric distribution is implemented in
SuppDists.
-
Logarithmic distribution
: This can be found in
VGAM
and
gamlss.dist. A fast random generator is
available for the logarithmic distribution
is implemented in
Runuran
as well as the 'density' function.
-
Multinomial distribution
: This can be found in
mc2d,
LearnBayes
and
MCMCpack.
-
Sichel distribution
: This can be found in
gamlss.dist.
-
Triangle distribution
: The discrete triangle distribution can be found in
TRIANG.
-
Zero inflated/modified (ZI/ZM) distributions
:
ZM (or Hurdle) Poisson, ZM logarithmic,
ZI/ZM negative binomial, ZI Poisson inverse Gaussian,
ZI/ZM binomial, ZI/ZM beta binomial distributions are
implemented in
gamlss.dist.
-
Zipf law
: Package
zipfR
provides tools for the Zipf and
the Zipf-Mandelbrot distributions.
VGAM
also implements the Zipf distribution.
-
Further distributions
: The
VGAM
package provides several
additional distributions, namely: Skellam, Yule-Simon, Zeta and Haight's Zeta,
Borel-Tanner and Felix distribution.
Continuous distributions:
-
Arcsine distribution
: implemented in package
distr.
-
Beard distribution
:
ActuDistns
provide d, h, i, q functions
for the Beard and the Makeham-Beard distributions.
-
Beta distribution and its extensions
: Base R provides
the d, p, q, r functions for this distribution (see above).
actuar
provides moments and limited expected values,
ActuDistns
provides hazard and integrated hazard rate functions.
It also provide the d, p, q, r functions for the generalized beta and
the inverse tranformed beta distribution. The zero and one inflated beta distribution
can be found in
gamlss.dist
as well as generalized beta of the first
and second kind. The
beta of the second kind and the generalized beta distribution
can also be found in
VGAM
and
mc2d. Several special cases of
the generalized beta distribution are also implemented in
VGAM:
Lomax, inverse Lomax, Dagum, Fisk (aka log logistic), (inverse or not)
paralogistic and Singh-Maddala distribution and in
mc2d: Pert.
-
Benini distribution
: Provided in
VGAM.
-
Birnbaum-Saunders distribution
: Provided in package
VGAM. The generalized Birnbaum-Saunders distribution is implemented in
gbs.
-
Box Cox distributions
:
gamlss.dist
provides the Box-Cox normal,
the Box-Cox power exponential and the Box-Cox t distributions.
-
Cardioid distribution
: Provided in
VGAM.
-
Cauchy distribution
: Base R provides
the d, p, q, r functions for this distribution (see above). Other
implementations are available in
lmomco.
-
Chen distribution
: Provided in
reliaR
and
ActuDistns.
-
Chi(-squared or not) distributions
: Base R provides
the d, p, q, r functions for the chi-squared distribution, both central
and non-central (see above). Moments, limited
expected values and the moment generating function are provided by
actuar.
Only d,r functions are available for the inverse chi-squared distribution
by package
geoR. A fast random generator is available for the Chi distribution
is implemented in
Runuran
as well as the density function.
The non-central Chi distribution is not yet implemented. The chi-bar-squared distribution
is implemented in
emdbook.
-
Davies distribution
: The Davies distribution is provided
in
Davies
package.
-
Dirichlet distribution
: functions d, r
are provided in
MCMCpack,
mc2d,
hyperdirichlet
and
bayesm. The generalized and the hyperdirichlet distributions are provided
by
hyperdirichlet.
-
Eta-mu distribution
: Provided in
lmomco.
-
Exponential distribution and its extensions
: Base R provides the d, p, q, r functions
for this distribution (see above).
actuar
provides additional functions
such as the moment generating function, moments and limited expected values. It also has
the d, p, q, r for the inverse exponential distribution.
ActuDistns
provides hazard and integrated hazard rate functions.
The shifted and the
truncated exponential distributions are implemented in
lmomco
package with d, p, q, r functions.
d, p, q, r functions for the power and the skew power exponential type 1-4 distributions are implemented
in
gamlss.dist
and
lmomco.
reliaR
and
ActuDistns
provide
the generalized exponential, the inverse generalized exponential,
the logistic exponential, the Marshall-Olkin Extended Exponential and
the exponential extension distributions.
A fast random generator is available for the power Exponential distribution
is implemented in
Runuran
as well as the density function.
-
Fisher-Snedecor or F distribution
: Base R provides the d, p, q, r functions
for the F distribution, possibly with a non-central parameter. Doubly non-central
F distribution does not seem to be implemented?.
flexsurv
provides d, p, q, r functions as well as
hazard (h) and integrated hazard rate (i) functions for
the generalized F distribution.
ActuDistns
provides integrated hazard rate function
for generalized F distribution.
-
Frechet distribution
: Provided in
VGAM
and
evd. A fast random generator is available for the Frechet distribution
is implemented in
Runuran
as well as the density function.
-
Friedman's Chi distribution
: Provided in
SuppDists.
-
Gamma distribution and its extensions
: Base R provides
the d, p, q, r functions for this distribution (see above).
actuar
provides d, p, q, r functions for the inverse, the inverse
transformed and the log gamma distributions
while
ghyp
provides those functions for the variance gamma distribution.
VarianceGamma
provides d, p, q, r functions for the variance gamma distribution
as well as moments (skewness, kurtosis, ...).
ActuDistns
provides hazard (h) and integrated hazard rate (i) functions for gamma distribution,
q, h, i, q for the generalized gamma, the log-gamma distributions.
VGAM
provides d, p, q, r functions of the log
gamma and the generalized gamma distribution. The generalized gamma distribution
can also be found in
gamlss.dist.
reliaR
provides
the log gamma distribution. See Pearson III for a three-parameter
gamma distribution with a location parameter.
flexsurv
provides d, p, q, r functions as well as
hazard (h) and integrated hazard rate (i) functions for
the generalized gamma distribution.
-
Gaussian (or normal) distribution and its extensions
: Base R provides
the d, p, q, r functions for this distribution (see above).
ActuDistns
provides hazard (h) and integrated hazard rate (i) functions.
The
truncnorm
package provides d, p, q, r functions for the truncated
univariate gaussian distribution as well as functions for the first two moments.
actuar
provides the moment generating function and moments. d, p, q, r functions for the generalized
inverse gaussian distribution can be found in
gamlss.dist
and
HyperbolicDist.
A fast random generator is available for the (generalized) Inverse Gaussian distribution
is implemented in
Runuran
as well as the density function.
SuppDists
provides functions for the inverse Gaussian distribution as well and furthermore includes functions
for computing moments, skewness, kurtosis.
VGAM,
ActuDistns
and
fBasics
also implement
the folded and the skewed normal distribution, the inverse Gaussian distribution, and
fBasics
the normal inverse Gaussian and standardized
normal inverse Gaussian distributions.
lmomco
implements the generalized normal distribution.
The log normal distribution is implemented in Base R (see above), but the 3-parameter lognormal
distribution is available in
lmomco
and
FAdist.
ActuDistns
provides hazard (h) and integrated hazard rate (i) functions
for the lognormal distribution.
The package
loglognorm
implements d, p, q, r functions for the double lognormal distribution,
as well as the raw moment, the expected value and the variance functions.
The Exponentially modified Gaussian is available in
emg,
gamlss.dist
and
retimes.
Finally, the multivariate Gaussian distribution
is provided by the packages
mvtnorm
and
mnormt;
tmvtnorm
implements the truncated
multivariate normal distribution;
sparseMVN
implements very
fast algorithms to compute the density and generate random variates of
a multivariate normal distribution for which the covariance matrix or precision matrix is sparse.
CompQuadForm
provides the distribution function of quadratic forms
in normal variates.
NormalGamma
provides the density of the sum of a gaussian and a gamma random variables.
-
General Error Distribution (also known as exponential power distribution)
:
provided in
normalp
and
fExtremes, see
exponential
item.
-
Generalized Extreme Value distribution
: Provided in
lmomco
(d, p, q) ,
VGAM,
evd,
evir,
FAdist
and
fExtremes
(d, p, q, r). Both bivariate and
multivariate Extreme Value distributions as well as order/maxima/minima distributions
are implemented in
evd
(d, p, r).
evdbayes
provides some
additional functions for GEV distribution using MCMC.
-
Gompertz distribution
: Provided in
reliaR,
ActuDistns,
flexsurv.
ActuDistns
and
flexsurv
also
provide hazard (h) and integrated hazard rate (i) functions.
-
Gumbel distribution
: Provided in packages
lmomco,
VGAM,
gamlss.dist,
FAdist,
reliaR,
ActuDistns
and
evd.
ActuDistns
also provides hazard (h) and integrated hazard rate (i) functions.
A fast random generator is available for the Gumbel distribution
is implemented in
Runuran
as well as the density function.
The reverse Gumbel distribution is implemented in
lmomco
and
gamlss.dist.
The Gumbel II distribution is implemented in
ActuDistns.
-
Hjorth distribution
: Provided in
ActuDistns.
-
Huber's least favourable distribution
: density and random
generator in package
smoothmest.
-
Hyperbolic distribuion
:
fBasics,
ghyp,
GeneralizedHyperbolic
and
HyperbolicDist
packages
provide d, p, q, r functions for the generalized hyperbolic distributions.
SkewHyperbolic
provides the skewed Hyperbolic Student t-Distribution.
fBasics
also implements the standardized generalized Hyperbolic distribution.
A fast random generator is available for the hyperbolic distribution
is implemented in
Runuran
as well as the density function.
-
J-shaped distribution
: Provided in
ActuDistns.
-
Johnson distribution
: Provided in
SuppDists.
-
Kappa distribution
: A 4-parameter Kappa distribution is provided in
lmomco
and
FAdist.
-
Kappa-mu distribution
: Provided in
lmomco.
-
Kendall's tau distribution
: Provided in
SuppDists.
-
Kruskal Wallis distribution
: Provided in
SuppDists.
-
Kumaraswamy distribution
: Provided in packages
VGAM,
ActuDistns
and
lmomco.
-
(Tukey) Lambda distribution and its extensions
: The generalized Lambda
distribution (GLD) is well known for its wide range of shapes. There exists 3 kinds
of GLD in the literature: RS, FMKL and FM5. The following packages implement such distributions
(with d, p, q, r functions):
gld
provides the 3 kinds of GLD,
Davies
provides the RS type and
lmomco
provides the FMKL.
The original Tukey Lambda distribution can be obtained as a special
case of the generalized Lambda distribution.
-
Tukey's H distribution
: provided as a special case of
Lambert W x F distribution.
-
Lai distribution
: Provided in
ActuDistns.
-
Lambert W x F distributions
:
LambertW
package provides
d, p, q, r functions as well as the first 4 central moments and a qqplot.
-
Laplace and asymetric Laplace distribution
: Provided in
lmomco,
VGAM
and
HyperbolicDist
packages.
Laplace distribution (also called double exponential distribution) is implemented in
distr.
A fast random generator is available for the Laplace distribution
is implemented in
Runuran
as well as the density function.
smoothmest
implements the density and the random generator.
-
Linear failure rate distribution
: Provided in
reliaR
and
ActuDistns.
ActuDistns
also provides hazard (h) and integrated hazard rate (i) functions.
-
Loglog distribution
: Provided in
reliaR
and
ActuDistns.
ActuDistns
also provides hazard (h) and integrated hazard rate (i) functions.
-
Logistic distributions and its extensions
: Base R provides
the d, p, q, r functions for this distribution (see above).
ActuDistns
also provides hazard (h) and integrated hazard rate (i) functions.
actuar
provides d, p, q, r functions for
the log logistic (also called Fisk), the paralogistic and the inverse paralogistic distributions.
VGAM
package also implements these distributions plus
the bivariate logistic distribution.
The generalized logistic distribution (Type I, also known as skew-logistic distribution) is provided
in
lmomco
and
glogis.
FAdist
the log-logistic distribution with two and three parameters. Finally,
ActuDistns
implements the log-logistic distribution.
-
Makeham distribution
: Provided in
ActuDistns
as well as
Makeham-Beard and Makeham-Perks distributions.
-
Maxwell distribution
: Provided in
VGAM.
-
Maxwell-Boltzmann-Bose-Einstein-Fermie-Dirac (MBBEFD) distribution
:
Provided in
mbbefd. Note that the distribution is a
mixed-type distribution.
-
Nakagami distribution
: Provided in
VGAM.
-
Pareto distribution
: d, p, q, r functions are implemented in
VGAM
for the Pareto distribution type IV (which includes Burr's distribution,
Pareto type III, Pareto type II (also called the lomax distribution) and
Pareto type I) and the (upper/lower) truncated Pareto distribution. In an actuarial
context,
actuar
provides d, p, q, r functions as well as moments and
limited expected values for the Pareto I and II, the inverse Pareto, the 'generalized pareto'
distributions, the Burr and the inverse Burr distributions. A fast random generator for the
Burr and the Pareto II distribution is implemented in
Runuran
as well as the density.
mgpd
provides the density for the multivariate generalized Pareto distribution
of type II, while
evd
provides the density for type I.
ActuDistns
also provides q, p, q, h functions of the Pareto II distribution and
the Burr-X distribution.
Finally
lmomco,
POT,
evd,
fExtremes,
FAdist
and
evir
packages
implement the Generalized Pareto Distribution (from Extreme Value Theory), which is
depending the shape parameter's value a Pareto II distribution,
a shifted exponential distribution or a generalized beta I distribution.
-
Pearson's distributions
: Pearson type III available
in
lmomco
and
FAdist.
A log-Pearson type III distribution is also available in
FAdist.
PearsonDS
provides the d, p, q, r functions as well as the first
four moments for the Pearson distributions: types I, II, III, IV, V, VI, VII.
-
Pearson's Rho distribution
: Provided in
SuppDists.
-
Perks distribution
: Provided in
ActuDistns
as well as
the Makeham-Perks distribution.
-
Planck's distribution
: a random generator is available in
Runuran.
-
Phase-type distributions
: Provided in
actuar, see also
PhaseType
for inference.
-
Power distributions
:
reliaR
and
ActuDistns
implement the
exponential power distribution.
-
Rayleigh distribution
: Provided in packages
VGAM
and
lmomco. Generalized and logistic Rayleigh distributions are available in
reliaR
and
ActuDistns.
-
Rice distribution
: Provided in
VGAM
and
lmomco.
-
Schabe distribution
: Provided in
ActuDistns.
-
Sinh-Arcsinh distribution
: Provided in
gamlss.dist.
-
Slash distribution
: Provided in
VGAM.
-
Spearman's Rho distribution
: Provided in
SuppDists.
-
stable distributions
: d, p, q, r functions are available in
fBasics
and
stabledist,
the functions use the approach of J.P. Nolan for general stable distributions.
-
Student distribution and its extensions
: Base R provides
the d, p, q, r functions for Student and non central Student distribution (see above).
The skewed Student distribution is provided by
skewt,
sn
and
gamlss.dist
packages.
d, p, q, r functions for the generalized t-distribution
can be found in
gamlss.dist.
fBasics
provides d, p, q, r functions
for the skew and the generalized hyperbolic t-distribution.
The multivariate Student distribution
is provided by the packages
mvtnorm
and
mnormt.
-
Triangle/trapezoidal distribution
: packages
triangle,
mc2d
and
VGAM
provide d, p, q, r functions for the triangle distribution, while the package
trapezoid
provides d, p, q, r functions for the Generalized Trapezoidal Distribution.
A fast random generator is available for the triangle distribution
is implemented in
Runuran
as well as the density function.
-
Tweedie distribution
: the Tweedie distribution is implemented
in package
tweedie. Let us note that the Tweedie distribution
is not necessarily continuous, a special case of it is the Poisson distribution.
-
Uniform distribution
: d, p, q, r functions are of course provided
in R. See section RNG for random number generation topics.
ActuDistns
provides hazard and integrated hazard rate functions.
HI
generates
uniformly random points on a bounded convex set, in particular the unit ball.
mvtBinaryEP
provides a generator for bivariate data correlated by
the method of Emrich and Piedmonte.
-
Wakeby distribution
: A 5-parameter Wakeby is provided in
lmomco.
-
Weibull distribution and its extensions
: Base R provides
the d, p, q, r functions for this distribution (see above).
The inverse Weibull is provided by
actuar
package and also the moments
and the limited expected value for both the raw and the inverse Weibull distribution.
FAdist
implements the three-parameter Weibull distribution, while
reliaR
and
ActuDistns
implement the exponential Weibull, the flexible Weibull,
the generalized power weibull, the Marshall-Olkin Extended Weibull and
the Weibull extension distributions.
Finally,
lmomco
implements the Weibull distribution while
evd
implements the reverse Weibull distribution. d, p, q, r functions for
the reverse generalized extreme value distribution are provided in
gamlss.dist.
-
Xie distribution
: Provided in
ActuDistns.
Mixture of probability laws (and composite):
-
Cauchy-polynomial quantile mixture
: d, p, q, r functions are
provided by
Lmoments.
-
composite lognormal distribution
: d, p, q, r functions are
provided by
CompLognormal.
-
Gaussian mixture
: Functions d, r are provided by
mixtools
package when dealing with finite mixture models.
nor1mix
provides
d, p, r functions for Gaussian mixture.
-
Gamma mixture
: Gamma shape mixtures are implemented (d, p, r)
in the
GSM
package.
-
Generic mixtures
: there is an implementation via S4-class
UnivarMixingDistribution in package
distr.
gamlss.mx
uses the
gamlss.dist
package.
-
Normal-polynomial quantile mixture
: d, p, q, r functions are
provided by
Lmoments.
-
Poisson Binomial distribution
:
poibin
implements
the Poisson Binomial distribution.
-
Poisson lognormal distribution
:
poilog
implements
the Poisson lognormal distribution.
-
Poisson-Tweedie exponential family models
: provided in
poistweedie.
-
Student mixture
: The
AdMit
package provides d, r functions
for Student mixtures in the context of Adaptive Mixture of Student-t distributions.
-
von Mises Fisher mixture
: The
movMF
package provides d, r functions
for finite von Mises Fisher mixtures.
Moments, skewness, kurtosis and etc:
-
Empirical moments
: base R provides
mean(),
sd(),
var()
functions to compute
the mean, standard deviation and variance, respectively.
The skewness is available in
agricolae,
e1071,
GLDEX,
HyperbolicDist,
modeest,
moments,
npde,
TSA,
s20x
packages.
The kurtosis is available in
agricolae,
e1071,
GLDEX,
HyperbolicDist,
moments,
npde,
TSA
packages.
The raw or centered moments are provided in
e1071,
moments.
L-moments are available in
lmom,
lmomco,
Lmoments,
GLDEX,
trimmed L-moments are available in
lmomco, and
Lmoments,
right-censored L-moments are available in
lmomco,
and cumulants in
GLDEX.
Finally, the mode is provided in
modeest.
-
Theoretical moments
:
The
actuar
package implements raw moments, limited expected values
and moment generating function for base R distributions.
HyperbolicDist
provides the mean, variance, skewness, kurtosis, mode,
raw and centered moments for the hyperbolic, the generalized hyperbolic and the
generalized inverse Gaussian distributions.
lmomco
provides L-moments (L), trimmed L-moments (TL),
and right-censored [RC] for the following distributions:
Asymmetric Exponential Power (L), Cauchy (TL), Eta-Mu (L),
Exponential (L), Gamma (L), Generalized Extreme Value (L),
Generalized Lambda (L and TL), Generalized Logistic (L),
Generalized Normal (L), Generalized Pareto (L[RC] and TL),
Gumbel (L), Kappa (L), Kappa-Mu (L), Kumaraswamy (L),
Laplace (L), Normal (L), 3-parameter log-Normal (L),
Pearson Type III (L), Rayleigh (L), Reverse Gumbel (L[RC]),
Rice/Rician (L), Truncated Exponential (L), Wakeby (L), and Weibull (L).
Multivariate L-moments (L-comoments) are provided in
lmomco.
Random matrices:
-
Wishart and inverse Wishart distributions
:
Base R provides the r function for the Wishart distribution.
the d, r functions are provided in
MCMCpack
and
bayesm.
-
Marcenko-Pastur distribution
:
provided in
RMTstat,
MCMCpack
and
bayesm.
-
Tracy-Widom distribution
:
provided in
RMTstat,
MCMCpack
and
bayesm: supported beta values
are 1 (Gaussian Orthogonal Ensemble), 2 (Gaussian Unitary Ensemble),
and 4 (Gaussian Symplectic Ensemble).
-
Wishart distribution
:
provided in
RMTstat.
-
Spiked Wishart Maximum Eigenvalue Distributions
:
provided in
RMTstat,
MCMCpack
and
bayesm.
-
White Wishart Maximum Eigenvalue Distribution
:
provided in
RMTstat,
MCMCpack
and
bayesm.
Copulas:
-
Unified approaches
:
The packages
fCopulae,
copula, and
copBasic
provide a lot of
general functionality for copulas. Although lacking support for
many existing copulas themselves,
copBasic
is primarily oriented
around utility functions for the general mathematics of copulas
as described in the well known introduction to copulas by Nelson.
-
Archimedean copulas
: The Frank bivariate distribution
is available in
VGAM.
fCopulae
implements the 22 Archimedean
copulas of Nelsen (1998,
Introduction to Copulas
, Springer-Verlag) including
Gumbel, Frank, Clayton, and Ali-Mikhail-Haq.
gumbel
is a
standalone package for the Gumbel copula and
VGAM
provides the Ali-Mikhail-Haq bivariate distribution.
nacopula
provides
Ali-Mikhail-Haq, Clayton, Frank, Gumbel and Joe copulas.
CDVine
and
VineCopula
provide
Clayton, Gumbel, Frank, Joe, BB1, BB6, BB7 and BB8 copulas.
Generalized Archimedean copulas are implemented in the
fgac
package.
-
Blomqvist copula
: provided in
copBasic.
-
Composition of copula
:
copBasic
provides functions
for composition of a single symmetric copula and composition of two copulas.
-
Cubic copula
: Not yet implemented?
-
Dirichlet copula
: Not yet implemented?
-
Empirical copula
: provided in
copBasic.
-
Elliptical copulas
: Gaussian, Student and Cauchy copulas are implemented in
fCopulae
for the bivariate cases.
copula,
CDVine,
VineCopula
provide the Gaussian and the Student copula.
-
Extreme value copulas
:
fCopulae
provides the following copulas
Gumbel, Galambos, Husler-Reiss, Tawn, or BB5.
copula
also implements
Gumbel, Galambos and Husler-Reiss.
-
Eyraud-Farlie-Gumbel-Morgenstern copula
: Provided in
VGAM
and
copula.
-
Mardia copula
: Not yet implemented?
-
Nested copulas
: arbitrary nested versions of copulas can
be implemented in
nacopula.
-
Plackett
: Provided in
VGAM,
copBasic
and
copula.
-
Vine copulas
: Packages
CDVine,
VineCopula
provide functions for C- and D-vine copulas and for general
R-vine copulas, respectively.
Random Number Generators:
-
Basic functionality
: R provides several random number generators (RNGs).
The random seed can be provided via
set.seed
and the kind of RNG can be specified
using
RNGkind. The default RNG is the Mersenne-Twister algorithm.
Other generators include Wichmann-Hill, Marsaglia-Multicarry, Super-Duper,
Knuth-TAOCP, Knuth-TAOCP-2002, as well as user-supplied RNGs. For normal
random numbers, the following algorithms are available: Kinderman-Ramage,
Ahrens-Dieter, Box-Muller, Inversion (default). In addition to the tools above,
setRNG
provides an easy way to set, retain information about the setting, and reset the RNG.
-
Pseudo-randomness
:
RDieHarder
offers several dozen new RNGs
from the GNU GSL.
randtoolbox
provides
more recent RNGs such as SF Mersenne-Twister and WELL,
which are generators of Mersenne Twister type, but with
improved quality parameters.
rngwell19937
provides one of the WELL generators with 53 bit
resolution of the output and allows seeding by a vector
of integers of arbitrary length.
randaes
provides the deterministic part of the Fortuna cryptographic
pseudorandom number generator (AES).
SuppDists
implements two RNGs of G. Marsaglia.
-
Support for several independent streams:
rsprng
implements Scalable Parallel RNGs library.
rstream
focuses on multiple independent streams of random numbers
from different sources (in an object oriented approach).
-
For non-uniform generation, the
Runuran
package interfaces to the UNU.RAN library for universal non-uniform generation
as well as customised distributions based on polynomial interpolation of the inverse
cumulative distribution function.
-
Quasi-randomness
: The
randtoolbox
provides
the following quasi random sequences: the Sobol sequence, the Halton
(hence Van Der Corput) sequence and the Torus sequence (also known as Kronecker
sequence).
lhs
and
mc2d
packages implement the latin hypercube sampling,
an hybrid quasi/pseudo random method.
-
True randomness
: The
random
package provides several functions that access the
true random number service at
random.org
.
-
RNG tests
:
RDieHarder
offers
numerous tests of RNGs based on a
reimplementation and extension of Marsaglia's DieHarder battery.
randtoolbox
provides basic RNG tests.
-
Parallel computing
:
Random-number generators for parallel computing are available via
the
rsprng
package and the
rlecuyer
package.
See the
HighPerformanceComputing
task view for more details.
Miscellaneous:
-
Benchmark
: A set of 28 densities suitable for comparing
nonparametric density estimators in simulation studies can be found
in the
benchden
package. The densities vary greatly in degree of
smoothness, number of modes and other properties. The package
provides d,p,q and r functions.
-
Binned Empirical distributions: The
HistogramTools
package
provides a number of methods for manipulating empirical data that has
been binned into histogram form, including: (1) the empirical
cumulative distribution function, (2) the empirical quantile, and (3)
information loss metrics associated with binning.
-
Empirical distribution
: Base R provides functions for univariate analysis:
(1) the empirical density (see density), (2) the empirical cumulative
distribution function (see ecdf), (3) the empirical quantile (see quantile)
and (4) random sampling (see sample).
-
Hierarchical models
: Distributions whose some parameters
are no longer constant but random according to a particular distribution.
VGAM
provides a lot of hierarchical models: beta/binomial,
beta/geometric and beta/normal distributions.
bayesm
implements: binary logit, linear, multivariate logit and negative binomial
models. Furthermore
LearnBayes
and
MCMCpack
provides poisson/gamma, beta/binomial,
normal/normal and multinomial/Dirichlet models.
-
Object-orientation
:
General discrete and continuous distributions are implemented in package
distr
respectively via S4-class DiscreteDistribution and
AbscontDistribution providing the classic d, p, q and r functions.
distrEx
extends available distributions to multivariate and conditional distributions as well
as methods to compute useful statistics (expectation, variance,...) and distances
between distributions (Hellinger, Kolmogorov,... distance). Finally
package
distrMod
provides functions for the computation of minimum
criterion estimators (maximum likelihood and minimum distance estimators). See other
packages of the distr-family (distrSim,
distrTEst,
distrTeach,
distrDoc,
distrEllipse).
-
Transformation
: Lebesgue decomposition are implemented
in
distr, as well as Convolution, Truncation and Huberization of distributions.
Furthermore,
distr
provides distribution of the maximum or minimum
of two distributions. See Object-orientation above.
-
Non Parametric distributions
:
spd
provides the Semi Parametric Piecewise Distribution, while
fBasics
implements spline smoothed distributions.
-
User Interface
:
AtelieR
package provides a GTK GUI for teaching basic
concepts in statistical inference, implementing all the R base distributions
as well as the generalized Student, the inverse Chi-square, the inverse gamma
and the lambda-prime distributions.
-
Transversal functions
: Package
modeest
provides mode
estimation for various distributions, while
lmomco
and
Lmoments
focus on
univariate/multivariate (L-)moments estimation.
VGAM
provides a lot of parameter
estimation for usual and "exotic" distributions.
gaussDiff
provides a collection difference measures for
multivariate Gaussian probability density functions
Package
MASS
implements the flexible
fitdistr
function for parameter estimations.
fitdistrplus
greatly enlarges and enhances
the tools to fit probability distributions.
flexsurv
and
msm
provides a quantile
function for a generic distribution based on numerical
computation based on a dichotomic search.