In numerical linear algebra, the Jacobi eigenvalue algorithm is an iterative method for the calculation of the eigenvalues and eigenvectors of a real symmetric matrix (a process known as diagonalization). It is named after Carl Gustav Jacob Jacobi, who first proposed the method in 1846,[1] but only became widely used in the 1950s with the advent of computers.[2]
This algorithm is inherently a dense matrix algorithm: it draws little or no advantage from being applied to a sparse matrix, and it will destroy sparseness by creating fill-in. Similarly, it will not preserve structures such as being banded of the matrix on which it operates.
Let S {\displaystyle S} be a symmetric matrix, and G = G ( i , j , θ ) {\displaystyle G=G(i,j,\theta )} be a Givens rotation matrix. Then:
is symmetric and similar to S {\displaystyle S} .
Furthermore, S ′ {\displaystyle S^{\prime }} has entries:
where s = sin ( θ ) {\displaystyle s=\sin(\theta )} and c = cos ( θ ) {\displaystyle c=\cos(\theta )} .
Since G {\displaystyle G} is orthogonal, S {\displaystyle S} and S ′ {\displaystyle S^{\prime }} have the same Frobenius norm | | ⋅ | | F {\displaystyle ||\cdot ||_{F}} (the square-root sum of squares of all components), however we can choose θ {\displaystyle \theta } such that S i j ′ = 0 {\displaystyle S_{ij}^{\prime }=0} , in which case S ′ {\displaystyle S^{\prime }} has a larger sum of squares on the diagonal:
Set this equal to 0, and rearrange:
if S j j = S i i {\displaystyle S_{jj}=S_{ii}}
In order to optimize this effect, Sij should be the off-diagonal element with the largest absolute value, called the pivot.
The Jacobi eigenvalue method repeatedly performs rotations until the matrix becomes almost diagonal. Then the elements in the diagonal are approximations of the (real) eigenvalues of S.
If p = S k l {\displaystyle p=S_{kl}} is a pivot element, then by definition | S i j | ≤ | p | {\displaystyle |S_{ij}|\leq |p|} for 1 ≤ i , j ≤ n , i ≠ j {\displaystyle 1\leq i,j\leq n,i\neq j} . Let Γ ( S ) 2 {\displaystyle \Gamma (S)^{2}} denote the sum of squares of all off-diagonal entries of S {\displaystyle S} . Since S {\displaystyle S} has exactly 2 N := n ( n − 1 ) {\displaystyle 2N:=n(n-1)} off-diagonal elements, we have p 2 ≤ Γ ( S ) 2 ≤ 2 N p 2 {\displaystyle p^{2}\leq \Gamma (S)^{2}\leq 2Np^{2}} or 2 p 2 ≥ Γ ( S ) 2 / N {\displaystyle 2p^{2}\geq \Gamma (S)^{2}/N} . Now Γ ( S J ) 2 = Γ ( S ) 2 − 2 p 2 {\displaystyle \Gamma (S^{J})^{2}=\Gamma (S)^{2}-2p^{2}} . This implies Γ ( S J ) 2 ≤ ( 1 − 1 / N ) Γ ( S ) 2 {\displaystyle \Gamma (S^{J})^{2}\leq (1-1/N)\Gamma (S)^{2}} or Γ ( S J ) ≤ ( 1 − 1 / N ) 1 / 2 Γ ( S ) {\displaystyle \Gamma (S^{J})\leq (1-1/N)^{1/2}\Gamma (S)} ; that is, the sequence of Jacobi rotations converges at least linearly by a factor ( 1 − 1 / N ) 1 / 2 {\displaystyle (1-1/N)^{1/2}} to a diagonal matrix.
A number of N {\displaystyle N} Jacobi rotations is called a sweep; let S σ {\displaystyle S^{\sigma }} denote the result. The previous estimate yields
that is, the sequence of sweeps converges at least linearly with a factor ≈ e 1 / 2 {\displaystyle e^{1/2}} .
However the following result of Schönhage[3] yields locally quadratic convergence. To this end let S have m distinct eigenvalues λ 1 , . . . , λ m {\displaystyle \lambda _{1},...,\lambda _{m}} with multiplicities ν 1 , . . . , ν m {\displaystyle \nu _{1},...,\nu _{m}} and let d > 0 be the smallest distance of two different eigenvalues. Let us call a number of
Jacobi rotations a Schönhage-sweep. If S s {\displaystyle S^{s}} denotes the result then
Thus convergence becomes quadratic as soon as Γ ( S ) < d 2 + n 2 − 1 {\displaystyle \Gamma (S)<{\frac {d}{2+{\sqrt {{\frac {n}{2}}-1}}}}}
Each Givens rotation can be done in O ( n ) {\displaystyle O(n)} steps when the pivot element p is known. However the search for p requires inspection of all N ≈ 1/2 n2 off-diagonal elements, which means this search dominates the overall complexity and pushes the computational complexity of a sweep in the classical Jacobi algorithm to O ( n 4 ) {\displaystyle O(n^{4})} . Competing algorithms attain O ( n 3 ) {\displaystyle O(n^{3})} complexity for a full diagonalisation.
We can reduce the complexity of finding the pivot element from O(N) to O(n) if we introduce an additional index array m 1 , … , m n − 1 {\displaystyle m_{1},\,\dots \,,\,m_{n-1}} with the property that m i {\displaystyle m_{i}} is the index of the largest element in row i, (i = 1, ..., n − 1) of the current S. Then the indices of the pivot (k, l) must be one of the pairs ( i , m i ) {\displaystyle (i,m_{i})} . Also the updating of the index array can be done in O(n) average-case complexity: First, the maximum entry in the updated rows k and l can be found in O(n) steps. In the other rows i, only the entries in columns k and l change. Looping over these rows, if m i {\displaystyle m_{i}} is neither k nor l, it suffices to compare the old maximum at m i {\displaystyle m_{i}} to the new entries and update m i {\displaystyle m_{i}} if necessary. If m i {\displaystyle m_{i}} should be equal to k or l and the corresponding entry decreased during the update, the maximum over row i has to be found from scratch in O(n) complexity. However, this will happen on average only once per rotation. Thus, each rotation has O(n) and one sweep O(n3) average-case complexity, which is equivalent to one matrix multiplication. Additionally the m i {\displaystyle m_{i}} must be initialized before the process starts, which can be done in n2 steps.
Typically the Jacobi method converges within numerical precision after a small number of sweeps. Note that multiple eigenvalues reduce the number of iterations since N S < N {\displaystyle N_{S}<N} .
An alternative approach is to forego the search entirely, and simply have each sweep pivot every off-diagonal element once, in some predetermined order. It has been shown that this cyclic Jacobi attains quadratic convergence,[4][5] just like the classical Jacobi.
The opportunity for parallelisation that is particular to Jacobi is based on combining cyclic Jacobi with the observation that Givens rotations for disjoint sets of indices commute, so that several can be applied in parallel. Concretely, if G 1 {\displaystyle G_{1}} pivots between indices i 1 , j 1 {\displaystyle i_{1},j_{1}} and G 2 {\displaystyle G_{2}} pivots between indices i 2 , j 2 {\displaystyle i_{2},j_{2}} , then from { i 1 , j 1 } ∩ { i 2 , j 2 } = ∅ {\displaystyle \{i_{1},j_{1}\}\cap \{i_{2},j_{2}\}=\varnothing } follows G 1 G 2 = G 2 G 1 {\displaystyle G_{1}G_{2}=G_{2}G_{1}} because in computing G 1 G 2 A {\displaystyle G_{1}G_{2}A} or G 2 G 1 A {\displaystyle G_{2}G_{1}A} the G 1 {\displaystyle G_{1}} rotation only needs to access rows i 1 , j 1 {\displaystyle i_{1},j_{1}} and the G 2 {\displaystyle G_{2}} rotation only needs to access rows i 2 , j 2 {\displaystyle i_{2},j_{2}} . Two processors can perform both rotations in parallel, because no matrix element is accessed for both.
Partitioning the set of index pairs of a sweep into classes that are pairwise disjoint is equivalent to partitioning the edge set of a complete graph into matchings, which is the same thing as edge colouring it; each colour class then becomes a round within the sweep. The minimal number of rounds is the chromatic index of the complete graph, and equals n {\displaystyle n} for odd n {\displaystyle n} but n − 1 {\displaystyle n-1} for even n {\displaystyle n} . A simple rule for odd n {\displaystyle n} is to handle the pairs { i 1 , j 1 } {\displaystyle \{i_{1},j_{1}\}} and { i 2 , j 2 } {\displaystyle \{i_{2},j_{2}\}} in the same round if i 1 + j 1 ≡ i 2 + j 2 ( mod n ) {\displaystyle i_{1}+j_{1}\equiv i_{2}+j_{2}\textstyle {\pmod {n}}} . For even n {\displaystyle n} one may create n − 1 {\displaystyle n-1} rounds k = 0 , 1 , … , n − 2 {\displaystyle k=0,1,\dotsc ,n-2} where a pair { i , j } {\displaystyle \{i,j\}} for 1 ⩽ i < j ⩽ n − 1 {\displaystyle 1\leqslant i<j\leqslant n-1} goes into round ( i + j ) mod ( n − 1 ) {\displaystyle (i+j){\bmod {(}}n-1)} and additionally a pair { i , n } {\displaystyle \{i,n\}} for 1 ⩽ i ⩽ n − 1 {\displaystyle 1\leqslant i\leqslant n-1} goes into round 2 i mod ( n − 1 ) {\displaystyle 2i{\bmod {(}}n-1)} . This brings the time complexity of a sweep down from O ( n 3 ) {\displaystyle O(n^{3})} to O ( n 2 ) {\displaystyle O(n^{2})} , if n / 2 {\displaystyle n/2} processors are available.
A round would consist of each processor first calculating ( c , s ) {\displaystyle (c,s)} for its rotation, and then applying the rotation from the left (rotating between rows). Next, the processors synchronise before applying the transpose rotation from the right (rotating between columns), and finally synchronising again. A matrix element may be accessed by two processors during a round, but not by both during the same half of this round.
Further parallelisation is possible by dividing the work for a single rotation between several processors, but that might be getting too fine-grained to be practical.
The following algorithm is a description of the Jacobi method in math-like notation. It calculates a vector e which contains the eigenvalues and a matrix E which contains the corresponding eigenvectors; that is, e i {\displaystyle e_{i}} is an eigenvalue and the column E i {\displaystyle E_{i}} an orthonormal eigenvector for e i {\displaystyle e_{i}} , i = 1, ..., n.
procedure jacobi(S ∈ Rn×n; out e ∈ Rn; out E ∈ Rn×n) var i, k, l, m, state ∈ N s, c, t, p, y, d, r ∈ R ind ∈ Nn changed ∈ Ln function maxind(k ∈ N) ∈ N ! index of largest off-diagonal element in row k m := k+1 for i := k+2 to n do if │Ski│ > │Skm│ then m := i endif endfor return m endfunc procedure update(k ∈ N; t ∈ R) ! update ek and its status y := ek; ek := y+t if changedk and (y=ek) then changedk := false; state := state−1 elsif (not changedk) and (y≠ek) then changedk := true; state := state+1 endif endproc procedure rotate(k,l,i,j ∈ N) ! perform rotation of Sij, Skl ┌ ┐ ┌ ┐┌ ┐ │Skl│ │c −s││Skl│ │ │ := │ ││ │ │Sij│ │s c││Sij│ └ ┘ └ ┘└ ┘ endproc ! init e, E, and arrays ind, changed E := I; state := n for k := 1 to n do indk := maxind(k); ek := Skk; changedk := true endfor while state≠0 do ! next rotation m := 1 ! find index (k,l) of pivot p for k := 2 to n−1 do if │Sk indk│ > │Sm indm│ then m := k endif endfor k := m; l := indm; p := Skl ! calculate c = cos φ, s = sin φ y := (el−ek)/2; d := │y│+√(p2+y2) r := √(p2+d2); c := d/r; s := p/r; t := p2/d if y<0 then s := −s; t := −t endif Skl := 0.0; update(k,−t); update(l,t) ! rotate rows and columns k and l for i := 1 to k−1 do rotate(i,k,i,l) endfor for i := k+1 to l−1 do rotate(k,i,i,l) endfor for i := l+1 to n do rotate(k,i,l,i) endfor ! rotate eigenvectors for i := 1 to n do ┌ ┐ ┌ ┐┌ ┐ │Eik│ │c −s││Eik│ │ │ := │ ││ │ │Eil│ │s c││Eil│ └ ┘ └ ┘└ ┘ endfor ! update all potentially changed indi for i := 1 to n do indi := maxind(i) endfor loop endproc
1. The logical array changed holds the status of each eigenvalue. If the numerical value of e k {\displaystyle e_{k}} or e l {\displaystyle e_{l}} changes during an iteration, the corresponding component of changed is set to true, otherwise to false. The integer state counts the number of components of changed which have the value true. Iteration stops as soon as state = 0. This means that none of the approximations e 1 , . . . , e n {\displaystyle e_{1},\,...\,,e_{n}} has recently changed its value and thus it is not very likely that this will happen if iteration continues. Here it is assumed that floating point operations are optimally rounded to the nearest floating point number.
2. The upper triangle of the matrix S is destroyed while the lower triangle and the diagonal are unchanged. Thus it is possible to restore S if necessary according to
for k := 1 to n−1 do ! restore matrix S for l := k+1 to n do Skl := Slk endfor endfor
3. The eigenvalues are not necessarily in descending order. This can be achieved by a simple sorting algorithm.
for k := 1 to n−1 do m := k for l := k+1 to n do if el > em then m := l endif endfor if k ≠ m then swap em,ek swap Em,Ek endif endfor
4. The algorithm is written using matrix notation (1 based arrays instead of 0 based).
5. When implementing the algorithm, the part specified using matrix notation must be performed simultaneously.
6. This implementation does not correctly account for the case in which one dimension is an independent subspace. For example, if given a diagonal matrix, the above implementation will never terminate, as none of the eigenvalues will change. Hence, in real implementations, extra logic must be added to account for this case.
Let S = ( 4 − 30 60 − 35 − 30 300 − 675 420 60 − 675 1620 − 1050 − 35 420 − 1050 700 ) {\displaystyle S={\begin{pmatrix}4&-30&60&-35\\-30&300&-675&420\\60&-675&1620&-1050\\-35&420&-1050&700\end{pmatrix}}}
Then jacobi produces the following eigenvalues and eigenvectors after 3 sweeps (19 iterations) :
e 1 = 2585.25381092892231 {\displaystyle e_{1}=2585.25381092892231}
E 1 = ( 0.0291933231647860588 − 0.328712055763188997 0.791411145833126331 − 0.514552749997152907 ) {\displaystyle E_{1}={\begin{pmatrix}0.0291933231647860588\\-0.328712055763188997\\0.791411145833126331\\-0.514552749997152907\end{pmatrix}}}
e 2 = 37.1014913651276582 {\displaystyle e_{2}=37.1014913651276582}
E 2 = ( − 0.179186290535454826 0.741917790628453435 − 0.100228136947192199 − 0.638282528193614892 ) {\displaystyle E_{2}={\begin{pmatrix}-0.179186290535454826\\0.741917790628453435\\-0.100228136947192199\\-0.638282528193614892\end{pmatrix}}}
e 3 = 1.4780548447781369 {\displaystyle e_{3}=1.4780548447781369}
E 3 = ( − 0.582075699497237650 0.370502185067093058 0.509578634501799626 0.514048272222164294 ) {\displaystyle E_{3}={\begin{pmatrix}-0.582075699497237650\\0.370502185067093058\\0.509578634501799626\\0.514048272222164294\end{pmatrix}}}
e 4 = 0.1666428611718905 {\displaystyle e_{4}=0.1666428611718905}
E 4 = ( 0.792608291163763585 0.451923120901599794 0.322416398581824992 0.252161169688241933 ) {\displaystyle E_{4}={\begin{pmatrix}0.792608291163763585\\0.451923120901599794\\0.322416398581824992\\0.252161169688241933\end{pmatrix}}}
When the eigenvalues (and eigenvectors) of a symmetric matrix are known, the following values are easily calculated.
The following code is a straight-forward implementation of the mathematical description of the Jacobi eigenvalue algorithm in the Julia programming language.
using LinearAlgebra, Test function find_pivot(Sprime) n = size(Sprime,1) pivot_i = pivot_j = 0 pivot = 0.0 for j = 1:n for i = 1:(j-1) if abs(Sprime[i,j]) > pivot pivot_i = i pivot_j = j pivot = abs(Sprime[i,j]) end end end return (pivot_i, pivot_j, pivot) end # in practice one should not instantiate explicitly the Givens rotation matrix function givens_rotation_matrix(n,i,j,θ) G = Matrix{Float64}(I,(n,n)) G[i,i] = G[j,j] = cos(θ) G[i,j] = sin(θ) G[j,i] = -sin(θ) return G end # S is a symmetric n by n matrix n = 4 sqrtS = randn(n,n); S = sqrtS*sqrtS'; # the largest allowed off-diagonal element of U' * S * U # where U are the eigenvectors tol = 1e-14 Sprime = copy(S) U = Matrix{Float64}(I,(n,n)) while true (pivot_i, pivot_j, pivot) = find_pivot(Sprime) if pivot < tol break end θ = atan(2*Sprime[pivot_i,pivot_j]/(Sprime[pivot_j,pivot_j] - Sprime[pivot_i,pivot_i] )) / 2 G = givens_rotation_matrix(n,pivot_i,pivot_j,θ) # update Sprime and U Sprime .= G'*Sprime*G U .= U * G end # Sprime is now (almost) a diagonal matrix # extract eigenvalues λ = diag(Sprime) # sort eigenvalues (and corresponding eigenvectors U) by increasing values i = sortperm(λ) λ = λ[i] U = U[:,i] # S should be equal to U * diagm(λ) * U' @test S ≈ U * diagm(λ) * U'
The Jacobi Method has been generalized to complex Hermitian matrices, general nonsymmetric real and complex matrices as well as block matrices.
Since singular values of a real matrix are the square roots of the eigenvalues of the symmetric matrix S = A T A {\displaystyle S=A^{T}A} it can also be used for the calculation of these values. For this case, the method is modified in such a way that S must not be explicitly calculated which reduces the danger of round-off errors. Note that J S J T = J A T A J T = J A T J T J A J T = B T B {\displaystyle JSJ^{T}=JA^{T}AJ^{T}=JA^{T}J^{T}JAJ^{T}=B^{T}B} with B := J A J T {\displaystyle B\,:=JAJ^{T}} .