Multivariate normal distribution

From Wikipedia, the free encyclopedia

Jump to: navigation, search
MVN redirects here. For the airport with that IATA code in Mount Vernon, Illinois, see Mount Vernon Airport.
Multivariate normal
Probability density function
Cumulative distribution function
Parameters \mu = [\mu_1, \dots, \mu_N]^T location (real vector)
Σ covariance matrix (positive-definite real N\times N matrix)
Support x \in\mathbb{R}^N\!
Probability density function (pdf) f_X(x_1, \dots, x_N)=\frac {1} {(2\pi)^{N/2} \left|\Sigma\right|^{1/2}}

                 \exp\left( -\frac{1}{2}( x - \mu)^\top \Sigma^{-1} (x - \mu)\right)
Cumulative distribution function (cdf) No analytic expression
Mean μ
Median μ
Mode μ
Variance Σ (covariance matrix)
Skewness 0
Excess kurtosis 0
Entropy \ln\left(\sqrt{(2\,\pi\,e)^N \left| \Sigma \right|}\right)\!
Moment-generating function (mgf) M_X(t)= \exp\left( \mu^\top t + \frac{1}{2} t^\top \Sigma t\right)
Characteristic function \phi_X(t;\mu,\Sigma)=\exp\left( i \mu^\top t - \frac{1}{2} t^\top \Sigma t\right)

In probability theory and statistics, a multivariate normal distribution, sometimes also called a multivariate Gaussian distribution, is a generalization of the one-dimensional normal distribution (also called a Gaussian distribution) to higher dimensions. It is also closely related to matrix normal distribution.

Contents

[edit] General case

A random vector \ X = [X_1, \dots, X_N]^T follows a multivariate normal distribution if it satisfies the following equivalent conditions:

  • there is a random vector \ Z = [Z_1, \dots, Z_M]^T, whose components are independent standard normal random variables, a vector \ \mu = [\mu_1, \dots, \mu_N]^T and an N \times M matrix \ A such that \ X = A Z + \mu.
  • there is a vector μ and a symmetric, positive semi-definite matrix \ \Sigma such that the characteristic function of X is

\phi_X\left(u;\mu,\Sigma\right)
=
\exp
\left(
 i \mu^\top u - \frac{1}{2} u^\top \Sigma u
\right).

If \ \Sigma is non-singular, then the distribution may be described by the following PDF:


f_X(x_1, \dots, x_N)
=
\frac
 {1}
 {(2\pi)^{N/2}|\Sigma|^{1/2}}
\exp
\left(
 -\frac{1}{2}
 ( x - \mu)^\top \Sigma^{-1} (x - \mu)
\right)

where \ \left| \Sigma \right| is the determinant of \ \Sigma. Note how the equation above reduces to that of the univariate normal distribution if \ \Sigma is a scalar (i.e., a 1x1 matrix).

The vector μ in these conditions is the expected value of X and the matrix \ \Sigma = A A^T is the covariance matrix of the components Xi.

It is important to realize that the covariance matrix must be allowed to be singular (thus not described by above formula for which \ \Sigma^{-1} is defined). That case arises frequently in statistics; for example, in the distribution of the vector of residuals in ordinary linear regression problems. Note also that the Xi are in general not independent; they can be seen as the result of applying the linear transformation A to a collection of independent Gaussian variables Z.

That the distribution of a random vector X is a multivariate normal distribution can be written in the following notation:

X\ \sim \mathcal{N}(\mu, \Sigma),

or to make it explicitly known that X is N-dimensional,

X\ \sim \mathcal{N}_N(\mu, \Sigma).

[edit] Cumulative distribution function

The cumulative distribution function (cdf) F(x) is defined as the probability that all values in a random vector X are less than or equal to the corresponding values in vector x. Though there is no closed form for F(x), there are a number of algorithms that estimate it numerically. For example, see MVNDST under [1] (includes FORTRAN code) or [2] (includes MATLAB code).

[edit] A counterexample

The fact that two random variables X and Y both have a normal distribution does not imply that the pair (XY) has a joint normal distribution. A simple example is one in which Y = X if |X| > 1 and Y = −X if |X| < 1. This is also true for more than two random variables.

Also see normally distributed and uncorrelated does not imply independent.

[edit] Normally distributed and independent

If X and Y are normally distributed and independent, this implies they are "jointly normally distributed", i.e., the pair (XY) must have bivariate normal distribution. However, a pair of jointly normally distributed variables need not be independent.

[edit] Bivariate case

In the 2-dimensional nonsingular case, the probability density function (with mean (0,0)) is


f(x,y)
=
\frac{1}{2 \pi \sigma_x \sigma_y \sqrt{1-\rho^2}}
\exp
\left(
 -\frac{1}{2 (1-\rho^2)}
 \left(
  \frac{x^2}{\sigma_x^2} +
  \frac{y^2}{\sigma_y^2} -
  \frac{2 \rho x y}{ (\sigma_x \sigma_y)}
 \right)
\right)

where ρ is the correlation between X and Y. In this case,


\Sigma =
\begin{bmatrix}
\sigma_x^2              & \rho \sigma_x \sigma_y \\
\rho \sigma_x \sigma_y  & \sigma_y^2
\end{bmatrix}.

[edit] Affine transformation

If Y = c + B X \, is an affine transformation of X\ \sim \mathcal{N}(\mu, \Sigma), where c\, is an M \times 1 vector of constants and B\, an M \times N matrix, then Y\, has a multivariate normal distribution with expected value c + B \mu \, and variance B \Sigma B^T \, i.e., Y \sim \mathcal{N} \left(c + B \mu, B \Sigma B^T\right). In particular, any subset of the X_i\, has a marginal distribution that is also multivariate normal. To see this, consider the following example: to extract the subset (X_1, X_2, X_4)^T \,, use


B
=
\begin{bmatrix}
 1 & 0 & 0 & 0 & 0 & \ldots & 0 \\
 0 & 1 & 0 & 0 & 0 & \ldots & 0 \\
 0 & 0 & 0 & 1 & 0 & \ldots & 0
\end{bmatrix}

which extracts the desired elements directly.

Another corollary would be that the distribution of Z=b\cdot X, where b is a vector the same length as X and the dot indicates a vector product, would be univariate Gaussian with Z\sim\mathcal{N}\left(b\cdot\mu, b^T\Sigma b\right). This result follows by using


B=\begin{bmatrix}
b_1 & b_2 & \ldots & b_n\\
0   & 0   & \ldots & 0  \\
    &     & \vdots &    \\
0   & 0   & \ldots & 0  \\
\end{bmatrix}

and considering only the first component of the product (the first row of B is the vector b). Observe how the positive-definiteness of Σ implies that the variance of the dot product must be positive.

[edit] Geometric interpretation

The equidensity contours of a non-singular multivariate normal distribution are ellipsoids (i.e. linear transformations of hyperspheres) centered at the mean[1]. The directions of the principal axes of the ellipsoids are given by the eigenvectors of the covariance matrix Σ. The squared relative lengths of the principal axes are given by the corresponding eigenvalues.

If Σ = UΛUT = UΛ1 / 2(UΛ1 / 2)T is an eigendecomposition where the columns of U are unit eigenvectors and Λ is a diagonal matrix of the eigenvalues, then we have

X\ \sim N(\mu, \Sigma) \iff X\ \sim \mu+U\Lambda^{1/2}N(0, I) \iff X\ \sim \mu+UN(0, \Lambda).

Moreover, U can be chosen to be a rotation matrix, as inverting an axis does not have any effect on N(0,Λ), but inverting a column changes the sign of U's determinant. The distribution N(μ,Σ) is in effect N(0,I) scaled by Λ1 / 2, rotated by U and translated by μ.

Conversely, any choice of μ, full rank matrix U, and positive diagonal entries Λi yields a non-singular multivariate normal distribution. If any Λi is zero and U is square, the resulting covariance matrix UΛUT is singular. Geometrically this means that every contour ellipsoid is infinitely thin and has zero volume in n-dimensional space, as at least one of the principal axes has length of zero.

[edit] Correlations and independence

In general, random variables may be uncorrelated but highly dependent. But if a random vector has a multivariate normal distribution then any two or more of its components that are uncorrelated are independent. This implies that any two or more of its components that are pairwise independent are independent.

But it is not true that two random variables that are (separately, marginally) normally distributed and uncorrelated are independent. Two random variables that are normally distributed may fail to be jointly normally distributed, i.e., the vector whose components they are may fail to have a multivariate normal distribution. For an example of two normally distributed random variables that are uncorrelated but not independent, see normally distributed and uncorrelated does not imply independent.

[edit] Higher moments

The kth-order moments of X are defined by


\mu _{1,\dots,N}(X)\ \stackrel{\mathrm{def}}{=}\  \mu _{r_{1},\dots,r_{N}}(X)\ \stackrel{\mathrm{def}}{=}\  E\left[
\prod\limits_{j=1}^{N}X_j^{r_{j}}\right]

where r_1 +r_2 + \cdots + r_N =k.

The central k-order central moments are given as follows

(a) If k is odd, \mu _{1,\dots,N}(X-\mu )=0.

(b) If k is even with k = 2λ, then


\mu _{1,\dots,2\lambda }(X-\mu )=\sum \left( \sigma _{ij}\sigma _{k\ell}\cdots\sigma _{XZ}\right)

where the sum is taken over all allocations of the set \left\{ 1,\dots,2\lambda
\right\} into λ (unordered) pairs. That is, if you have a kth( = 2λ = 6) central moment, you will be summing the products of λ = 3 covariances (the -μ notation has been dropped in the interests of parsimony):


\begin{align}
& {} E[X_1 X_2 X_3 X_4 X_5 X_6] \\
&{} = E[X_1 X_2 ]E[X_3 X_4 ]E[X_5 X_6 ] + E[X_1 X_2 ]E[X_3 X_5 ]E[X_4 X_6] + E[X_1 X_2 ]E[X_3 X_4 ]E[X_4 X_5] \\
&{} + E[X_1 X_2 ]E[X_2 X_4 ]E[X_5 X_6 ] + E[X_1 X_3 ]E[X_2 X_5 ]E[X_4 X_6 ] + E[X_1 X_3]E[X_2 X_6]E[X_4 X_5] \\
&+ E[X_1 X_4]E[X_2 X_3]E[X_5 X_6]+E[X_1 X_4]E[X_2 X_5]E[X_3 X_6]+E[X_1 X_4]E[X_2 X_6]E[X_3 X_5] \\
& + E[X_1 X_5]E[X_2 X_3]E[X_4 X_6]+E[X_1 X_5]E[X_2 X_4]E[X_3 X_6]+E[X_1 X_5]E[X_2 X_6]E[X_3 X_4] \\
& + E[X_1 X_6]E[X_2 X_3]E[X_4 X_5 ] + E[X_1 X_6]E[X_2 X_4 ]E[X_3 X_5] + E[X_1 X_6]E[X_2 X_5]E[X_3 X_4].
\end{align}


This yields (2λ − 1)! / (2λ − 1(λ − 1)!) terms in the sum (15 in the above case), each being the product of λ (in this case 3) covariances. For fourth order moments (four variables) there are three terms. For sixth-order moments there are 3 × 5 = 15 terms, and for eighth-order moments there are 3 × 5 × 7 = 105 terms.

The covariances are then determined by replacing the terms of the list \left[ 1,\dots,2\lambda \right] by the corresponding terms of the list consisting of r1 ones, then r2 twos, etc... To illustrate this, examine the following 4th-order central moment case:


E\left[ X_i^4\right] = 3\sigma _{ii}^2
E\left[ X_i^3 X_j\right] = 3\sigma _{ii} \sigma _{ij}
E\left[ X_i^2 X_j^2\right] = \sigma _{ii}\sigma_{jj}+2\left( \sigma _{ij}\right) ^2
E\left[ X_i^2X_jX_k\right] = \sigma _{ii}\sigma _{jk}+2\sigma _{ij}\sigma _{ik}
E\left[ X_i X_j X_k X_n\right] = \sigma _{ij}\sigma _{kn}+\sigma _{ik}\sigma _{jn}+\sigma _{in}\sigma _{jk}.


where σij is the covariance of Xi and Xj. The idea with the above method is you first find the general case for a kth moment where you have k different X variables - E\left[ X_i X_j X_k X_n\right] and then you can simplify this accordingly. Say, you have E\left[ X_i^2 X_k X_n\right] then you simply let Xi = Xj and realise that \sigma_{ii}=\sigma_i^2.

[edit] Conditional distributions

If μ and Σ are partitioned as follows


\mu
=
\begin{bmatrix}
 \mu_1 \\
 \mu_2
\end{bmatrix}
\quad with sizes \begin{bmatrix} q \times 1 \\ (N-q) \times 1 \end{bmatrix}

\Sigma
=
\begin{bmatrix}
 \Sigma_{11} & \Sigma_{12} \\
 \Sigma_{21} & \Sigma_{22}
\end{bmatrix}
\quad with sizes \begin{bmatrix} q \times q & q \times (N-q) \\ (N-q) \times q & (N-q) \times (N-q) \end{bmatrix}

then the distribution of x1 conditional on x2 = a is multivariate normal (X_1|X_2=a) \sim N(\bar{\mu}, \overline{\Sigma}) where


\bar{\mu}
=
\mu_1 + \Sigma_{12} \Sigma_{22}^{-1}
\left(
 a - \mu_2
\right)

and covariance matrix


\overline{\Sigma}
=
\Sigma_{11} - \Sigma_{12} \Sigma_{22}^{-1} \Sigma_{21}.

This matrix is the Schur complement of {\mathbf\Sigma_{22}} in {\mathbf\Sigma}.

Note that knowing that x2 = a alters the variance; perhaps more surprisingly, the mean is shifted by \Sigma_{12} \Sigma_{22}^{-1} \left(a - \mu_2 \right); compare this with the situation of not knowing the value of a, in which case x1 would have distribution N_q \left(\mu_1, \Sigma_{11} \right).

The matrix \Sigma_{12} \Sigma_{22}^{-1} is known as the matrix of regression coefficients.

[edit] Bivariate conditional expectation

In the case


\begin{pmatrix}
 X_1 \\
 X_2
\end{pmatrix}  \sim \mathcal{N} \left( \begin{pmatrix}
 0 \\
 0
\end{pmatrix} , \begin{pmatrix}
 1 & \rho \\
 \rho & 1 
\end{pmatrix} \right)

Then


E(X_1 | X_2 > z) = { \phi(z) \over \Phi(-z) }

where this latter ratio is often called the Inverse Mills ratio.

[edit] Fisher information matrix

The Fisher information matrix (FIM) for a normal distribution takes a special formulation. The (m,n) element of the FIM for X \sim N(\mu(\theta), \Sigma(\theta)) is


\mathcal{I}_{m,n}
=
\frac{\partial \mu}{\partial \theta_m}
\Sigma^{-1}
\frac{\partial \mu^\top}{\partial \theta_n}
+
\frac{1}{2}
\mathrm{tr}
\left(
 \Sigma^{-1}
 \frac{\partial \Sigma}{\partial \theta_m}
 \Sigma^{-1}
 \frac{\partial \Sigma}{\partial \theta_n}
\right)

where

  • 
\frac{\partial \mu}{\partial \theta_m}
=
\begin{bmatrix}
 \frac{\partial \mu_1}{\partial \theta_m} &
 \frac{\partial \mu_2}{\partial \theta_m} &
 \cdots &
 \frac{\partial \mu_N}{\partial \theta_m} &
\end{bmatrix}
  • 
\frac{\partial \mu^\top}{\partial \theta_m}
=
\left(
 \frac{\partial \mu}{\partial \theta_m}
\right)^\top
=
\begin{bmatrix}
 \frac{\partial \mu_1}{\partial \theta_m} \\  \\
 \frac{\partial \mu_2}{\partial \theta_m} \\  \\
 \vdots \\  \\
 \frac{\partial \mu_N}{\partial \theta_m} \\  \\
\end{bmatrix}
  • 
\frac{\partial \Sigma}{\partial \theta_m}
=
\begin{bmatrix}
 \frac{\partial \Sigma_{1,1}}{\partial \theta_m} &
 \frac{\partial \Sigma_{1,2}}{\partial \theta_m} &
 \cdots &
 \frac{\partial \Sigma_{1,N}}{\partial \theta_m} \\  \\
 \frac{\partial \Sigma_{2,1}}{\partial \theta_m} &
 \frac{\partial \Sigma_{2,2}}{\partial \theta_m} &
 \cdots &
 \frac{\partial \Sigma_{2,N}}{\partial \theta_m} \\  \\
 \vdots & \vdots & \ddots & \vdots \\  \\
 \frac{\partial \Sigma_{N,1}}{\partial \theta_m} &
 \frac{\partial \Sigma_{N,2}}{\partial \theta_m} &
 \cdots &
 \frac{\partial \Sigma_{N,N}}{\partial \theta_m}
\end{bmatrix}
  • tr is the trace function

[edit] Kullback-Leibler divergence

The Kullback-Leibler divergence from N0N00) to N1N11) is:


D_\text{KL}(N0 \| N1) = { 1 \over 2 } \left( \log_e \left( { \det \Sigma_1 \over \det \Sigma_0 } \right) + \mathrm{tr} \left( \Sigma_1^{-1} \Sigma_0 \right) + \left( \mu_1 - \mu_0\right)^\top \Sigma_1^{-1} ( \mu_1 - \mu_0 ) - N \right).

The logarithm must be taken to base e since the two terms following the logarithm are themselves base-e logarithms of expressions that are either factors of the density function or otherwise arise naturally. The divergence above is measured in nats. Dividing the entire expression above by loge 2 yields the divergence in bits.

[edit] Estimation of parameters

The derivation of the maximum-likelihood estimator of the covariance matrix of a multivariate normal distribution is perhaps surprisingly subtle and elegant. See estimation of covariance matrices.

In short, the probability density function (pdf) of an N-dimensional multivariate normal is

f(x)=(2 \pi)^{-N/2} \det(\Sigma)^{-1/2} \exp\left(-{1 \over 2} (x-\mu)^T \Sigma^{-1} (x-\mu)\right)

and the ML estimator of the covariance matrix from a sample of n observations is

\widehat\Sigma = {1 \over n}\sum_{i=1}^n (X_i-\overline{X})(X_i-\overline{X})^T

which is simply the sample covariance matrix. This is a biased estimator whose expectation is

E[\widehat\Sigma] = {n-1 \over n}\Sigma.

An unbiased sample covariance is

\widehat\Sigma = {1 \over n-1}\sum_{i=1}^n (X_i-\overline{X})(X_i-\overline{X})^T.

[edit] Entropy

The differential entropy of the multivariate normal distribution is [2]


\begin{align}
h\left(f\right) & = -\int_{-\infty}^\infty \int_{-\infty}^\infty \cdots\int_{-\infty}^\infty f(x) \ln f(x)\,dx \\
& = \frac12 \left(N+N\ln\left(2\pi\right) + \ln\left| \Sigma \right|\right) \\
& =\frac{1}{2}\ln\{(2\pi e)^N \left| \Sigma \right|\}
\end{align}

where \left| \Sigma \right| is the determinant of the covariance matrix Σ.

[edit] Multivariate normality tests

Multivariate normality tests check a given set of data for similarity to the multivariate normal distribution. The null hypothesis is that the data set is similar to the normal distribution, therefore a sufficiently small p-value indicates non-normal data. Multivariate normality tests include the Cox-Small test [3] and Smith and Jain's adaptation [4] of the Friedman-Rafsky test.

[edit] Drawing values from the distribution

A widely used method for drawing a random vector X from the N-dimensional multivariate normal distribution with mean vector μ and covariance matrix Σ (required to be symmetric and positive-definite) works as follows:

  1. Compute the Cholesky decomposition of Σ, that is, find the unique lower triangular matrix A such that A\,A^T = \Sigma. Any other matrix A for which this equation holds is also feasible.
  2. Let Z=(z_1,\dots,z_N)^T be a vector whose components are N independent standard normal variates (which can be generated, for example, by using the Box-Muller transform).
  3. Let X be μ + AZ.

[edit] References

  1. ^ Nikolaus Hansen. "The CMA Evolution Strategy: A Tutorial" (PDF).
  2. ^ Gokhale, DV; NA Ahmed, BC Res, NJ Piscataway (May 1989). "Entropy Expressions and Their Estimators for Multivariate Distributions". Information Theory, IEEE Transactions on 35 (3): 688–692. doi:10.1109/18.30996. 
  3. ^ Cox, D. R.; N. J. H. Small (August 1978). "Testing multivariate normality". Biometrika 65 (2): 263–272. doi:10.1093/biomet/65.2.263. 
  4. ^ Smith, Stephen P.; Anil K. Jain (September 1988). "A test to determine the multivariate normality of a dataset". IEEE Transactions on Pattern Analysis and Machine Intelligence 10 (5): 757–761. doi:10.1109/34.6789. 
Personal tools