Fact-checked by Grok 2 weeks ago

Skew-Hermitian matrix

In linear algebra, a skew-Hermitian matrix is a square with complex entries that equals the negative of its own , denoted as A = -A^H, where A^H is the of A. For real-valued matrices, this condition is equivalent to being skew-symmetric, meaning A = -A^T. These matrices form a real , closed under addition and scalar multiplication by real numbers, and the diagonal entries of any skew-Hermitian matrix must be purely imaginary. Key properties of skew-Hermitian matrices include the fact that their eigenvalues are purely imaginary, lying on the imaginary axis of the complex plane. Moreover, they admit a spectral decomposition: any skew-Hermitian matrix A \in \mathbb{C}^{n \times n} can be unitarily diagonalized as A = U D U^H, where U is a unitary matrix and D is diagonal with purely imaginary entries. A notable relation to Hermitian matrices is that if A is skew-Hermitian, then iA is Hermitian, and conversely, multiplying a Hermitian matrix by i yields a skew-Hermitian one. Skew-Hermitian matrices play a fundamental role in the unique decomposition of any complex square matrix Z into a of a and a skew-Hermitian matrix: Z = \frac{1}{2}(Z + Z^H) + \frac{1}{2}(Z - Z^H), where the first term is Hermitian and the second is skew-Hermitian. They are also a subclass of normal matrices, satisfying A A^H = A^H A, which ensures the existence of an of eigenvectors. In applications, such matrices arise in for representing anti-Hermitian operators and in stability analysis of differential equations.

Definition

Formal Definition

A square A with entries possesses a , also known as the and denoted A^\dagger, which is obtained by first transposing A (replacing A with its A^T, where (A^T)_{ij} = A_{ji}) and then taking the of each entry. The (i,j)-th entry of A^\dagger is thus given by (A^\dagger)_{ij} = \overline{A_{ji}}, where \overline{\cdot} denotes the . A skew-Hermitian matrix is a square matrix A over the complex numbers satisfying A^\dagger = -A. Skew-Hermitian matrices arise in the study of finite-dimensional complex vector spaces and are the complex analogs of real skew-symmetric matrices, which satisfy A^T = -A over the reals. They apply to n \times n matrices for any finite positive integer n. In contrast, Hermitian matrices satisfy A^\dagger = A.

Equivalent Conditions

A skew-Hermitian matrix A = (a_{ij}) satisfies the entry-wise condition that a_{ji} = -\overline{a_{ij}} for all indices i, j, where \overline{a_{ij}} denotes the of a_{ij}. This component-level characterization is equivalent to the defining property A^* = -A, with A^* being the , and directly implies that the diagonal entries a_{ii} must be purely imaginary (or zero). From the perspective of inner product spaces, a skew-Hermitian matrix A represents a such that the associated \langle Ax, y \rangle = -\langle x, Ay \rangle for all vectors x, y in the space, where \langle \cdot, \cdot \rangle is the standard inner product. This condition highlights the anti-symmetric nature of the form under the inner product, preserving a while introducing a sign reversal upon interchange of arguments. In a more general setting, skew-Hermitian matrices extend to bounded linear operators on complex Hilbert spaces, where an operator A is skew-Hermitian if its adjoint satisfies A^* = -A. This operator-theoretic formulation captures the same structural properties as the finite-dimensional matrix case, including the preservation of the Hilbert space inner product in an anti-Hermitian manner. A notable traceless variant consists of skew-Hermitian matrices with zero trace, which form the \mathfrak{su}(n) of the \mathrm{SU}(n). These matrices underpin the infinitesimal generators of \mathrm{SU}(n) transformations and are essential in .

Properties

Basic Properties

The set of all n \times n skew-Hermitian matrices over the complex numbers forms a real under the operations of and by real numbers. This structure arises because the defining condition A^\dagger = -A is preserved under these operations, making the set closed and satisfying the vector space axioms over the reals (though not over the complexes, as multiplication by i yields a ). The collection is closed under addition: if A and B are skew-Hermitian, then (A + B)^\dagger = A^\dagger + B^\dagger = -A - B = -(A + B). Similarly, for any real scalar c, the multiple cA satisfies (cA)^\dagger = \overline{c} A^\dagger = c (-A) = -(cA), since \overline{c} = c. Regarding , the product AB of two skew-Hermitian matrices A and B is not generally skew-Hermitian; instead, (AB)^\dagger = B^\dagger A^\dagger = (-B)(-A) = BA, so AB is Hermitian precisely when A and B commute (i.e., AB = BA). The trace of a skew-Hermitian matrix A is purely imaginary (including zero). This follows from \operatorname{tr}(A^\dagger) = \overline{\operatorname{tr}(A)} = \operatorname{tr}(-A) = -\operatorname{tr}(A), implying $2 \operatorname{Re}(\operatorname{tr}(A)) = 0, so the real part vanishes. Additionally, every skew-Hermitian matrix is normal, as A A^\dagger = A (-A) = -A^2 and A^\dagger A = (-A) A = -A^2, confirming A A^\dagger = A^\dagger A.

Spectral Properties

A skew-Hermitian matrix has all eigenvalues purely imaginary. To see this, suppose A is skew-Hermitian, so A^\dagger = -A, and let \lambda be an eigenvalue with eigenvector v \neq 0, satisfying A v = \lambda v. Taking the conjugate transpose gives v^\dagger A^\dagger = \overline{\lambda} v^\dagger, or v^\dagger (-A) = \overline{\lambda} v^\dagger, hence -v^\dagger A = \overline{\lambda} v^\dagger. Multiplying on the right by v yields -v^\dagger A v = \overline{\lambda} v^\dagger v. But v^\dagger A v = v^\dagger (\lambda v) = \lambda v^\dagger v, so -\lambda \|v\|^2 = \overline{\lambda} \|v\|^2, implying \lambda = -\overline{\lambda}, or equivalently, the real part of \lambda is zero. Thus, each eigenvalue can be written as \lambda = i \mu where \mu is real. Skew-Hermitian matrices are , since A A^\dagger = A (-A) = -A^2 and A^\dagger A = (-A) A = -A^2, so A A^\dagger = A^\dagger A. Normal matrices over the complex numbers are unitarily diagonalizable, meaning there exists a U (satisfying U^\dagger U = I) such that A = U D U^\dagger, where D is diagonal with purely imaginary entries on the diagonal. The columns of U form an of eigenvectors for A, and eigenvectors corresponding to distinct eigenvalues are orthogonal. Since skew-Hermitian matrices are , they are and possess only trivial Jordan blocks; their Jordan canonical form is simply the D from the unitary diagonalization, with no off-diagonal 1's. The of a skew-Hermitian matrix is the product of its eigenvalues, hence a product of purely imaginary numbers.

Examples and Constructions

Explicit Examples

A skew-Hermitian matrix of order 1 is simply a scalar multiple of the , such as [i b] where b is real, since its is [-i b], which equals the negative only if b is real. For a general 2×2 skew-Hermitian matrix, the form is A = \begin{pmatrix} i a & b + i c \\ -b + i c & i d \end{pmatrix}, where a, d are real and b, c are real numbers, ensuring the diagonal entries are purely imaginary and the off-diagonal entries satisfy the skew-Hermitian condition A^\dagger = -A. To verify, the yields A^\dagger = \begin{pmatrix} -i a & -b - i c \\ b - i c & -i d \end{pmatrix} = -A. A specific numerical example is the matrix \begin{pmatrix} -i & 2 - i \\ -2 - i & 0 \end{pmatrix}. Its is \begin{pmatrix} i & -2 + i \\ 2 + i & 0 \end{pmatrix}, which equals the negative of the original , confirming it is skew-Hermitian. Over the real numbers, skew-Hermitian matrices coincide with skew-symmetric matrices, such as \begin{pmatrix} 0 & 1 \\ -1 & 0 \end{pmatrix}, whose is its negative. Traceless skew-Hermitian matrices form the \mathfrak{su}(2), with basis given by i times the : i \sigma_x = \begin{pmatrix} 0 & i \\ i & 0 \end{pmatrix}, \quad i \sigma_y = \begin{pmatrix} 0 & 1 \\ -1 & 0 \end{pmatrix}, \quad i \sigma_z = \begin{pmatrix} i & 0 \\ 0 & -i \end{pmatrix}. Each satisfies the skew-Hermitian condition and has trace zero.

Generating Methods

A fundamental method to generate a skew-Hermitian matrix involves multiplying a by the i. If H is Hermitian, satisfying H^\dagger = H, then the matrix S = i H is skew-Hermitian because S^\dagger = (i H)^\dagger = -i H^\dagger = -i H = -S. For direct construction of finite-dimensional skew-Hermitian matrices, one specifies arbitrary entries above the , sets the diagonal entries to purely imaginary numbers (including zero), and defines the entries below the as the negative conjugates of the corresponding upper triangular entries. This procedure ensures the resulting matrix S satisfies S^\dagger = -S by design, as the swaps and conjugates the off-diagonal elements while negating the diagonal imaginaries appropriately. In numerical and computational contexts, random skew-Hermitian matrices are often generated by first creating a random —typically by drawing independent complex Gaussian entries for the upper triangle, their conjugates for the lower triangle, and real Gaussians for the diagonal—and then multiplying by i. This approach leverages efficient algorithms for random Hermitian generation and preserves the skew-Hermitian structure probabilistically. Skew-Hermitian matrices can also be constructed in block forms. A block-diagonal matrix composed of skew-Hermitian blocks on the diagonal is itself skew-Hermitian, since the conjugate transpose acts block-wise and preserves the property for each component. Similarly, the of a skew-Hermitian matrix A and a B yields a skew-Hermitian matrix, as (A \otimes B)^\dagger = A^\dagger \otimes B^\dagger = (-A) \otimes B = -(A \otimes B). In infinite-dimensional settings, skew-Hermitian operators arise naturally from on Hilbert spaces such as L^2(\mathbb{R}). For instance, the i \frac{d}{dx} (with suitable , e.g., compactly supported functions) defines a skew-Hermitian , as its formal is -i \frac{d}{dx}, satisfying the required relation under appropriate boundary conditions.

Decompositions and Representations

Hermitian-Skew-Hermitian Decomposition

Every square complex matrix A admits a unique decomposition into a Hermitian part and a skew-Hermitian part, given by A = H + S, where H = \frac{A + A^\dagger}{2}, \quad S = \frac{A - A^\dagger}{2}. Here, A^\dagger denotes the (adjoint) of A, H satisfies H^\dagger = H, and S satisfies S^\dagger = -S. To verify the properties, compute H^\dagger = \left( \frac{A + A^\dagger}{2} \right)^\dagger = \frac{A^\dagger + A}{2} = H, S^\dagger = \left( \frac{A - A^\dagger}{2} \right)^\dagger = \frac{A^\dagger - A}{2} = -\frac{A - A^\dagger}{2} = -S, and H + S = \frac{A + A^\dagger + A - A^\dagger}{2} = A. This establishes the decomposition. The decomposition is unique: Suppose A = H' + S' with H'^\dagger = H' and (S')^\dagger = -S'. Then H' - H = S - S'. Let D = H' - H = S - S'. The left side yields D^\dagger = D, while the right side yields D^\dagger = -D, so D = -D, implying D = 0. Thus, H' = H and S' = S. This decomposition, known as the Toeplitz or Cartesian , extends to bounded linear operators on Hilbert spaces, where any T \in B(\mathcal{H}) satisfies T = \operatorname{Re}(T) + i \operatorname{Im}(T), with both \operatorname{Re}(T) and \operatorname{Im}(T) (corresponding to Hermitian and skew-Hermitian parts via S = i \operatorname{Im}(T)). In , the decomposition enhances stability in iterative solvers for non-Hermitian systems, such as Hermitian and skew-Hermitian splitting (HSS) methods for large sparse positive definite linear equations, and supports computations like polar decompositions by isolating symmetric components.

The matrix exponential of a skew-Hermitian matrix S, defined as \exp(S) = \sum_{k=0}^{\infty} \frac{S^k}{k!}, is always a . This follows from the property that S^\dagger = -S, which implies \exp(S)^\dagger = \exp(S^\dagger) = \exp(-S) = \exp(S)^{-1}, confirming the unitarity condition \exp(S)^\dagger \exp(S) = I. The power series for the matrix exponential converges absolutely for every skew-Hermitian matrix S, as it does for all complex square matrices, with the radius of convergence being infinite. This convergence ensures that \exp(S) is well-defined and analytic in the space of skew-Hermitian matrices. A closely related construction involves Hermitian matrices: for any Hermitian matrix H, the matrix \exp(iH) is unitary, where iH is skew-Hermitian. Conversely, every exponential of a skew-Hermitian matrix can be expressed in this form by setting S = iH with H = -iS Hermitian. This equivalence highlights the exponential map's role in parameterizing unitary matrices via skew-Hermitian arguments. Every unitary matrix U admits a skew-Hermitian logarithm \Log(U) such that \exp(\Log(U)) = U. The principal branch of this logarithm is uniquely defined as the one whose eigenvalues lie in the open horizontal strip \{ z \in \mathbb{C} : -\pi < \Im(z) \leq \pi \}, ensuring the eigenvalues of \Log(U) are purely imaginary within i(-\pi, \pi]. Since skew-Hermitian matrices are and thus unitarily diagonalizable, the exponential can be computed efficiently via : if S = V D V^\dagger with V unitary and D diagonal containing purely imaginary entries, then \exp(S) = V \exp(D) V^\dagger, where \exp(D) applies the scalar exponential entrywise. This method leverages the unitary diagonalization property of skew-Hermitian matrices.

Applications

Lie Groups and Algebras

The set of all n \times n skew-Hermitian matrices over the complex numbers forms the Lie algebra \mathfrak{u}(n) of the U(n), where the Lie bracket is the [A, B] = AB - BA. This structure bridges linear algebra with , as \mathfrak{u}(n) consists precisely of the tangent vectors at the of U(n), which is the of all n \times n unitary matrices preserving the standard inner product on \mathbb{C}^n. The real dimension of \mathfrak{u}(n) is n^2, arising from the fact that a basis for \mathfrak{u}(n) can be constructed as i times a basis for the real of n \times n Hermitian matrices, which also has n^2. The subalgebra \mathfrak{su}(n) of traceless skew-Hermitian matrices is the of the SU(n), the of the map U(n) \to S^1, and possesses real n^2 - 1. The of U(n) on \mathfrak{u}(n) is realized by conjugation: for U \in U(n) and A \in \mathfrak{u}(n), \mathrm{Ad}_U(A) = U A U^{-1}, preserving the bracket and thus the structure. The \exp: \mathfrak{u}(n) \to U(n), given by the matrix exponential series, induces a near the zero element, mapping \mathfrak{u}(n) onto U(n) and reflecting the covering of the group by its in the infinitesimal sense.

Physics and Engineering

In , skew-Hermitian matrices play a fundamental role in describing the of quantum states. The time evolution U(t) = \exp\left( -\frac{i H t}{\hbar} \right), where H is the Hermitian representing the system's energy, generates unitary dynamics that preserve the norm of the . Here, the argument K = -\frac{i H t}{\hbar} is skew-Hermitian, as its eigenvalues are purely imaginary, ensuring that U(t) remains unitary and the evolution is reversible. This structure underpins the i \hbar \frac{d}{dt} |\psi(t)\rangle = H |\psi(t)\rangle, where the skew-Hermitian generator maintains probability conservation. In quantum computing, skew-Hermitian matrices appear as generators in variational quantum algorithms (VQAs) and techniques. For instance, in the (VQE), the ansatz circuits are constructed from exponentials of skew-Hermitian operators derived from Hermitian Pauli strings, enabling optimization over unitary transformations to approximate ground states of complex Hamiltonians. Similarly, the approximates the exponential of a sum of skew-Hermitian terms for efficient of on near-term devices, reducing circuit depth while preserving unitarity. These methods leverage the skew-Hermitian property to ensure faithful representation of quantum evolutions in noisy intermediate-scale quantum hardware. Skew-Hermitian matrices are integral to applications, particularly in the design of paraunitary for perfect reconstruction. Paraunitary systems, which maintain energy preservation across subbands, are constructed via the that maps para-skew-Hermitian matrices to paraunitary ones, converting nonlinear constraints into linear equations for easier optimization. The of a skew-Hermitian matrix \exp(S), being unitary, ensures that the polyphase matrix satisfies the paraunitary condition P(z) \tilde{P}(z) = I, enabling lossless decomposition in applications like and audio coding. This approach simplifies the synthesis of compactly supported orthogonal wavelets with desirable frequency selectivity. In numerical methods for optimization, skew-Hermitian approximations facilitate gradient flows on unitary manifolds, which are prevalent in tasks with orthogonal constraints. The to the consists of skew-Hermitian matrices, allowing Riemannian to project updates onto this space for maintaining unitarity during training of recurrent neural networks or parameters. For example, in optimizing over the , the skew-Hermitian component of the is extracted to define the Riemannian , enabling convergence to local minima while avoiding manifold violations. This is particularly effective in , where it approximates complex evolutions with reduced computational overhead.

References

  1. [1]
    [PDF] The Matrix Cookbook
    Nov 15, 2012 · A matrix A is called skew-hermitian if. A = −AH. For real valued matrices, skew-Hermitian and skew-symmetric matrices are equivalent. A ...<|control11|><|separator|>
  2. [2]
    [PDF] Lecture Notes for Math 623 Matrix Analysis - Michael O'Sullivan
    Apr 18, 2013 · The diagonal entries of a skew-Hermitian matrix must be purely imaginary. (3) The set of Hermitian matrices is closed under addition and scalar.
  3. [3]
    [PDF] 8.7 Complex Matrices
    Jul 8, 2020 · If B is skew-hermitian, show that the eigenvalues of B are pure imaginary (iλ for real λ). d. Show that every n × n complex matrix Z can be.
  4. [4]
    [PDF] 7 Spectral Properties of Matrices
    (Spectral Theorem for Hermitian Matrices) If the matrix A ∈ Cn×n is Hermitian or skew-Hermitian, A can be written as. A = UDUH, where U is a unitary matrix and ...
  5. [5]
    [PDF] Complex inner products (6.7 supplement) - UMD MATH
    Examples of normal matrices are Hermitian matrices (A = A∗), skew Hermitian matrices (A = −A∗) and unitary matrices (A∗ = A−1) so all such matrices are ...
  6. [6]
    Adjoint -- from Wolfram MathWorld
    ### Definition and Formula for the Adjoint (Conjugate Transpose) of a Matrix
  7. [7]
    Antihermitian Matrix -- from Wolfram MathWorld
    Antihermitian matrices are often called "skew Hermitian matrices" by mathematicians. ... See also. Adjoint, Antisymmetric Part, Hermitian Matrix, Unitary Matrix.
  8. [8]
    Hermitian Matrix -- from Wolfram MathWorld
    ### Definition of Hermitian Matrix
  9. [9]
    [PDF] Symmetric and self-adjoint matrices - University of Waterloo
    that A is hermitian if and only if (Ax, y) = (x, Ay) for each x, y in Cn ... If B ∈ Mn(C) with B∗ = −B we can B skew-hermitian. Notice that iB ...
  10. [10]
    Two projection methods for Skew-Hermitian operator equations
    In this paper we present a projection method for solving operator equations with bounded operator in Hilbert spaces.
  11. [11]
    [PDF] Representations of Matrix Lie Algebras - UChicago Math
    In other words, the tangent space of. SU(n) at the identity is the space of n×n traceless skew-Hermitian matrices. 2.5 The Lie Bracket. If the tangent space L(G) ...
  12. [12]
    [PDF] Study on Hermitian, Skew-Hermitian and Uunitary Matrices as a part ...
    It is also true that every real skew matrix is a real normal square root of a negative definite or semi definite, real symmetric matrix, whose non-zero ...
  13. [13]
  14. [14]
    skew-Hermitian matrix - PlanetMath
    Mar 22, 2013 · Proof. Property (1) follows directly from property (2) since the trace is the sum of the eigenvalues. But one can also give a simple proof ...Missing: purely | Show results with:purely
  15. [15]
    [PDF] The Matrix Cookbook
    Nov 15, 2012 · Horn and Charles R. Johnson. Matrix Analysis. Cambridge. University Press, 1985. [16] Mardia K. V., J.T. Kent and J.M. Bibby, Multivariate ...
  16. [16]
    None
    ### Summary of Skew-Hermitian Matrices, Normality, Eigenvalues, Diagonalization, and Jordan Form from https://www.math.ubc.ca/~carrell/307_chap10.pdf
  17. [17]
    Normal matrix - StatLect
    A matrix is normal if and only if either pre-multiplying or post-multiplying it by its conjugate transpose gives the same result.
  18. [18]
    [PDF] Unitary Diagonalization of Matrices - UMD MATH
    Consequently, A is normal. Examples of normal matrices are Hermitian matrices (A = A∗), skew Hermitian matrices (A = −A∗) and unitary matrices (A∗ = A−1) so ...
  19. [19]
    None
    Below is a merged summary of skew-Hermitian matrices from *Matrix Analysis* (2nd Edition) by Roger A. Horn, consolidating all information from the provided segments into a comprehensive response. To maximize detail and clarity, I will use a structured format with tables where appropriate, followed by a narrative summary for additional context. The response retains all definitions, properties, examples, page references, and URLs mentioned across the segments.
  20. [20]
    [PDF] Representations of su(2) 1 Lie and linear groups
    hence the Lie algebra su(2) of SU(2) consists of all traceless two-by-two skew-hermitian matrices: su(2) = {X ∈ Mat(2, C) : X = −X†, tr X = 0}. A basis for ...
  21. [21]
    [2312.14330] Random anti-commuting Hermitian matrices - arXiv
    Dec 21, 2023 · Abstract:We consider pairs of anti-commuting 2p-by-2p Hermitian matrices that are chosen randomly with respect to a Gaussian measure.Missing: generation | Show results with:generation
  22. [22]
    [PDF] REAL DIMENSION OF THE LIE ALGEBRA OF S-SKEW-HERMITIAN ...
    May 29, 2020 · A matrix A ∈ Mn(C) is said to be S-skew-Hermitian if SA∗ = −AS where A∗ is the conjugate transpose of A. The set uS of all S-skew-Hermitian.
  23. [23]
    [PDF] Lie Algebras: Definition and Basic Properties
    The associative algebra Fn of n×n matrices can therefore be given a Lie algebra ... of skew-Hermitian matrices. Intersecting this with sl (n, C), we get the Lie.
  24. [24]
    [PDF] Comments on Problem Set 2
    Mar 6, 2002 · The Lie algebra su(n) is the set of skew–Hermitian matrices of trace 0, which also has dimension n2 − 1: a skew–Hermitian matrix must have ...
  25. [25]
    [PDF] The Exponential Map, Lie Groups, and Lie Algebras - UPenn CIS
    In the complex case, the Lie algebras gl(n,C) is the set of all complex n×n matrices, but u(n) 6= su(n), because a skew Hermitian matrix does not necessarily.
  26. [26]
    [PDF] Representation theory and quantum mechanics tutorial Some linear ...
    ... space V injects into a canonical Hilbert space ... 1.2 Let Ж1 and Ж2 be Hilbert spaces and A : Ж1 → Ж2 a C-linear map. ... Prove that for A a skew-Hermitian ...
  27. [27]
    Introducing (dynamical) Lie algebras for quantum practitioners
    Feb 26, 2024 · One very relevant Lie algebra for us is the special unitary algebra su ( N ) , the space of N × N skew-Hermitian matrices with trace zero. The ...Introduction · Lie algebras · Relation to Lie groups · Hamiltonian Symmetries
  28. [28]
    A Trotter-Suzuki approximation for Lie groups with applications to ...
    Jun 1, 2016 · We present a product formula to approximate the exponential of a skew-Hermitian operator that is a sum of generators of a Lie algebra.
  29. [29]
    [PDF] notice - NASA Technical Reports Server (NTRS)
    All of the eigenvalues of a skew-hermitian matrix are purely imaginary ... Kalman filter loop transfer matrices respectively given previously in. (20) ...
  30. [30]
    Hermitian and Skew-Hermitian Splitting Methods for Non ... - SIAM.org
    We study efficient iterative methods for the large sparse non-Hermitian positive definite system of linear equations based on the Hermitian and skew-Hermitian ...
  31. [31]
    [PDF] Multidimensional Orthogonal Filter Bank Characterization and ...
    Para-skew-Hermitian matrices are skew-Hermitian on the unit circle. Para-skew-Hermitian matrices. Paraunitary matrices. Orthogonal. Filter Banks. Cayley.
  32. [32]
    Multidimensional orthogonal filter bank characterization and design ...
    In contrast to the paraunitary condition, the para-skew-Hermitian condition amounts to linear constraints on the matrix entries which are much easier to solve.
  33. [33]
    [PDF] Optimizing quantum circuits with Riemannian gradient flow - arXiv
    Riemannian gradient flow optimizes quantum circuits by using a Riemannian optimization scheme over the special unitary group, with favorable properties for  ...
  34. [34]
    [PDF] Conjugate gradient algorithm for optimization under unitary matrix ...
    Mar 24, 2009 · This paper introduces a conjugate gradient algorithm on the Lie group of unitary matrices to minimize a function under the constraint that the ...