Cholesky decomposition explained

In linear algebra, the Cholesky decomposition or Cholesky factorization (pronounced) is a decomposition of a Hermitian, positive-definite matrix into the product of a lower triangular matrix and its conjugate transpose, which is useful for efficient numerical solutions, e.g., Monte Carlo simulations. It was discovered by André-Louis Cholesky for real matrices, and posthumously published in 1924.[1] When it is applicable, the Cholesky decomposition is roughly twice as efficient as the LU decomposition for solving systems of linear equations.[2]

Statement

The Cholesky decomposition of a Hermitian positive-definite matrix, is a decomposition of the form

\mathbf = \mathbf^,

where is a lower triangular matrix with real and positive diagonal entries, and * denotes the conjugate transpose of . Every Hermitian positive-definite matrix (and thus also every real-valued symmetric positive-definite matrix) has a unique Cholesky decomposition.[3]

The converse holds trivially: if can be written as for some invertible, lower triangular or otherwise, then is Hermitian and positive definite.

When is a real matrix (hence symmetric positive-definite), the factorization may be written\mathbf = \mathbf^\mathsf,where is a real lower triangular matrix with positive diagonal entries.[4] [5] [6]

Positive semidefinite matrices

If a Hermitian matrix is only positive semidefinite, instead of positive definite, then it still has a decomposition of the form where the diagonal entries of are allowed to be zero.[7] The decomposition need not be unique, for example:\begin0 & 0 \\0 & 1\end = \mathbf L \mathbf L^*, \quad \quad \mathbf L=\begin0 & 0\\ \cos \theta & \sin\theta\end,for any . However, if the rank of is, then there is a unique lower triangular with exactly positive diagonal elements and columns containing all zeroes.[8]

Alternatively, the decomposition can be made unique when a pivoting choice is fixed. Formally, if is an positive semidefinite matrix of rank, then there is at least one permutation matrix such that has a unique decomposition of the form with \mathbf L = \begin \mathbf L_1 & 0 \\ \mathbf L_2 & 0\end ,where is an lower triangular matrix with positive diagonal.[9]

LDL decomposition

A closely related variant of the classical Cholesky decomposition is the LDL decomposition,

\mathbf = \mathbf^*,

where is a lower unit triangular (unitriangular) matrix, and is a diagonal matrix. That is, the diagonal elements of are required to be 1 at the cost of introducing an additional diagonal matrix in the decomposition. The main advantage is that the LDL decomposition can be computed and used with essentially the same algorithms, but avoids extracting square roots.[10]

For this reason, the LDL decomposition is often called the square-root-free Cholesky decomposition. For real matrices, the factorization has the form and is often referred to as decomposition (or decomposition, or LDL′). It is reminiscent of the eigendecomposition of real symmetric matrices,, but is quite different in practice because and are not similar matrices.

The LDL decomposition is related to the classical Cholesky decomposition of the form as follows:

\mathbf = \mathbf^* = \mathbf L \mathbf D^ \left(\mathbf D^ \right)^* \mathbf L^* =\mathbf L \mathbf D^ \left(\mathbf L \mathbf D^\right)^*.

Conversely, given the classical Cholesky decomposition \mathbf A = \mathbf C \mathbf C^* of a positive definite matrix, if is a diagonal matrix that contains the main diagonal of \mathbf C, then can be decomposed as \mathbf L \mathbf D \mathbf L^* where \mathbf L = \mathbf C \mathbf S^ (this rescales each column to make diagonal elements 1), \mathbf D = \mathbf S^2.

If is positive definite then the diagonal elements of are all positive.For positive semidefinite, an \mathbf L \mathbf D \mathbf L^* decomposition exists where the number of non-zero elements on the diagonal is exactly the rank of .[11] Some indefinite matrices for which no Cholesky decomposition exists have an LDL decomposition with negative entries in : it suffices that the first leading principal minors of are non-singular.

Example

Here is the Cholesky decomposition of a symmetric real matrix:

\begin \begin 4 & 12 & -16 \\ 12 & 37 & -43 \\ -16 & -43 & 98 \\ \end= \begin 2 & 0 & 0 \\ 6 & 1 & 0 \\ -8 & 5 & 3 \\ \end \begin 2 & 6 & -8 \\ 0 & 1 & 5 \\ 0 & 0 & 3 \\ \end.\end

And here is its LDLT decomposition:

\begin \begin 4 & 12 & -16 \\ 12 & 37 & -43 \\ -16 & -43 & 98 \\ \end& = \begin 1 & 0 & 0 \\ 3 & 1 & 0 \\ -4 & 5 & 1 \\ \end \begin 4 & 0 & 0 \\ 0 & 1 & 0 \\ 0 & 0 & 9 \\ \end \begin 1 & 3 & -4 \\ 0 & 1 & 5 \\ 0 & 0 & 1 \\ \end.\end

Geometric interpretation

See also: Whitening transformation. The Cholesky decomposition is equivalent to a particular choice of conjugate axes of an ellipsoid.[12] In detail, let the ellipsoid be defined as y^TAy = 1, then by definition, a set of vectors v_1, ..., v_n are conjugate axes of the ellipsoid iff v_i^T A v_j = \delta_. Then, the ellipsoid is precisely\left\ = f(\mathbb S^n)where f maps the basis vector e_i \mapsto v_i, and \mathbb S^n is the unit sphere in n dimensions. That is, the ellipsoid is a linear image of the unit sphere.

Define the matrix V := [v_1 | v_2 | \cdots | v_n], then v_i^T A v_j = \delta_ is equivalent to V^TAV = I. Different choices of the conjugate axes correspond to different decompositions.

The Cholesky decomposition corresponds to choosing v_1 to be parallel to the first axis, v_2 to be within the plane spanned by the first two axes, and so on. This makes V an upper-triangular matrix. Then, there is A = LL^T, where L = (V^)^T is lower-triangular.

Similarly, principal component analysis corresponds to choosing v_1, ..., v_n to be perpendicular. Then, let \lambda = 1/\|v_i\|^2 and \Sigma = \mathrm(\lambda_1, ..., \lambda_n), and there is V = U\Sigma^ where U is an orthogonal matrix. This then yields A = U\Sigma U^T.

Applications

Numerical solution of system of linear equations

The Cholesky decomposition is mainly used for the numerical solution of linear equations \mathbf = \mathbf. If is symmetric and positive definite, then \mathbf = \mathbf can be solved by first computing the Cholesky decomposition \mathbf = \mathbf^\mathrm, then solving \mathbf = \mathbf for by forward substitution, and finally solving \mathbf = \mathbf for by back substitution.

An alternative way to eliminate taking square roots in the \mathbf^\mathrm decomposition is to compute the LDL decomposition \mathbf = \mathbf^\mathrm, then solving \mathbf = \mathbf for, and finally solving \mathbf^\mathrm\mathbf = \mathbf.

For linear systems that can be put into symmetric form, the Cholesky decomposition (or its LDL variant) is the method of choice, for superior efficiency and numerical stability. Compared to the LU decomposition, it is roughly twice as efficient.[2]

Linear least squares

Systems of the form with symmetric and positive definite arise quite often in applications. For instance, the normal equations in linear least squares problems are of this form. It may also happen that matrix comes from an energy functional, which must be positive from physical considerations; this happens frequently in the numerical solution of partial differential equations.

Non-linear optimization

Non-linear multi-variate functions may be minimized over their parameters using variants of Newton's method called quasi-Newton methods. At iteration k, the search steps in a direction p_k defined by solving B_k p_k = -g_k for p_k , where p_k is the step direction, g_k is the gradient, and B_k is an approximation to the Hessian matrix formed by repeating rank-1 updates at each iteration. Two well-known update formulas are called Davidon–Fletcher–Powell (DFP) and Broyden–Fletcher–Goldfarb–Shanno (BFGS). Loss of the positive-definite condition through round-off error is avoided if rather than updating an approximation to the inverse of the Hessian, one updates the Cholesky decomposition of an approximation of the Hessian matrix itself.[13]

Monte Carlo simulation

The Cholesky decomposition is commonly used in the Monte Carlo method for simulating systems with multiple correlated variables. The covariance matrix is decomposed to give the lower-triangular . Applying this to a vector of uncorrelated observations in a sample produces a sample vector Lu with the covariance properties of the system being modeled.[14]

The following simplified example shows the economy one gets from the Cholesky decomposition: suppose the goal is to generate two correlated normal variables x_1 and x_2 with given correlation coefficient \rho. To accomplish that, it is necessary to first generate two uncorrelated Gaussian random variables z_1 and z_2 (for example, via a Box–Muller transform). Given the required correlation coefficient \rho, the correlated normal variables can be obtained via the transformations x_1 = z_1 and x_2 = \rho z_1 + \sqrt z_2.

Kalman filters

Unscented Kalman filters commonly use the Cholesky decomposition to choose a set of so-called sigma points. The Kalman filter tracks the average state of a system as a vector of length and covariance as an matrix . The matrix is always positive semi-definite and can be decomposed into LLT. The columns of can be added and subtracted from the mean to form a set of vectors called sigma points. These sigma points completely capture the mean and covariance of the system state.

Matrix inversion

The explicit inverse of a Hermitian matrix can be computed by Cholesky decomposition, in a manner similar to solving linear systems, using n^3 operations (\tfrac n^3 multiplications).[10] The entire inversion can even be efficiently performed in-place.

A non-Hermitian matrix can also be inverted using the following identity, where BB* will always be Hermitian:

\mathbf^ = \mathbf^* (\mathbf^*)^.

Computation

There are various methods for calculating the Cholesky decomposition. The computational complexity of commonly used algorithms is in general. The algorithms described below all involve about FLOPs (multiplications and the same number of additions) for real flavors and FLOPs for complex flavors,[15] where is the size of the matrix . Hence, they have half the cost of the LU decomposition, which uses FLOPs (see Trefethen and Bau 1997).

Which of the algorithms below is faster depends on the details of the implementation. Generally, the first algorithm will be slightly slower because it accesses the data in a less regular manner.

The Cholesky algorithm

The Cholesky algorithm, used to calculate the decomposition matrix, is a modified version of Gaussian elimination.

The recursive algorithm starts with and

.

At step, the matrix has the following form:\mathbf^=\begin\mathbf_ & 0 & 0 \\0 & a_ & \mathbf_^ \\0 & \mathbf_ & \mathbf^\end,where denotes the identity matrix of dimension .

If the matrix is defined by\mathbf_:=\begin\mathbf_ & 0 & 0 \\0 & \sqrt & 0 \\0 & \frac \mathbf_ & \mathbf_\end,(note that since is positive definite),then can be written as\mathbf^ = \mathbf_ \mathbf^ \mathbf_^where\mathbf^=\begin\mathbf_ & 0 & 0 \\0 & 1 & 0 \\0 & 0 & \mathbf^ - \frac \mathbf_ \mathbf_^\end.Note that is an outer product, therefore this algorithm is called the outer-product version in (Golub & Van Loan).

This is repeated for from 1 to . After steps, is obtained, and hence, the lower triangular matrix sought for is calculated as

\mathbf := \mathbf_ \mathbf_ \dots \mathbf_.

The Cholesky–Banachiewicz and Cholesky–Crout algorithms

If the equation\begin\mathbf = \mathbf^T & =\begin L_ & 0 & 0 \\ L_ & L_ & 0 \\ L_ & L_ & L_\\\end\begin L_ & L_ & L_ \\ 0 & L_ & L_ \\ 0 & 0 & L_\end \\[8pt]& =\begin L_^2 & &(\text) \\ L_L_ & L_^2 + L_^2& \\ L_L_ & L_L_+L_L_ & L_^2 + L_^2+L_^2\end,\end

is written out, the following is obtained:

\begin\mathbf = \begin \sqrt & 0 & 0 \\A_/L_ & \sqrt & 0 \\A_/L_ & \left(A_ - L_L_ \right) /L_ &\sqrt\end\end

and therefore the following formulas for the entries of :

L_ = (\pm)\sqrt, L_ = \frac \left(A_ - \sum_^ L_ L_ \right) \quad \text i>j.

For complex and real matrices, inconsequential arbitrary sign changes of diagonal and associated off-diagonal elements are allowed. The expression under the square root is always positive if is real and positive-definite.

For complex Hermitian matrix, the following formula applies:

L_ = \sqrt, L_ = \frac \left(A_ - \sum_^ L_^* L_ \right) \quad \text i>j.

So it now is possible to compute the entry if the entries to the left and above are known. The computation is usually arranged in either of the following orders:

for (i = 0; i < dimensionSize; i++) The above algorithm can be succinctly expressed as combining a dot product and matrix multiplication in vectorized programming languages such as Fortran as the following,do i = 1, size(A,1) L(i,i) = sqrt(A(i,i) - dot_product(L(i,1:i-1), L(i,1:i-1))) L(i+1:,i) = (A(i+1:,i) - matmul(conjg(L(i,1:i-1)), L(i+1:,1:i-1))) / L(i,i)end dowhere conjg refers to complex conjugate of the elements.

for (j = 0; j < dimensionSize; j++) The above algorithm can be succinctly expressed as combining a dot product and matrix multiplication in vectorized programming languages such as Fortran as the following,do i = 1, size(A,1) L(i,i) = sqrt(A(i,i) - dot_product(L(1:i-1,i), L(1:i-1,i))) L(i,i+1:) = (A(i,i+1:) - matmul(conjg(L(1:i-1,i)), L(1:i-1,i+1:))) / L(i,i)end dowhere conjg refers to complex conjugate of the elements.

Either pattern of access allows the entire computation to be performed in-place if desired.

Stability of the computation

Suppose that there is a desire to solve a well-conditioned system of linear equations. If the LU decomposition is used, then the algorithm is unstable unless some sort of pivoting strategy is used. In the latter case, the error depends on the so-called growth factor of the matrix, which is usually (but not always) small.

Now, suppose that the Cholesky decomposition is applicable. As mentioned above, the algorithm will be twice as fast. Furthermore, no pivoting is necessary, and the error will always be small. Specifically, if, and denotes the computed solution, then solves the perturbed system (where \|\mathbf\|_2 \le c_n \varepsilon \|\mathbf\|_2. Here ||·||2 is the matrix 2-norm, cn is a small constant depending on, and denotes the unit round-off.

One concern with the Cholesky decomposition to be aware of is the use of square roots. If the matrix being factorized is positive definite as required, the numbers under the square roots are always positive in exact arithmetic. Unfortunately, the numbers can become negative because of round-off errors, in which case the algorithm cannot continue. However, this can only happen if the matrix is very ill-conditioned. One way to address this is to add a diagonal correction matrix to the matrix being decomposed in an attempt to promote the positive-definiteness.[16] While this might lessen the accuracy of the decomposition, it can be very favorable for other reasons; for example, when performing Newton's method in optimization, adding a diagonal matrix can improve stability when far from the optimum.

LDL decomposition

An alternative form, eliminating the need to take square roots when is symmetric, is the symmetric indefinite factorization[17] \begin\mathbf = \mathbf^\mathrm & =\begin 1 & 0 & 0 \\ L_ & 1 & 0 \\ L_ & L_ & 1\\\end\begin D_1 & 0 & 0 \\ 0 & D_2 & 0 \\ 0 & 0 & D_3\\\end\begin 1 & L_ & L_ \\ 0 & 1 & L_ \\ 0 & 0 & 1\\\end \\[8pt]& = \begin D_1 & &(\mathrm) \\ L_D_1 & L_^2D_1 + D_2& \\ L_D_1 & L_L_D_+L_D_2 & L_^2D_1 + L_^2D_2+D_3.\end.\end

The following recursive relations apply for the entries of and : D_j = A_ - \sum_^ L_^2 D_k, L_ = \frac \left(A_ - \sum_^ L_ L_ D_k \right) \quad \text i>j.

This works as long as the generated diagonal elements in stay non-zero. The decomposition is then unique. and are real if is real.

For complex Hermitian matrix, the following formula applies:

D_ = A_ - \sum_^ L_L_^* D_k, L_ = \frac \left(A_ - \sum_^ L_ L_^* D_k \right) \quad \text i>j.

Again, the pattern of access allows the entire computation to be performed in-place if desired.

Block variant

When used on indefinite matrices, the LDL* factorization is known to be unstable without careful pivoting;[18] specifically, the elements of the factorization can grow arbitrarily. A possible improvement is to perform the factorization on block sub-matrices, commonly 2 × 2:[19]

\begin\mathbf = \mathbf^\mathrm & =\begin \mathbf I & 0 & 0 \\ \mathbf L_ & \mathbf I & 0 \\ \mathbf L_ & \mathbf L_ & \mathbf I\\\end\begin \mathbf D_1 & 0 & 0 \\ 0 & \mathbf D_2 & 0 \\ 0 & 0 & \mathbf D_3\\\end\begin \mathbf I & \mathbf L_^\mathrm T & \mathbf L_^\mathrm T \\ 0 & \mathbf I & \mathbf L_^\mathrm T \\ 0 & 0 & \mathbf I\\\end \\[8pt]& = \begin \mathbf D_1 & &(\mathrm) \\ \mathbf L_ \mathbf D_1 & \mathbf L_ \mathbf D_1 \mathbf L_^\mathrm T + \mathbf D_2& \\ \mathbf L_ \mathbf D_1 & \mathbf L_ \mathbf D_ \mathbf L_^\mathrm T + \mathbf L_ \mathbf D_2 & \mathbf L_ \mathbf D_1 \mathbf L_^\mathrm T + \mathbf L_ \mathbf D_2 \mathbf L_^\mathrm T + \mathbf D_3\end,\end

where every element in the matrices above is a square submatrix. From this, these analogous recursive relations follow:

\mathbf D_j = \mathbf A_ - \sum_^ \mathbf L_ \mathbf D_k \mathbf L_^\mathrm T,\mathbf L_ = \left(\mathbf A_ - \sum_^ \mathbf L_ \mathbf D_k \mathbf L_^\mathrm T\right) \mathbf D_j^.

This involves matrix products and explicit inversion, thus limiting the practical block size.

Updating the decomposition

A task that often arises in practice is that one needs to update a Cholesky decomposition. In more details, one has already computed the Cholesky decomposition \mathbf = \mathbf\mathbf^* of some matrix \mathbf, then one changes the matrix \mathbf in some way into another matrix, say \tilde , and one wants to compute the Cholesky decomposition of the updated matrix: \tilde = \tilde \tilde^* . The question is now whether one can use the Cholesky decomposition of \mathbf that was computed before to compute the Cholesky decomposition of \tilde .

Rank-one update

The specific case, where the updated matrix \tilde is related to the matrix \mathbf by \tilde = \mathbf + \mathbf \mathbf^* , is known as a rank-one update.

Here is a function[20] written in Matlab syntax that realizes a rank-one update:function [L] = cholupdate(L, x) n = length(x); for k = 1:n r = sqrt(L(k, k)^2 + x(k)^2); c = r / L(k, k); s = x(k) / L(k, k); L(k, k) = r; if k < n L((k+1):n, k) = (L((k+1):n, k) + s * x((k+1):n)) / c; x((k+1):n) = c * x((k+1):n) - s * L((k+1):n, k); end endendA rank-n update is one where for a matrix \mathbf one updates the decomposition such that \tilde = \mathbf + \mathbf \mathbf^* . This can be achieved by successively performing rank-one updates for each of the columns of \mathbf.

Rank-one downdate

A rank-one downdate is similar to a rank-one update, except that the addition is replaced by subtraction: \tilde = \mathbf - \mathbf \mathbf^* . This only works if the new matrix \tilde is still positive definite.

The code for the rank-one update shown above can easily be adapted to do a rank-one downdate: one merely needs to replace the two additions in the assignment to r and L((k+1):n, k) by subtractions.

Adding and removing rows and columns

If a symmetric and positive definite matrix \mathbf A is represented in block form as

\mathbf = \begin \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_ \\\end

and its upper Cholesky factor\mathbf = \begin \mathbf L_ & \mathbf L_ \\ 0 & \mathbf L_ \\\end,

then for a new matrix \tilde , which is the same as \mathbf A but with the insertion of new rows and columns,\begin\tilde &= \begin \mathbf A_ & \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_^ & \mathbf A_ \\\end\end

Now there is an interest in finding the Cholesky factorization of \tilde , which can be called \tilde , without directly computing the entire decomposition. \begin\tilde &= \begin \mathbf S_ & \mathbf S_ & \mathbf S_ \\ 0 & \mathbf S_ & \mathbf S_ \\ 0 & 0 & \mathbf S_ \\\end.\end

Writing \mathbf A \setminus \mathbf for the solution of \mathbf A \mathbf x = \mathbf b, which can be found easily for triangular matrices, and \text (\mathbf M) for the Cholesky decomposition of \mathbf M , the following relations can be found:\begin\mathbf S_ &= \mathbf L_, \\\mathbf S_ &= \mathbf L_^ \setminus \mathbf A_, \\\mathbf S_ &= \mathbf L_, \\\mathbf S_ &= \mathrm \left(\mathbf A_ - \mathbf S_^ \mathbf S_\right), \\\mathbf S_ &= \mathbf S_^ \setminus \left(\mathbf A_ - \mathbf S_^ \mathbf S_\right), \\\mathbf S_ &= \mathrm \left(\mathbf L_^ \mathbf L_ - \mathbf S_^ \mathbf S_\right).\end

These formulas may be used to determine the Cholesky factor after the insertion of rows or columns in any position, if the row and column dimensions are appropriately set (including to zero). The inverse problem,

\begin\tilde &= \begin \mathbf A_ & \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_^ & \mathbf A_ \\\end\endwith known Cholesky decomposition \begin\tilde &= \begin \mathbf S_ & \mathbf S_ & \mathbf S_ \\ 0 & \mathbf S_ & \mathbf S_ \\ 0 & 0 & \mathbf S_ \\\end\end

and the desire to determine the Cholesky factor\begin\mathbf &= \begin \mathbf L_ & \mathbf L_ \\ 0 & \mathbf L_ \\\end\end

of the matrix \mathbf A with rows and columns removed,\begin\mathbf &= \begin \mathbf A_ & \mathbf A_ \\ \mathbf A_^ & \mathbf A_ \\\end,\end

yields the following rules:\begin\mathbf L_ &= \mathbf S_, \\\mathbf L_ &= \mathbf S_, \\\mathbf L_ &= \mathrm \left(\mathbf S_^ \mathbf S_ + \mathbf S_^ \mathbf S_\right).\end

Notice that the equations above that involve finding the Cholesky decomposition of a new matrix are all of the form \tilde = \mathbf \pm \mathbf \mathbf^* , which allows them to be efficiently calculated using the update and downdate procedures detailed in the previous section.[21]

Proof for positive semi-definite matrices

Proof by limiting argument

The above algorithms show that every positive definite matrix \mathbf has a Cholesky decomposition. This result can be extended to the positive semi-definite case by a limiting argument. The argument is not fully constructive, i.e., it gives no explicit numerical algorithms for computing Cholesky factors.

If \mathbf is an n \times n positive semi-definite matrix, then the sequence \left(\mathbf_k\right)_k := \left(\mathbf + \frac \mathbf_n\right)_k consists of positive definite matrices. (This is an immediate consequence of, for example, the spectral mapping theorem for the polynomial functional calculus.) Also, \mathbf_k \rightarrow \mathbf\quad \text \quadk \rightarrow \infty in operator norm. From the positive definite case, each \mathbf_k has Cholesky decomposition \mathbf_k = \mathbf_k\mathbf_k^* . By property of the operator norm,

\| \mathbf_k \|^2 \leq \| \mathbf_k \mathbf_k^* \| = \| \mathbf_k \| \,.

The \leq holds because M_n(\mathbb) equipped with the operator norm is a C* algebra. So \left(\mathbf_k \right)_k is a bounded set in the Banach space of operators, therefore relatively compact (because the underlying vector space is finite-dimensional). Consequently, it has a convergent subsequence, also denoted by \left(\mathbf_k \right)_k, with limit \mathbf. It can be easily checked that this \mathbf has the desired properties, i.e. \mathbf = \mathbf\mathbf^* , and \mathbf is lower triangular with non-negative diagonal entries: for all x and y,

\langle \mathbf x, y \rangle = \left\langle \lim \mathbf_k x, y \right\rangle = \langle \lim \mathbf_k \mathbf_k^* x, y \rangle = \langle \mathbf \mathbf^*x, y \rangle \,.

Therefore, \mathbf = \mathbf\mathbf^* . Because the underlying vector space is finite-dimensional, all topologies on the space of operators are equivalent. So \left(\mathbf_k \right)_k tends to \mathbf in norm means \left(\mathbf_k \right)_k tends to \mathbf entrywise. This in turn implies that, since each \mathbf_k is lower triangular with non-negative diagonal entries, \mathbf is also.

Proof by QR decomposition

Let \mathbf be a positive semi-definite Hermitian matrix. Then it can be written as a product of its square root matrix, \mathbf = \mathbf \mathbf^*. Now QR decomposition can be applied to \mathbf^*, resulting in \mathbf^* = \mathbf\mathbf, where \mathbf is unitary and \mathbf is upper triangular. Inserting the decomposition into the original equality yields A = \mathbf \mathbf^* = (\mathbf)^*\mathbf = \mathbf^*\mathbf^*\mathbf = \mathbf^*\mathbf. Setting \mathbf = \mathbf^* completes the proof.

Generalization

The Cholesky factorization can be generalized to (not necessarily finite) matrices with operator entries. Let \ be a sequence of Hilbert spaces. Consider the operator matrix

\mathbf =\begin\mathbf_ & \mathbf_ & \mathbf_ & \; \\\mathbf_^* & \mathbf_ & \mathbf_ & \; \\\mathbf _^* & \mathbf_^* & \mathbf_ & \; \\\; & \; & \; & \ddots\end

acting on the direct sum

\mathcal = \bigoplus_n \mathcal_n,

where each

\mathbf_ : \mathcal_j \rightarrow \mathcal _i

is a bounded operator. If is positive (semidefinite) in the sense that for all finite and for any

h \in \bigoplus_^k \mathcal_k,

there is \langle h, \mathbf h\rangle \ge 0, then there exists a lower triangular operator matrix such that . One can also take the diagonal entries of to be positive.

Implementations in programming libraries

See also

References

External links

History of science

Information

Computer code

Use of the matrix in simulation

Online calculators

Notes and References

  1. Benoit. 1924. Note sur une méthode de résolution des équations normales provenant de l'application de la méthode des moindres carrés à un système d'équations linéaires en nombre inférieur à celui des inconnues (Procédé du Commandant Cholesky). Bulletin Géodésique. fr. 2. 66–67. 10.1007/BF03031308.
  2. Book: Press, William H.. Saul A. Teukolsky. William T. Vetterling. Brian P. Flannery. Numerical Recipes in C: The Art of Scientific Computing. second. Cambridge University England EPress. 1992. 994. 0-521-43108-5. 2009-01-28.
  3. ,, .
  4. .
  5. Web site: matrices - Diagonalizing a Complex Symmetric Matrix. MathOverflow. 2020-01-25.
  6. Schabauer. Hannes. Pacher. Christoph. Sunderland. Andrew G.. Gansterer. Wilfried N.. 2010-05-01. Toward a parallel solver for generalized complex symmetric eigenvalue problems. Procedia Computer Science. ICCS 2010. en. 1. 1. 437–445. 10.1016/j.procs.2010.04.047. 1877-0509. free.
  7. .
  8. Book: Gentle, James E. . 1998 . Numerical Linear Algebra for Applications in Statistics . 978-1-4612-0623-1 . Springer . en . 94.
  9. Book: Higham, Nicholas J. . http://eprints.maths.manchester.ac.uk/1193/ . Reliable Numerical Computation . Oxford University Press . 1990 . 978-0-19-853564-5 . Cox . M. G. . Oxford, UK . 161–185 . en . Hammarling . S. J. . Analysis of the Cholesky Decomposition of a Semi-definite Matrix.
  10. Krishnamoorthy. Aravindh. Menon, Deepak. Matrix Inversion Using Cholesky Decomposition. 1111. 4144. 2011. 2011arXiv1111.4144K. 1111.4144.
  11. So . Anthony Man-Cho . A Semidefinite Programming Approach to the Graph Realization Problem: Theory, Applications and Extensions . 2007 . en . PhD. Theorem 2.2.6.
  12. Pope, Stephen B. "Algorithms for ellipsoids." Cornell University Report No. FDA (2008): 08-01.
  13. Book: Arora, Jasbir Singh . Introduction to Optimum Design . 2004-06-02 . Elsevier . 978-0-08-047025-2 . en.
  14. http://www.mathworks.com/help/techdoc/ref/randn.html Matlab randn documentation
  15. ?potrf Intel® Math Kernel Library https://software.intel.com/content/www/us/en/develop/documentation/onemkl-developer-reference-c/top/lapack-routines/lapack-linear-equation-routines/lapack-linear-equation-computational-routines/matrix-factorization-lapack-computational-routines/potrf.html#potrf
  16. Fang. Haw-ren. O'Leary, Dianne P.. Dianne P. O'Leary . Modified Cholesky Algorithms: A Catalog with New Approaches. 8 August 2006.
  17. Book: Watkins, D. . 1991 . Fundamentals of Matrix Computations . registration . New York . Wiley . 84 . 0-471-61414-9 .
  18. Book: Nocedal, Jorge. Numerical Optimization. 2000. Springer.
  19. Fang. Haw-ren. Analysis of Block LDLT Factorizations for Symmetric Indefinite Matrices. 24 August 2007.
  20. Based on: Book: Stewart, G. W.. Basic decompositions. 1998. Soc. for Industrial and Applied Mathematics. Philadelphia. 0-89871-414-1.
  21. Osborne, M. (2010), Appendix B.