Skip to main content
Entropy logoLink to Entropy
. 2020 Sep 12;22(9):1019. doi: 10.3390/e22091019

The Siegel–Klein Disk: Hilbert Geometry of the Siegel Disk Domain

Frank Nielsen 1
PMCID: PMC7597112  PMID: 33286788

Abstract

We study the Hilbert geometry induced by the Siegel disk domain, an open-bounded convex set of complex square matrices of operator norm strictly less than one. This Hilbert geometry yields a generalization of the Klein disk model of hyperbolic geometry, henceforth called the Siegel–Klein disk model to differentiate it from the classical Siegel upper plane and disk domains. In the Siegel–Klein disk, geodesics are by construction always unique and Euclidean straight, allowing one to design efficient geometric algorithms and data structures from computational geometry. For example, we show how to approximate the smallest enclosing ball of a set of complex square matrices in the Siegel disk domains: We compare two generalizations of the iterative core-set algorithm of Badoiu and Clarkson (BC) in the Siegel–Poincaré disk and in the Siegel–Klein disk: We demonstrate that geometric computing in the Siegel–Klein disk allows one (i) to bypass the time-costly recentering operations to the disk origin required at each iteration of the BC algorithm in the Siegel–Poincaré disk model, and (ii) to approximate fast and numerically the Siegel–Klein distance with guaranteed lower and upper bounds derived from nested Hilbert geometries.

Keywords: hyperbolic geometry, symmetric positive-definite matrix manifold, symplectic group, Siegel upper space domain, Siegel disk domain, Hilbert geometry, Bruhat–Tits space, smallest enclosing ball

1. Introduction

German mathematician Carl Ludwig Siegel [1] (1896–1981) and Chinese mathematician Loo-Keng Hua [2] (1910–1985) have introduced independently the symplectic geometry in the 1940s (with a preliminary work of Siegel [3] released in German in 1939). The adjective symplectic stems from the Greek, and means “complex”: That is, mathematically the number field C instead of the ordinary real field R. Symplectic geometry was originally motivated by the study of complex multivariate functions in the two landmark papers of Siegel [1] and Hua [2]. As we shall see soon, the naming “symplectic geometry” for the geometry of complex matrices originally stems from the relationships with the symplectic groups (and their matrix representations). Presently, symplectic geometry is mainly understood as the study of symplectic manifolds [4] which are even-dimensional differentiable manifolds equipped with a closed and nondegenerate differential 2-form ω, called the symplectic form, studied in geometric mechanics.

We refer the reader to the PhD thesis [5,6] for an overview of Siegel bounded domains. More generally, the Siegel-like bounded domains have been studied and classified into 6 types in the most general setting of bounded symmetric irreducible homogeneous domains by Elie Cartan [7] in 1935 (see also [8,9]).

The Siegel upper space and the Siegel disk domains provide generalizations of the complex Poincaré upper plane and the complex Poincaré disk to spaces of symmetric square complex matrices. In the remainder, we shall term them the Siegel–Poincaré upper plane and the Siegel–Poincaré disk. The Siegel upper space includes the well-studied cone of real symmetric positive-definite (SPD) matrices [10] (SPD manifold). The celebrated affine-invariant SPD Riemannian metric [11] can be recovered as a special case of the Siegel metric.

Applications of the geometry of Siegel upper/disk domains are found in radar processing [12,13,14,15] especially for dealing with Toepliz matrices [16,17], probability density estimations [18] and probability metric distances [19,20,21,22], information fusion [23], neural networks [24], theoretical physics [25,26,27], and image morphology operators [28], just to cite a few.

In this paper, we extend the Klein disk model [29] of the hyperbolic geometry to the Siegel disk domain by considering the Hilbert geometry [30] induced by the open-bounded convex Siegel disk [31,32]. We call the Hilbert metric distance of the Siegel disk the Siegel–Klein distance. We term this model the Klein-Siegel model for short to contrast it with the Poincaré-Siegel upper plane model and the Poincaré-Siegel disk model. The main advantages of using the Klein-Siegel disk model instead of the usual Siegel–Poincaré upper plane or the Siegel–Poincaré disk are that the geodesics are unique and always straight by construction. Thus, this Siegel–Klein disk model is very well-suited for designing efficient algorithms and data structures by borrowing techniques of Euclidean computational geometry [33]. Moreover, in the Siegel–Klein disk model, we have an efficient and robust method to approximate with guarantees the calculation of the Siegel–Klein distance: This is especially useful when handling high-dimensional square complex matrices. The algorithmic advantage of the Hilbert geometry was already observed for real hyperbolic geometry (included as a special case of the Siegel–Klein model): For example, the hyperbolic Voronoi diagrams can be efficiently computed as an affine power diagram clipped to the boundary circle [34,35,36,37]. To demonstrate the advantage of the Siegel–Klein disk model (Hilbert distance) over the Siegel–Poincaré disk model (Kobayashi distance), we consider approximating the Smallest Enclosing Ball (SEB) of the a set of square complex matrices in the Siegel disk domain. This problem finds potential applications in image morphology [28,38] or anomaly detection of covariance matrices [39,40]. Let us state the problem as follows:

Problem 1 (Smallest Enclosing Ball (SEB)). 

Given a metric space (X,ρ) and a finite set {p1,,pn} of n points in X, find the smallest-radius enclosing ball with circumcenter c* minimizing the following objective function:

mincXmaxi{1,,n}ρ(c,pi). (1)

In general, the SEBs may not be unique in a metric space: For example, the SEBs are not unique in a discrete Hamming metric space [41] making it notably NP-hard to calculate. We note in passing that the set-complement of a Hamming ball is a Hamming ball in a Hamming metric space. However, the SEB is proven unique in the Euclidean geometry [42], the hyperbolic geometry [43], the Riemannian positive-definite matrix manifold [44,45], and more generally in any Cartan-Hadamard manifold [46] (Riemannian manifold that is complete and simply connected with non-positive sectional curvatures). The SEB is guaranteed to be unique in any Bruhat–Tits space [44] (i.e., complete metric space with a semi-parallelogram law) which includes the Riemannian SPD manifold.

A fast (1+ϵ)-approximation algorithm which requires 1ϵ2 iterations was reported in [46,47] to approximate the SEB in the Euclidean space: That is a covering ball of radius (1+ϵ)r* where r*=maxi{1,,n}ρ(c*,pi) for c*=argmincXmaxi{1,,n}ρ(c,pi). Since the approximation factor does not depend on the dimension, this SEB approximation algorithm found many applications in machine learning [48] (e.g., in  Reproducing Kernel Hilbert Spaces [49], RKHS).

1.1. Paper Outline and Contributions

In Section 2, we concisely recall the usual models of the hyperbolic complex plane: The Poincaré upper plane model, and the Poincaré disk model, and the Klein disk model. We then briefly review the geometry of the Siegel upper plane domain in Section 3 and the Siegel disk domain in Section 4. Section 5 introduces the novel Siegel–Klein model using the Hilbert geometry and its Siegel–Klein distance. To demonstrate the algorithmic advantage of using the Siegel–Klein disk model over the Siegel–Poincaré disk model in practice, we compare in Section 6 the two implementations of the Badoiu and Clarkson’s SEB approximation algorithm [47] in these models. Finally, we conclude this work in Section 7. In the Appendix, we first list the notations used in this work, recall the deflation method for calculating numerically the eigenvalues of a Hermitian matrix (Appendix A), and provide some basic snippet code for calculating the Siegel distance (Appendix A).

Our main contributions are summarized as follows:

  • First, we formulate a generalization of the Klein disk model of hyperbolic geometry to the Siegel disk domain in Definition 2 using the framework of Hilbert geometry. We report the formula of the Siegel–Klein distance to the origin in Theorem 1 (and more generally a closed-form expression for the Siegel–Klein distance between two points whose supporting line passes through the origin), describe how to convert the Siegel–Poincaré disk to the Siegel–Klein disk and vice versa in Proposition 2, report an exact algorithm to calculate the Siegel–Klein distance for diagonal matrices in Theorem 4. In practice, we show how to obtain a fast guaranteed approximation of the Siegel–Klein distance using geodesic bisection searches with guaranteed lower and upper bounds (Theorem 5 whose proof is obtained by considering nested Hilbert geometries).

  • Second, we report the exact solution to a geodesic cut problem in the Siegel–Poincaré/Siegel–Klein disks in Proposition 3. This result yields an explicit equation for the geodesic linking the origin of the Siegel disk domain to any other matrix point of the Siegel disk domain (Propositions 3 and 4). We then report an implementation of the Badoiu and Clarkson’s iterative algorithm [47] for approximating the smallest enclosing ball tailored to the Siegel–Poincaré and Siegel–Klein disk domains. In particular, we show in §6 that the implementation in the Siegel–Klein model yields a fast algorithm which bypasses the costly operations of recentering to the origin required in the Siegel–Poincaré disk model.

Let us now introduce a few notations on matrices and their norms.

1.2. Matrix Spaces and Matrix Norms

Let F be a number field considered in the remainder to be either the real number field R or the complex number field C. For a complex number z=a+ibC (with imaginary number i2=1), we denote by z¯=aib its complex conjugate, and  by |z|=zz¯=a2+b2 its modulus. Let Re(z)=a and Im(z)=b denote the real part and the imaginary part of the complex number z=a+ib, respectively.

Let M(d,F) be the space of d×d square matrices with coefficients in F, and let GL(d,F) denote its subspace of invertible matrices. Let Sym(d,F) denote the vector space of d×d symmetric matrices with coefficients in F. The identity matrix is denoted by I (or Id when we want to emphasize its d×d dimension). The conjugate of a matrix M=[Mi,j]i,j is the matrix of complex conjugates: M¯:=[M¯i,j]i,j. The conjugate transpose of a matrix M is MH=(M¯)=M¯, the adjoint matrix. Conjugate transposition is also denoted by the star operator (i.e., M*) or the dagger symbol (i.e., M) in the literature. A complex matrix is said Hermitian when MH=M (hence M has real diagonal elements). For any MM(d,C), Matrix MMH is Hermitian: (MMH)H=(MH)H(M)H=MMH.

A real matrix MM(d,R) is said symmetric positive-definite (SPD) if and only if xMx>0 for all xRd with x0. This positive-definiteness property is written M0, where ≻ denotes the partial Löwner ordering [50]. Let PD(d,R)={P0:PSym(d,R)} be the space of real symmetric positive-definite matrices [10,44,51,52] of dimension d×d. This space is not a vector space but a cone, i.e., if P1,P2PD(d,R) then P1+λP2PD(d,R) for all λ>0. The boundary of the cone consists of rank-deficient symmetric positive semi-definite matrices.

The (complex/real) eigenvalues of a square complex matrix M are ordered such that |λ1(M)||λd(M)|, where |·| denotes the complex modulus. The spectrum λ(M) of a matrix M is its set of eigenvalues: λ(M)={λ1(M),,λd(M)}. In general, real matrices may have complex eigenvalues but symmetric matrices (including SPD matrices) have always real eigenvalues. The singular values σi(M) of M are always real:

σi(M)=λi(MM¯)=λi(M¯M), (2)

and ordered as follows: σ1(M)σd(M) with σmax(M)=σ1(M) and σmin(M)=σd(M). We have σdi+1(M1)=1σi(M), and in particular σd(M1)=1σ1(M).

Any matrix norm · (including the operator norm) satisfies:

  • M0 with equality if and only if M=0 (where 0 denotes the matrix with all its entries equal to zero),

  • αM=|α|M,

  • M1+M2M1+M2, and 

  • M1M2M1M2.

Let us define two usual matrix norms: The Fröbenius norm and the operator norm. The Fröbenius norm of M is:

MF:=i,j|Mi,j|2, (3)
=tr(MMH)=tr(MHM). (4)

The induced Fröbenius distance between two complex matrices C1 and C2 is ρE(C1,C2)=C1C2F.

The operator norm or spectral norm of a matrix M is:

MO=maxx0Mx2x2, (5)
=λmax(MHM), (6)
=σmax(M). (7)

Notice that MHM is a Hermitian positive semi-definite matrix. The operator norm coincides with the spectral radius ρ(M)=maxi{|λi(M)|} of the matrix M and is upper bounded by the Fröbenius norm: MOMF, and we have MOmaxi,j|Mi,j|. When the dimension d=1, the operator norm of [M] coincides with the complex modulus: MO=|M|.

To calculate the largest singular value σmax, we may use a the (normalized) power method [53,54] which has quadratic convergence for Hermitian matrices (see Appendix A). We can also use the more costly Singular Value Decomposition (SVD) of M which requires cubic time: M=UDVH where D=Diag(σ1,,σd) is the diagonal matrix with coefficients being the singular values of M.

2. Hyperbolic Geometry in the Complex Plane: The Poincaré Upper Plane and Disk Models and the Klein Disk Model

We concisely review the three usual models of the hyperbolic plane [55,56]: Poincaré upper plane model in Section 2.1, the Poincaré disk model in Section 2.2, and the Klein disk model in Section 2.2.1. We then report distance expressions in these models and conversions between these three usual models in Section 2.3. Finally, in Section 2.4, we recall the important role of hyperbolic geometry in the Fisher–Rao geometry in information geometry [57,58].

2.1. Poincaré Complex Upper Plane

The Poincaré upper plane domain is defined by

H=z=a+ib:zC,b=Im(z)>0. (8)

The Hermitian metric tensor is:

dsU2=dzdz¯Im(z)2, (9)

or equivalently the Riemannian line element is:

dsU2=dx2+dy2y2, (10)

Geodesics between z1 and z2 are either arcs of semi-circles whose centers are located on the real axis and orthogonal to the real axis, or vertical line segments when Re(z1)=Re(z2).

The geodesic length distance is

ρU(z1,z2):=log|z1z¯2|+|z1z2||z1z¯2||z1z2|, (11)

or equivalently

ρU(z1,z2)=arccosh|z1z¯2|2Im(z1)Im(z2), (12)

where

arccosh(x)=logx+x21,x1. (13)

Equivalent formula can be obtained by using the following identity:

log(x)=arcoshx2+12x=artanhx21x2+1, (14)

where

artanh(x)=12log1+x1x,x<1. (15)

By interpreting a complex number z=x+iy as a 2D point with Cartesian coordinates (x,y), the metric can be rewritten as

dsU2=dx2+dy2y2=1y2dsE2, (16)

where dsE2=dx2+dy2 is the Euclidean (flat) metric. That is, the Poincaré upper plane metric dsU can be rewritten as a conformal factor 1y times the Euclidean metric dsE. Thus, the metric of Equation (16) shows that the Poincaré upper plane model is a conformal model of hyperbolic geometry: That is, the Euclidean angle measurements in the (x,y) chart coincide with the underlying hyperbolic angles.

The group of orientation-preserving isometries (i.e., without reflections) is the real projective special group PSL(2,R)=SL(2,R)/{±I} (quotient group), where SL(2,R) denotes the special linear group of matrices with unit determinant:

Isom+(H)PSL(2,R). (17)

The left group action is a fractional linear transformation (also called a Möbius transformation):

g.z=az+bcz+d,g=abcd,adbc0. (18)

The condition abcd0 is to ensure that the Möbius transformation is not constant. The set of Möbius transformations form a group Moeb(R,2). The elements of the Möbius group can be represented by corresponding 2×2 matrices of PSL(2,R):

abcd,adbc0. (19)

The neutral element e is encoded by the identity matrix I.

The fractional linear transformations

w(z)=az+bcz+d,a,b,c,dR,adbc0 (20)

are the analytic mappings C{}C{} of the Poincaré upper plane onto itself.

The group action is transitive (i.e., z1,z2H,g such that g.z1=z2) and faithful (i.e., if g.z=zz then g=e). The stabilizer of i is the rotation group:

SO(2)=cosθsinθsinθcosθ:θR. (21)

The unit speed geodesic anchored at i and going upward (i.e., geodesic with initial condition) is:

γ(t)=et/200et/2×i=iet. (22)

Since the other geodesics can be obtained by the action of PSL(2,R), it follows that the geodesics in H are parameterized by:

γ(t)=aiet+bciet+d. (23)

2.2. Poincaré Disk

The Poincaré unit disk is

D=w¯w<1:wC. (24)

The Riemannian Poincaré line element (also called Poincaré-Bergman line element) is

dsD2=4dwdw¯(1|w|2)2. (25)

Since dsD2=21x22dsE2, we deduce that the metric is conformal: The Poincaré disk is a conformal model of hyperbolic geometry. The geodesic between points w1 and w2 are either arcs of circles intersecting orthogonally the disk boundary D, or straight lines passing through the origin 0 of the disk and clipped to the disk domain.

The geodesic distance in the Poincaré disk is

ρD(w1,w2)=arccosh|w1w¯21|2(1|w1|2)(1|w2|2), (26)
=2arctanhw2w11w¯1w2. (27)

The group of orientation-preserving isometry is the complex projective special group PSL(2,C)=SL(2,C)/{±I} where SL(2,C) denotes the special group of 2×2 complex matrices with unit determinant.

In the Poincaré disk model, the transformation

Tz0,θ(z)=eiθzz01z¯0z (28)

corresponds to a hyperbolic motion (a Möbius transformation [59]) which moves point z0 to the origin 0, and then makes a rotation of angle θ. The group of such transformations is the automorphism group of the disk, Aut(D), and the transformation Tz0,θ is called a biholomorphic automorphism (i.e., a one-to-one conformal mapping of the disk onto itself).

The Poincaré distance is invariant under automorphisms of the disk, and more generally the Poincaré distance decreases under holomorphic mappings (Schwarz–Pick theorem): That is, the Poincaré distance is contractible under holomorphic mappings f: ρD(f(w1),f(w2))ρD(w1,w2).

2.2.1. Klein Disk

The Klein disk model [29,55] (also called the Klein-Beltrami model) is defined on the unit disk domain as the Poincaré disk model. The Klein metric is

dsK2=dsE21xE2+x,dxE1xE22. (29)

It is not a conformal metric (except at the disk origin), and therefore the Euclidean angles in the (x,y) chart do not correspond to the underlying hyperbolic angles.

The Klein distance between two points k1=(x1,y1) and k2=(x2,y2) is

ρK(k1,k2)=arccosh1(x1x2+y1y2)(1k12)(1k22). (30)

An equivalent formula shall be reported later in page 24 in a more setting of Theorem 4.

The advantage of the Klein disk over the Poincaré disk is that geodesics are straight Euclidean lines clipped to the unit disk domain. Therefore, this model is well-suited to implement computational geometric algorithms and data structures, see for example [34,60]. The group of isometries in the Klein model are projective maps RP2 preserving the disk. We shall see that the Klein disk model corresponds to the Hilbert geometry of the unit disk.

2.3. Poincaré and Klein Distances to the Disk Origin and Conversions

In the Poincaré disk, the distance of a point w to the origin 0 is

ρD(0,w)=log1+|w|1|w|. (31)

Since the Poincaré disk model is conformal (and Möbius transformations are conformal maps), Equation (31) shows that Poincaré disks have Euclidean disk shapes (however with displaced centers).

In the Klein disk, the distance of a point k to the origin is

ρK(0,k)=12log1+|k|1|k|=12ρD(0,k). (32)

Observe the multiplicative factor of 12 in Equation (32).

Thus, we can easily convert a point wC in the Poincaré disk to a point kC in the Klein disk, and vice versa as follows:

w=11+1|k|2k, (33)
k=21+|w|2w. (34)

Let CKD(k) and CDK(w) denote these conversion functions with

CKD(k)=11+1|k|2k, (35)
CDK(w)=21+|w|2w. (36)

We can write CKD(k)=α(k)k and CDK(w)=β(w)w, so that α(k)>1 is an expansion factor, and β(w)<1 is a contraction factor.

The conversion functions are Möbius transformations represented by the following matrices:

MKD(k)=α(k)001, (37)
MDK(w)=β(w)001. (38)

For sanity check, let w=r+0i be a point in the Poincaré disk with equivalent point k=21+r2r+0i in the Klein disk. Then we have:

ρK(0,k)=12log1+|k|1|k|, (39)
=12log1+21+r2r121+r2r, (40)
=12log1+r2+2r1+r22r, (41)
=12log(1+r)2(1r)2, (42)
=log1+r1r=ρD(0,w). (43)

We can convert a point z in the Poincaré upper plane to a corresponding point w in the Poincaré disk, or vice versa, using the following Möbius transformations:

w=ziz+i, (44)
z=i1+w1w. (45)

Notice that we compose Möbius transformations by multiplying their matrix representations.

2.4. Hyperbolic Fisher–Rao Geometry of Location-Scale Families

Consider a parametric family P={pθ(x)}θΘ of probability densities dominated by a positive measure μ (usually, the Lebesgue measure or the counting measure) defined on a measurable space (X,Σ), where X denotes the support of the densities and Σ is a finite σ-algebra [57]. Hotelling [61] and Rao [62] independently considered the Riemannian geometry of P by using the Fisher Information Matrix (FIM) to define the Riemannian metric tensor [63] expressed in the (local) coordinates θΘ, where Θ denotes the parameter space. The FIM is defined by the following symmetric positive semi-definite matrix [57,64]:

I(θ)=Epθθlogpθ(x)θlogpθ(x). (46)

When P is regular [57], the FIM is guaranteed to be positive-definite, and can thus play the role of a metric tensor field: The so-called Fisher metric.

Consider the location-scale family induced by a density f(x) symmetric with respect to 0 such that Xf(x)dμ(x)=1, Xxf(x)dμ(x)=0 and Xx2f(x)dμ(x)=1 (with X=R):

P=pθ(x)=1θ2fxθ1θ2,θ=(θ1,θ2)R×R++. (47)

The density f(x) is called the standard density, and corresponds to the parameter (0,1): p(0,1)(x)=f(x). The parameter space Θ=R×R++ is the upper plane, and the FIM can be structurally calculated [65] as the following diagonal matrix:

I(θ)=a200b2 (48)

with

a2:=f(x)f(x)2f(x)dμ(x), (49)
b2:=xf(x)f(x)+12f(x)dμ(x). (50)

By rescaling θ=(θ1,θ2) as θ=(θ1,θ2) with θ1=ab2θ1 and θ2=θ2, we get the FIM with respect to θ expressed as:

I(θ)=b2θ221001, (51)

a constant time the Poincaré metric in the upper plane. Thus, the Fisher–Rao manifold of a location-scale family (with symmetric standard density f) is isometric to the planar hyperbolic space of negative curvature κ=1b2.

3. The Siegel Upper Space and the Siegel Distance

The Siegel upper space [1,3,5,66] SH(d) is defined as the space of symmetric complex square matrices of size d×d which have positive-definite imaginary part:

SH(d):=Z=X+iY:XSym(d,R),YPD(d,R). (52)

The space SH(d) is a tube domain of dimension d(d+1) since

dim(SH(d))=dim(Sym(d,R))+dim(PD(d,R)), (53)

with dim(Sym(d,R))=d(d+1)2 and dim(PD(d,R))=d(d+1)2. We can extract the components X and Y from Z as X=12(Z+Z¯) and Y=12i(ZZ¯)=i2(ZZ¯). The matrix pair (X,Y) belongs to the Cartesian product of a matrix-vector space with the symmetric positive-definite (SPD) matrix cone: (X,Y)Sym(d,R)×PD(d,R). When d=1, the Siegel upper space coincides with the Poincaré upper plane: SH(1)=H. The geometry of the Siegel upper space was studied independently by Siegel [1] and Hua [2] from different viewpoints in the late 1930s–1940s. Historically, these classes of complex matrices ZSH(d) were first studied by Riemann [67], and later eponymously called Riemann matrices. Riemann matrices are used to define Riemann theta functions [68,69,70,71].

The Siegel distance in the upper plane is induced by the following line element:

dsU2(Z)=2trY1dZY1dZ¯. (54)

The formula for the Siegel upper distance between Z1 and Z2SH(d) was calculated in Siegel’s masterpiece paper [1] as follows:

ρU(Z1,Z2)=i=1dlog21+ri1ri, (55)

where

ri=λiR(Z1,Z2), (56)

with R(Z1,Z2) denoting the matrix generalization [72] of the cross-ratio:

R(Z1,Z2):=(Z1Z2)(Z1Z¯2)1(Z¯1Z¯2)(Z¯1Z2)1, (57)

and λi(M) denotes the i-th largest (real) eigenvalue of (complex) matrix M. The letter notation ‘R’ in R(Z1,Z2) is a mnemonic which stands for ‘r’atio.

The Siegel distance can also be expressed without explicitly using the eigenvalues as:

ρU(Z1,Z2)=2trR12i=0R12i2i+12, (58)

where R12=R(Z1,Z2). In particular, we can truncate the matrix power series of Equation (58) to get an approximation of the Siegel distance:

ρ˜U,l(Z1,Z2)=2trR12i=0lR12i2i+12. (59)

It costs O(Spectrum(d))=O(d3) to calculate the Siegel distance using Equation (55) and O(lMult(d))=O(ld2.3737) to approximate it using the truncated series formula of Equation (59), where Spectrum(d) denotes the cost of performing the spectral decomposition of a d×d complex matrix, and Mult(d) denotes the cost of multiplying two d×d square complex matrices. For example, choosing the Coppersmith-Winograd algorithm for d×d matrix multiplications, we have Mult(d)=O(d2.3737). Although Siegel distance formula of Equation (59) is attractive, the number of iterations l to get an ϵ-approximation of the Siegel distance depends on the dimension d. In practice, we can define a threshold δ > 0, and as a rule of thumb iterate on the truncated sum until trR12i2i+1<δ.

A spectral function [52] of a matrix M is a function F which is the composition of a symmetric function f with the eigenvalue map Λ: F(M):=(fΛ)(M)=f(Λ(M)). For example, the Kullback–Leibler divergence between two zero-centered Gaussian distributions is a spectral function distance since we have:

DKL(pΣ1,pΣ2)=pΣ1(x)logpΣ1(x)pΣ2(x)dx, (60)
=12log|Σ2||Σ1|+tr(Σ21Σ1)d, (61)
=12i=1dlogλi(Σ2)λi(Σ1)+λi(Σ21Σ1)d, (62)
=12i=1dλi(Σ21Σ1)logλi(Σ21Σ1)1, (63)
=(fKLΛ)(Σ21Σ1), (64)

where |Σ| and λi(Σ) denotes respectively the determinant of a positive-definite matrix Σ0, and the i-the real largest eigenvalue of Σ, and 

pΣ(x)=1(2π)d|Σ|exp12xΣ1x (65)

is the density of the multivariate zero-centered Gaussian of covariance matrix Σ,

fKL(u1,,ud)=12i=1d(ui1logui), (66)

is a symmetric function invariant under parameter permutations, and Λ(·) denotes the eigenvalue map.

This Siegel distance in the upper plane is also a smooth spectral distance function since we have

ρU(Z1,Z2)=fΛ(R(Z1,Z2)), (67)

where f is the following symmetric function:

f(x1,,xd)=i=1dlog21+xi1xi. (68)

A remarkable property is that all eigenvalues of R(Z1,Z2) are positive (see [1]) although R may not necessarily be a Hermitian matrix. In practice, when calculating numerically the eigenvalues of the complex matrix R(Z1,Z2), we  obtain very small imaginary parts which shall be rounded to zero. Thus, calculating the Siegel distance on the upper plane requires cubic time, i.e., the cost of computing the eigenvalue decomposition.

This Siegel distance in the upper plane SH(d) generalizes several well-known distances:

  • When Z1=iY1 and Z2=iY2, we have
    ρU(Z1,Z2)=ρPD(Y1,Y2), (69)
    the Riemannian distance between Y1 and Y2 on the symmetric positive-definite manifold [10,51]:
    ρPD(Y1,Y2)=Log(Y1Y21)F (70)
    =i=1dlog2λi(Y1Y21). (71)
    In that case, the Siegel upper metric for Z=iY becomes the affine-invariant metric:
    dsU2(Z)=tr(Y1dY)2=dsPD(Y). (72)
    Indeed, we have ρPD(CY1C,CY2C)=ρPD(Y1,Y2) for any CGL(d,R) and
    ρPD(Y11,Y21)=ρPD(Y1,Y2). (73)
  • In 1D, the Siegel upper distance ρU(Z1,Z2) between Z1=[z1] and Z2=[z2] (with z1 and z2 in C) amounts to the hyperbolic distance on the Poincaré upper plane H:
    ρU(Z1,Z2)=ρU(z1,z2), (74)
    where
    ρU(z1,z2):=log|z1z¯2|+|z1z2||z1z¯2||z1z2|. (75)
  • The Siegel distance between two diagonal matrices Z=diag(z1,,zd) and Z=diag(z1,,zd) is
    ρU(Z,Z)=i=1dρU2(zi,zi). (76)
    Observe that the Siegel distance is a non-separable metric distance, but its squared distance is separable when the matrices are diagonal:
    ρU2(Z,Z)=i=1dρU2(zi,zi). (77)

The Siegel metric in the upper plane is invariant by generalized matrix Möbius transformations (linear fractional transformations or rational transformations):

ϕS(Z):=(AZ+B)(CZ+D)1, (78)

where SM(2d,R) is the following 2d×2d block matrix:

S=ABCD. (79)

which satisfies

AB=BA,CD=DC,ADBC=I. (80)

The map ϕS(·)=ϕ(S,·) is called a symplectic map.

The set of matrices S encoding the symplectic maps forms a group called the real symplectic group Sp(d,R) [5] (informally, the group of Siegel motions):

Sp(d,R)=ABCD,A,B,C,DM(d,R):AB=BA,CD=DC,ADBC=I. (81)

It can be shown that symplectic matrices have unit determinant [73,74], and therefore Sp(d,R) is a subgroup of SL(2d,R), the special group of real invertible matrices with unit determinant. We also check that if MSp(d,R) then MSp(d,R).

Matrix S denotes the representation of the group element gS. The symplectic group operation corresponds to matrix multiplications of their representations, the neutral element is encoded by E=I00I, and the group inverse of gS with S=ABCD is encoded by the matrix:

S(1)=:DBCA. (82)

Here, we use the parenthesis notation S(1) to indicate that it is the group inverse and not the usual matrix inverse S1. The symplectic group is a Lie group of dimension d(2d+1). Indeed, a symplectic matrix of Sp(d,R) has 2d×2d=4d2 elements which are constrained from the block matrices as follows:

AB=BA, (83)
CD=DC, (84)
ADBC=I. (85)

The first two constraints are independent and of the form M=M which yields each d2d2 elementary constraints. The third constraint is of the form M1M2=I, and independent of the other constraints, yielding d2 elementary constraints. Thus, the dimension of the symplectic group is

dim(Sp(d,R))=4d2(d2d)d2=2d2+d=d(2d+1). (86)

The action of the group is transitive: That is, for any Z=A+iB and S(Z)=B120AB12B12, we have ϕS(Z)(iI)=Z. Therefore, by taking the group inverse

S(1)=(B12)0(AB12)(B12), (87)

we get

ϕS(1)(Z)=iI. (88)

The action ϕS(Z) can be interpreted as a “Siegel translation” moving matrix iI to matrix Z, and conversely the action ϕS(1)(Z) as moving matrix Z to matrix iI.

The stabilizer group of Z=iI (also called isotropy group, the set of group elements SSp(d,R) whose action fixes Z) is the subgroup of symplectic orthogonal matrices SpO(2d,R):

SpO(2d,R)=ABBA:AA+BB=I,ABSym(d,R). (89)

We have SpO(2d,R)=Sp(2d,R)O(2d), where O(2d) is the group of orthogonal matrices of dimension 2d×2d:

O(2d):=RM(2d,R):RR=RR=I. (90)

Informally speaking, the elements of SpO(2d,R) represent the “Siegel rotations” in the upper plane. The Siegel upper plane is isomorphic to Sp(2d,R)/Od(R).

A pair of matrices (Z1,Z2) can be transformed into another pair of matrices (Z1,Z2) of SH(d) if and only if λ(R(Z1,Z2))=λ(R(Z1,Z2)), where λ(M):={λ1(M),,λd(M)} denotes the spectrum of matrix M.

By noticing that the symplectic group elements M and M yield the same symplectic map, we define the orientation-preserving isometry group of the Siegel upper plane as the real projective symplectic group PSp(d,R)=Sp(d,R)/{±I2d} (generalizing the group PSL(2,R) obtained when d=1).

The geodesics in the Siegel upper space can be obtained by applying symplectic transformations to the geodesics of the positive-definite manifold (geodesics on the SPD manifold) which is a totally geodesic submanifold of SU(d). Let Z1=iP1 and Z2=iP2. Then the geodesic Z12(t) with Z12(0)=Z1 and Z12(1)=Z2 is expressed as:

Z12(t)=iP112Exp(tLog(P112P2P112))P112, (91)

where Exp(M) denotes the matrix exponential:

Exp(M)=i=01i!Mi, (92)

and Log(M) is the principal matrix logarithm, unique when matrix M has all positive eigenvalues.

The equation of the geodesic emanating from P with tangent vector STp (symmetric matrix) on the SPD manifold is:

γP,S(t)=P12Exp(tP12SP12)P12. (93)

Both the exponential and the principal logarithm of a matrix M can be calculated in cubic time when the matrices are diagonalizable: Let V denote the matrix of eigenvectors so that we have the following decomposition:

M=Vdiag(λ1,,λd)V1, (94)

where λ1,,λd are the corresponding eigenvalues of eigenvectors. Then for a scalar function f (e.g., f(u)=exp(u) or f(u)=logu), we define the corresponding matrix function f(M) as

f(M):=Vdiag(f(λ1),,f(λd))V1. (95)

The volume element of the Siegel upper plane is 2d(d1)2dv where dv is the volume element of the d(d+1)-dimensional Euclidean space expressed in the Cartesian coordinate system.

4. The Siegel Disk Domain and the Kobayashi Distance

The Siegel disk [1] is an open convex complex matrix domain defined by

SD(d):=WSym(d,C):IW¯W0. (96)

The Siegel disk can be written equivalently as SD(d):=WSym(d,C):IWW¯0 or SD(d):=WSym(d,C):WO<1. In the Cartan classification [7], the Siegel disk is a Siegel domain of type III.

When d=1, the Siegel disk SD(1) coincides with the Poincaré disk: SD(1)=D. The Siegel disk was described by Siegel [1] (page 2, called domain E to contrast with domain H of the upper space) and Hua in his 1948’s paper [75] (page 205) on the geometries of matrices [76]. Siegel’s paper [1] in 1943 only considered the Siegel upper plane. Here, the Siegel (complex matrix) disk is not to be confused with the other notion of Siegel disk in complex dynamics which is a connected component in the Fatou set.

The boundary SD(d) of the Siegel disk is called the Shilov boundary [5,77,78]): SD(d):=WSym(d,C):WO=1. We have SD(d)=Sym(d,C)U(d,C), where

U(d,C)={UU*=U*U=I:UM(d,C)} (97)

is the group of d×d unitary matrices. Thus, SD(d) is the set of symmetric d×d unitary matrices with determinant of unit module. The Shilov boundary is a stratified manifold where each stratum is defined as a space of constant rank-deficient matrices [79].

The metric in the Siegel disk is:

dsD2=tr(IWW¯)1dW(IWW¯)1dW¯. (98)

When d=1, we  recover dsD2=1(1|w|2)2dwdw¯ which is the usual metric in the Poincaré disk (up to a missing factor of 4, see Equation (25).

This Siegel metric induces a Kähler geometry [13] with the following Kähler potential:

K(W)=trLogIWHW. (99)

The Kobayashi distance [80] between W1 and W2 in SD(d) is calculated [79] as follows:

ρD(W1,W2)=log1+ΦW1(W2)O1ΦW1(W2)O, (100)

where

ΦW1(W2)=(IW1W¯1)12(W2W1)(IW¯1W2)1(IW¯1W1)12, (101)

is a Siegel translation which moves W1 to the origin O (matrix with all entries set to 0) of the disk: We have ΦW(W)=0. In the Siegel disk domain, the Kobayashi distance [80] coincides with the Carathéodory distance [81] and yields a metric distance. Notice that the Siegel disk distance, although a spectral distance function via the operator norm, is not smooth because of it uses the maximum singular value. Recall that the Siegel upper plane distance uses all eigenvalues of a matrix cross-ratio R.

It follows that the cost of calculating a Kobayashi distance in the Siegel disk is cubic: We require the computation of a symmetric matrix square root [82] in Equation (101), and  then compute the largest singular value for the operator norm in Equation (100).

Notice that when d=1, the “1d” scalar matrices commute, and we have:

Φw1(w2)=(1w1w¯1)12(w2w1)(1w¯1w2)1(1w¯1w1)12, (102)
=w2w11w¯1w2. (103)

This corresponds to a hyperbolic translation of w1 to 0 (see Equation (28)). Let us call the geometry of the Siegel disk the Siegel–Poincaré geometry.

We observe the following special cases of the Siegel–Poincaré distance:

  • Distance to the origin: When W1=0 and W2=W, we have Φ0(W)=W, and therefore the distance in the disk between a matrix W and the origin 0 is:
    ρD(0,W)=log1+WO1WO. (104)

    In particular, when d=1, we recover the formula of Equation (31): ρD(0,w)=log1+|w|1|w|.

  • When d=1, we have W1=[w1] and W2=[w2], and 
    ρD(W1,W2)=ρD(w1,w2). (105)
  • Consider diagonal matrices W=diag(w1,,wd)SD(d) and W=diag(w1,,wd)SD(d). We have |wi|1 for i{1,,d}. Thus, the diagonal matrices belong to the polydisk domain. Then we have
    ρD(W1,W2)=i=1dρD2(wi,wi). (106)

    Notice that the polydisk domain is a Cartesian product of 1D complex disk domains, but it is not the unit d-dimensional complex ball {zCd:i=1dziz¯i=1}.

We can convert a matrix Z in the Siegel upper space to an equivalent matrix W in the Siegel disk by using the following matrix Cayley transformation for ZSHd:

WUD(Z):=(ZiI)(Z+iI)1SD(d). (107)

Notice that the imaginary positive-definite matrices iP of the upper plane (vertical axis) are mapped to

WUD(iP):=(PI)(P+I)1SD(d), (108)

i.e., the real symmetric matrices belonging to the horizontal-axis of the disk.

The inverse transformation for a matrix W in the Siegel disk is

ZDU(W)=iI+WIW1SH(d), (109)

a matrix in the Siegel upper space. With those mappings, the origin of the disk 0SD(d) coincides with matrix iISH(d) in the upper space.

A key property is that the geodesics passing through the matrix origin 0 are expressed by straight line segments in the Siegel disk. We can check that

ρD(0,W)=ρD(0,αW)+ρD(αW,W), (110)

for any α[0,1].

To describe the geodesics between W1 and W2, we first move W1 to 0 and W2 to ΦW1(W2). Then the geodesic between 0 and ΦW1(W2) is a straight line segment, and we map back this geodesic via Φ1W1(·). The inverse of a symplectic map is a symplectic map which corresponds to the action of an element of the complex symplectic group.

The complex symplectic group is

Sp(d,C)=MJM=J,M=ABCDM(2d,C), (111)

with

J=0II0, (112)

for the d×d identity matrix I. Notice that the condition MJM=J amounts to check that

AB=BA,CD=DC,ADBC=I. (113)

The conversions between the Siegel upper plan to the Siegel disk (and vice versa) can be expressed using complex symplectic transformations associated with the matrices:

W(Z)=IiIIiI.Z=(ZiI)(Z+iI))1, (114)
Z(W)=iIiIII.W=iI+WIW1. (115)

Figure 1 depicts the conversion of the upper plane to the disk, and vice versa.

Figure 1.

Figure 1

Illustrating the properties and conversion between the Siegel upper plane and the Siegel disk.

The orientation-preserving isometries in the Siegel disk is the projective complex symplectic group PSp(d,C)=Sp(d,C)/{±I2d}.

It can be shown that

Sp(d,C)=M=ABB¯A¯M(2d,C), (116)

with

AB¯BHA=0, (117)
AA¯BHB=I. (118)

and the left action of gSp(d,C) is

g.W=(AW+B)(A¯W+B¯)1. (119)

The isotropy group at the origin 0 is

A00A¯:AU(d), (120)

where U(d) is the unitary group: U(d)={UGL(d,C):UHU=UUH=I}.

Thus, we can “rotate” a matrix W with respect to the origin so that its imaginary part becomes 0: There exists A such that Re(AWW1A¯1)=0.

More generally, we can define a Siegel rotation [83] in the disk with respect to a center W0SD(d) as follows:

RW0(W)=(AWAW0)(BBW¯0W)1, (121)

where

A¯A=(IW0W¯0)1, (122)
B¯B=(IW¯0W0)1, (123)
A¯AW0=W0B¯B. (124)

Interestingly, the Poincaré disk can be embedded non-diagonally onto the Siegel upper plane [84].

In complex dimension d=1, the Kobayashi distance ρW coincides with the Siegel distance ρU. Otherwise, we calculate the Siegel distance in the Siegel disk as

ρU(W1,W2):=ρUZDU(W1),ZDU(W2). (125)

5. The Siegel–Klein Geometry: Distance and Geodesics

We define the Siegel–Klein geometry as the Hilbert geometry for the Siegel disk model. Section 5.1 concisely explains the Hilbert geometry induced by an open-bounded convex domain. In Section 5.2, we study the Hilbert geometry of the Siegel disk domain. Then we report the Siegel–Klein distance in Section 5.3 and study some of its particular cases. Section 5.5 presents the conversion procedures between the Siegel–Poincaré disk and the Siegel–Klein disk. In Section 5.7, we design a fast guaranteed method to approximate the Siegel–Klein distance. Finally, we introduce the Hilbert-Fröbenius distances to get simple bounds on the Siegel–Klein distance in Section 5.8.

5.1. Background on Hilbert Geometry

Consider a normed vector space (V,·), and define the Hilbert distance [30,85] for an open-bounded convex domain Ω as follows:

Definition 1 (Hilbert distance). 

The Hilbert distance is defined for any open-bounded convex domain Ω and a prescribed positive factor κ>0 by

HΩ,κ(p,q):=κlogCR(p¯,p;q,q¯),pq,0p=q. (126)

where p¯ and q¯ are the unique two intersection points of the line (pq) with the boundary Ω of the domain Ω as depicted in Figure 2, and  CR denotes the cross-ratio of four points (a projective invariant):

CR(a,b;c,d)=acbdadbc. (127)

When pq, we have:

HΩ,κ(p,q):=κlogq¯pp¯qq¯qp¯p. (128)

Figure 2.

Figure 2

Hilbert distance induced by a bounded open convex domain Ω.

The Hilbert distance is a metric distance which does not depend on the underlying norm of the vector space:

Proposition 1 (Formula of Hilbert distance). 

The Hilbert distance between two points p and q of an open-bounded convex domain Ω is

HΩ,κ(p,q)=κlogα+(1α)α(α+1),pq,0p=q., (129)

where p¯=p+α(qp) and q¯=p+α+(qp) are the two intersection points of the line (pq) with the boundary Ω of the domain Ω.

Proof. 

For distinct points p and q of Ω, let α+>1 be such that q¯=p+α+(qp), and α<0 such that p¯=p+α(qp). Then we have q¯p=α+qp, p¯p=|α|qp, qq¯=(α+1)pq and p¯q=(1α)pq. Thus, we get

HΩ,κ(p,q)=κlogq¯pp¯qq¯qp¯p, (130)
=κlogα+(1α)|α|(α+1), (131)

and HΩ(p,q)=0 if and only if p=q. ☐

We may also write the source points p and q as linear interpolations of the extremal points p¯ and q¯ on the boundary: p=(1βp)p¯+βpq¯ and q=(1βq)p¯+βqq¯ with 0<βp<βq<1 for distinct points p and q. In that case, the Hilbert distance can be written as

HΩ,κ(p,q)=κlog1βpβpβq1βqβpβq,0βp=βq. (132)

The projective Hilbert space (Ω,HΩ) is a metric space. Notice that the above formula has demonstrated that

HΩ,κ(p,q)=HΩ(pq),κ(p,q). (133)

That is, the Hilbert distance between two points of a d-dimensional domain Ω is equivalent to the Hilbert distance between the two points on the 1D domain Ω(pq) defined by Ω restricted to the line (pq) passing through the points p and q.

Notice that the boundary Ω of the domain may not be smooth (e.g., Ω may be a simplex [86] or a polytope [87]). The Hilbert geometry for the unit disk centered at the origin with κ=12 yields the Klein model [88] (or Klein-Beltrami model [89]) of hyperbolic geometry. The Hilbert geometry for an ellipsoid yields the Cayley-Klein hyperbolic model [29,35,90] generalizing the Klein model. The Hilbert geometry for a simplicial polytope is isometric to a normed vector space [86,91]. We refer to the handbook [31] for a survey of recent results on Hilbert geometry. The Hilbert geometry of the elliptope (i.e., space of correlation matrices) was studied in [86]. Hilbert geometry may be studied from the viewpoint of Finslerian geometry which is Riemannian if and only if the domain Ω is an ellipsoid (i.e., Klein or Cayley-Klein hyperbolic geometries). Finally, it is interesting to observe the similarity of the Hilbert distance which relies on a geometric cross-ratio with the Siegel distance (Equation (55)) in the upper space which relies on a matrix generalization of the cross-ratio (Equation (57)).

5.2. Hilbert Geometry of the Siegel Disk Domain

Let us consider the Siegel–Klein disk model which is defined as the Hilbert geometry for the Siegel disk domain Ω=SD(d) as depicted in Figure 3 with κ=12.

Definition 2 (Siegel–Klein geometry). 

The Siegel–Klein disk model is the Hilbert geometry for the open-bounded convex domain Ω=SD(d) with prescribed constant κ=12. The Siegel–Klein distance is

ρK(K1,K2):=HSD(d),12(K1,K2). (134)

When d=1, the Siegel–Klein disk is the Klein disk model of hyperbolic geometry, and the Klein distance [34] between two any points k1C and k2C restricted to the unit disk is

ρK(k1,k2)=arccosh1(Re(k1)Re(k2)+Im(k1)Im(k2))(1|k1|)(1|k2|), (135)

where

arccosh(x)=logx+x21,x1. (136)

Figure 3.

Figure 3

Hilbert geometry for the Siegel disk: The Siegel–Klein disk model.

This formula can be retrieved from the Hilbert distance induced by the Klein unit disk [29].

5.3. Calculating and Approximating the Siegel–Klein Distance

The Siegel disk domain SD(d)=WSym(d,C):IW¯W0 can be rewritten using the operator norm as

SD(d)=WSym(d,C):WO<1. (137)

Let {K1+α(K2K1),αR} denote the line passing through (matrix) points K1 and K2. That line intersects the Shilov boundary when

K1+α(K2K1)O=1. (138)

when K1K2, there are two unique solutions since a line intersects the boundary of a bounded open convex domain in at most two points: Let one solution be α+ with α+>1, and the other solution be α with α<0. The Siegel–Klein distance is then defined as

ρK(K1,K2)=12logα+(1α)|α|(α+1), (139)

where K¯1=K1+α(K2K1) and K¯2=K1+α+(K2K1) are the extremal matrices belonging to the Shilov boundary SD(d).

Notice that matrices K1 and/or K2 may be rank-deficient. We have rank(K1+λ(K2K1))min(d,rank(K1)+rank(K2)), see [92].

In practice, we may perform a bisection search on the matrix line (K1K2) to approximate these two extremal points K¯1 and K¯2 (such that these matrices are ordered along the line as follows: K¯1, K1, K2, K¯2). We may find a lower bound for α and a upper bound for α+ as follows: We seek α on the line (K1K2) such that K1+α(K2K1) falls outside the Siegel disk domain:

1<K1+α(K2K1)O. (140)

Since ·O is a matrix norm, we have

1<K1+α(K2K1)OK1O+|α|(K2K1)O. (141)

Thus, we deduce that

|α|>1K1O(K2K1)O. (142)

5.4. Siegel–Klein Distance to the Origin

When K1=0 (the 0 matrix denoting the origin of the Siegel disk), and K2=KSD(d), it is easy to solve the equation:

αKO=1. (143)

We have |α|=1KO, i.e.,

α+=1KO>1, (144)
α=1KO<0. (145)

In that case, the Siegel–Klein distance of Equation (139) is expressed as:

ρK(0,K)=log1+1KO1KO1, (146)
=12log1+KO1KO, (147)
=2ρD(0,K), (148)

where ρD(0,W) is defined in Equation (104).

Theorem 1 (Siegel–Klein distance to the origin). 

The Siegel–Klein distance of matrix KSD(d) to the origin O is

ρK(0,K)=12log1+KO1KO. (149)

The constant κ=12 is chosen in order to ensure that when d=1 the corresponding Klein disk has negative unit curvature. The result can be easily extended to the case of the Siegel–Klein distance between K1 and K2 where the origin O belongs to the line (K1K2). In that case, K2=λK1 for some λR (e.g., λ=tr(K2)tr(K1) where tr denotes the matrix trace operator). It follows that

K1+α(K2K1)O=1, (150)
|1+α(λ1)|=1K1O. (151)

Thus, we get the two values defining the intersection of (K1K2) with the Shilov boundary:

α=1λ11K1O1, (152)
α=11λ1+1K1O. (153)

We then apply formula Equation (139):

ρK(K1,K2)=12logα(1α)α(α1), (154)
=12log1K1O1+K1OK1O(1λ)(1+K1O)K1O(λ1)(1K1O). (155)

Theorem 2.

The Siegel–Klein distance between two points K10 and K2 on a line (K1K2) passing through the origin is

ρK(K1,K2)=12log1K1O1+K1OK1O(1λ)(1+K1O)K1O(λ1)(1K1O),

where λ=tr(K2)tr(K1).

5.5. Converting Siegel–Poincaré Matrices from/to Siegel–Klein Matrices

From Equation (149), we deduce that we can convert a matrix K in the Siegel–Klein disk to a corresponding matrix W in the Siegel–Poincaré disk, and vice versa, as follows:

  • Converting K to W: We convert a matrix K in the Siegel–Klein model to an equivalent matrix W in the Siegel–Poincaré model as follows:
    CKD(K)=11+1KO2K. (156)

    This conversion corresponds to a radial contraction with respect to the origin 0 since 11+1KO21 (with equality for matrices belonging to the Shilov boundary).

  • Converting W to K: We convert a matrix W in the Siegel–Poincaré model to an equivalent matrix K in the Siegel–Klein model as follows:
    CDK(W)=21+WO2W. (157)

    This conversion corresponds to a radial expansion with respect to the origin 0 since 21+WO21 (with equality for matrices on the Shilov boundary).

Proposition 2 (Conversions Siegel–Poincaré⇔Siegel–Klein disk). 

The conversion of a matrix K of the Siegel–Klein model to its equivalent matrix W in the Siegel–Poincaré model, and vice versa, is done by the following radial contraction and expansion functions: CKD(K)=11+1KO2K and CDK(W)=21+|W|O2W.

Figure 4 illustrates the radial expansion/contraction conversions between the Siegel–Poincaré and Siegel–Klein matrices.

Figure 4.

Figure 4

Conversions in the Siegel disk domain: Poincaré to/from Klein matrices.

The cross-ratio (p,q;P,Q)=pPqQpQqP of four collinear points on a line is such that (p,q;P,Q)=(p,r;P,Q)×(r,q;P,Q) whenever r belongs to that line. By virtue of this cross-ratio property, the (pre)geodesics in the Hilbert–Klein disk are Euclidean straight. Thus, we can write the pregeodesics as:

γK1,K2(α)=(1α)K1+αK2=K1+α(K2K1). (158)

Riemannian geodesics are paths which minimize locally the distance and are parameterized proportionally to the arc-length. A pregeodesic is a path which minimizes locally the distance but is not necessarily parameterized proportionally to the arc-length. For implementing geometric intersection algorithms (e.g., a geodesic with a ball), it is enough to consider pregeodesics.

Another way to get a generic closed-form formula for the Siegel–Klein distance is by using the formula for the Siegel–Poincaré disk after converting the matrices to their equivalent matrices in the Siegel–Poincaré disk. We get the following expression:

ρK(K1,K2)=ρD(CKD(K1),CKD(K2)), (159)
=12log1+ΦCKD(K1)(CKD(K2))O1ΦCKD(K1)(CKD(K2))O. (160)

Theorem 3 (Formula for the Siegel–Klein distance). 

The Siegel–Klein distance between K1 and K2 in the Siegel disk is ρK(K1,K2)=12log1+ΦCKD(K1)(CKD(K2))O1ΦCKD(K1)(CKD(K2))O.

The isometries in Hilbert geometry have been studied in [93].

We now turn our attention to a special case where we can report an efficient and exact linear-time algorithm for calculating the Siegel–Klein distance.

5.6. Siegel–Klein Distance between Diagonal Matrices

Let Kα=K1+αK21 with K21=K2K1. When solving for the general case, we seek for the extremal values of α such that:

IK¯αKα0, (161)
I(K¯1+αK¯21)(K1+αK21)0, (162)
I(K¯1K1+α(K¯1K21+K¯21K1)+α2K¯21K21)0, (163)
K¯1K1+α(K¯1K21+K¯21K1)+α2K¯21K21I. (164)

This last equation is reminiscent to a Linear Matrix Inequality [94] (LMI, i.e., iyiSi0 with yiR and SiSym(d,R) where the coefficients yi are however linked between them).

Let us consider the special case of diagonal matrices corresponding to the polydisk domain: K=diag(k1,,kd) and K=diag(k1,,kd) of the Siegel disk domain.

First, let us start with the simple case d=1, i.e.,  the Siegel disk SD(1) which is the complex open unit disk {kC:k¯k<1}. Let kα=(1α)k1+αk2=k1+αk21 with k21=k2k1. We have k¯αkα=aα2+bα+c with a=k¯21k21, b=k¯1k21+k¯21k1 and c=k¯1k1. To find the two intersection points of line (k1k2) with the boundary of SD(1), we need to solve k¯αkα=1. This amounts to solve an ordinary quadratic equation since all coefficients a, b, and c are provably reals. Let Δ=b24ac be the discriminant (Δ>0 when k1k2). We get the two solutions αm=bΔ2a and αM=b+Δ2a, and apply the 1D formula for the Hilbert distance:

ρK(k1,k2)=12logαM(1αm)|αm|(αM1). (165)

Doing so, we obtain a formula equivalent to Equation (30).

For diagonal matrices with d>1, we get the following system of d inequalities:

αi2k¯ik¯ikiki+αik¯i(kiki)+ki(k¯ik¯i)+k¯iki10,i{1,,d}. (166)

For each inequality, we solve the quadratic equation as in the 1d case above, yielding two solutions αi and αi+. Then we satisfy all those constraints by setting

α=maxi{1,,d}αi, (167)
α+=mini{1,,d}αi+, (168)

and we compute the Hilbert distance:

ρK(K1,K2)=12logα+(1α)|α|(α+1). (169)

Theorem 4 (Siegel–Klein distance for diagonal matrices). 

The Siegel–Klein distance between two diagonal matrices in the Siegel–Klein disk can be calculated exactly in linear time.

Notice that the proof extends to triangular matrices as well.

When the matrices are non-diagonal, we must solve analytically the equation:

max|α|, (170)
such thatα2S2+αS1+S00, (171)

with the following Hermitian matrices (with all real eigenvalues):

S2=K¯21K21=S2H, (172)
S1=K¯1K21+K¯21K1=S1H, (173)
S0=K¯1K1I=S0H. (174)

Although S0 and S2 commute, it is not necessarily the case for S0 and S1, or S1 and S2.

When S0, S1 and S2 are simultaneously diagonalizable via congruence [95], the optimization problem becomes:

max|α|, (175)
such thatα2D2+αD1D0, (176)

where Di=PSiP for some PGL(d,C), and we apply Theorem 4. The same result applies for simultaneously diagonalizable matrices S0, S1 and S2 via similarity: Di=P1SiP with PGL(d,C).

Notice that the Hilbert distance (or its squared distance) is not a separable distance, even in the case of diagonal matrices. (However, recall that the squared Siegel–Poincaré distance in the upper plane is separable for diagonal matrices.)

When d=1, we have

ρU(z1,z2)=ρD(w1,w2)=ρK(k1,k2). (177)

We now investigate a guaranteed fast scheme for approximating the Siegel–Klein distance in the general case.

5.7. A Fast Guaranteed Approximation of the Siegel–Klein Distance

In the general case, we use the bisection approximation algorithm which is a geometric approximation technique that only requires the calculation of operator norms (and not the square root matrices required in the functions Φ·(·) for calculating the Siegel distance in the disk domain).

We have the following key property of the Hilbert distance:

Property 1 (Bounding Hilbert distance). 

Let Ω+ΩΩ be strictly nested open convex bounded domains. Then we have the following inequality for the corresponding Hilbert distances:

HΩ+,κ(p,q)HΩ,κ(p,q)HΩ,κ(p,q). (178)

Figure 5 illustrates the Property 1 of Hilbert distances corresponding to nested domains. Notice that when Ω is a large enclosing ball of Ω with radius increasing to infinity, we have αα+, and therefore the Hilbert distance tends to zero.

Figure 5.

Figure 5

Inequalities of the Hilbert distances induced by nested bounded open convex domains.

Proof. 

Recall that HΩ,κ(p,q)=HΩ(pq),κ(p,q), i.e., the  Hilbert distance with respect to domain Ω can be calculated as an equivalent 1-dimensional Hilbert distance by considering the open-bounded (convex) interval Ω(pq)=[p¯q¯]. Furthermore, we have [p¯q¯][p¯q¯]=Ω(pq) (with set containment ΩΩ). Therefore let us consider the 1D case as depicted in Figure 6. Let us choose p<q so that we have p¯p¯<p<q<q¯q¯. In 1D, the Hilbert distance is expressed as

HΩ,κ(p,q):=κlog|q¯p||p¯q||q¯q||p¯p|, (179)

for a prescribed constant κ>0. Therefore it follows that

HΩ,κ(p,q)HΩ,κ(p,q):=κlog|q¯p||p¯q||q¯q||p¯p|×|q¯q||p¯p||q¯p||p¯q|. (180)

We can rewrite the argument of the logarithm as follows:

|q¯p||p¯q||q¯q||p¯p|×|q¯q||p¯p||q¯p||p¯q|=(q¯p)(q¯q)(q¯q)(q¯p)×(pp¯)(qp¯)(pp¯)(qp¯), (181)
=CR(q¯,q¯;p,q)×CR(p,q;p¯,p¯), (182)

with

CR(a,b;c,d)=|ac||bd||ad||bc|=|ac||bc||ad||bd|. (183)

Since p¯p¯<p<q<q¯q¯, we have CR(q¯,q¯;p,q)1 and CR(p,q;p¯,p¯)1, see [29]. Therefore we deduce that HΩ,κ(p,q)HΩ,κ(p,q) when ΩΩ. ☐

Figure 6.

Figure 6

Comparison of the Hilbert distances HΩ,κ(p,q) and HΩ,κ(p,q) induced by nested open interval domains ΩΩ: HΩ,κ(p,q)HΩ,κ(p,q).

Therefore the bisection search for finding the values of α and α+ yields both lower and upper bounds on the exact Siegel–Klein distance as follows: Let α(l,u) and α+(l+,u+) where l, u, l+, u+ are real values defining the extremities of the intervals. Using Property 1, we get the following theorem:

Theorem 5 (Lower and upper bounds on the Siegel–Klein distance). 

The Siegel–Klein distance between two matrices K1 and K2 of the Siegel disk is bounded as follows:

ρK(l,u+)ρK(K1,K2)ρK(u,l+), (184)

where

ρK(αm,αM):=12logαM(1αm)|αm|(αM1). (185)

Figure 7 depicts the guaranteed lower and upper bounds obtained by performing the bisection search for approximating the point K¯1(K¯1,K¯1) and the points K¯2(K¯2,K¯2).

Figure 7.

Figure 7

Guaranteed lower and upper bounds for the Siegel–Klein distance by considering nested open matrix balls.

We have:

CR(K¯1,K1;K2,K¯2)CR(K¯1,K1;K2,K¯2)CR(K¯1,K1;K2,K¯2), (186)

where CR(a,b;c,d)=acbdadbc denotes the cross-ratio. Hence we have

HΩ,12(K1,K2)ρK(K1,K2)HΩ,12(K1,K2). (187)

Notice that the approximation of the Siegel–Klein distance by line bisection requires only to calculate an operator norm MO at each step: This involves calculating the smallest and largest eigenvalues of M, or the largest eigenvalue of MM¯. To get a (1+ϵ)-approximation, we need to perform O(log1ϵ) dichotomic steps. This yields a fast method to approximate the Siegel–Klein distance compared with the costly exact calculation of the Siegel–Klein distance of Equation (159) which requires calculation of the Φ·(·) functions: This involves the calculation of a square root of a complex matrix. Furthermore, notice that the operator norm can be numerically approximated using a Lanczos’s power iteration scheme [96,97] (see also [98]).

5.8. Hilbert-Fröbenius Distances and Fast Simple Bounds on the Siegel–Klein Distance

Let us notice that although the Hilbert distance does not depend on the chosen norm in the vector space, the Siegel complex ball SD(d) is defined according to the operator norm. In a finite-dimensional vector space, all norms are said “equivalent”: That is, given two norms ·a and ·b of vector space X, there exists positive constants c1 and c2 such that

c1xaxac2xb,xX. (188)

In particular, this property holds for the operator norm and Fröbenius norm of finite-dimensional complex matrices with positive constants cd, Cd, cd and Cd depending on the dimension d of the square matrices:

cdMOMFCdMO,MM(d,C), (189)
cdMFMOCdMF,MM(d,C). (190)

As mentioned in the introduction, we have MOMF.

Thus, the Siegel ball domain SD(d) may be enclosed by an open Fröbenius ball FDd,1(1+ϵ)cd (for any ϵ>0) with

FD(d,r)=:MM(d,C):MF<r. (191)

Therefore we have

HFDd,1cd,12(K1,K2)ρK(K1,K2), (192)

where HFD(d,r),12 denotes the Fröbenius-Klein distance, i.e., the Hilbert distance induced by the Fröbenius balls FD(d,r) with constant κ=12.

Now, we can calculate in closed-form the Fröbenius-Klein distance by computing the two intersection points of the line (K1K2) with the Fröbenius ball FD(d,r). This amounts to solve an ordinary quadratic equation K1+α(K2K1)F2=r for parameter α:

K21F2α2+i,jK21i,jK¯1i,j+K1i,jK¯21i,jα+(K1F2r)=0, (193)

where Ki,j denotes the coefficient of matrix K at row i and column j. Notice that i,jK21i,jK¯1i,j+K1i,jK¯21i,j is a real. Once α and α+ are found, we apply the 1D formula of the Hilbert distance of Equation (132).

We summarize the result as follows:

Theorem 6 (Lower bound on Siegel–Klein distance). 

The Siegel–Klein distance is lower bounded by the Fröbenius-Klein distance for the unit complex Fröbenius ball, and it can be calculated in O(d2) time.

6. The Smallest Enclosing Ball in the SPD Manifold and in the Siegel Spaces

The goal of this section is to compare two implementations of a generalization of the Badoiu and Clarkson’s algorithm [47] to approximate the Smallest Enclosing Ball (SEB) of a set of complex matrices: The implementation using the Siegel–Poincaré disk (with respect to the Kobayashi distance ρD), and the implementation using the Siegel–Klein disk (with respect to the Siegel–Klein distance ρK).

In general, we may encode a pair of features (S,P)Sym(d,R)×P++(d,R) in applications as a Riemann matrix Z(S,P):=S+iP, and consider the underlying geometry of the Siegel upper space. For example, anomaly detection of time-series maybe considered by considering (Σ˙(t),Σ(t)) where Σ(t) is the covariance matrix at time t and Σ˙(t)1dt(Σ(t+dt)Σ(t)) is the approximation of the derivative of the covariance matrix (a symmetric matrix) for a small prescribed value of dt.

The generic Badoiu and Clarkson’s algorithm [47] (BC algorithm) for a set {p1,,pn} of n points in a metric space (X,ρ) is described as follows:

  • Initialization: Let c1=p1 and l=1

  • Repeat L times:
    • -
      Calculate the farthest point: fl=argmini[d]ρ(cl,pi).
    • -
      Geodesic cut: Let cl+1=cl#tlfl, where p#tlq is the point which satisfies
      ρ(p,p#tlXq)=tlρ(p,q). (194)
    • -
      ll+1.

This elementary SEB approximation algorithm has been instantiated to various metric spaces with proofs of convergence according to the sequence {tl}l: see [43] for the case of hyperbolic geometry, ref. [46] for Riemannian geometry with bounded sectional curvatures, ref. [99,100] for dually flat spaces (a non-metric space equipped with a Bregman divergences [101,102]), etc. In Cartan-Hadamard manifolds [46], we require the series iti to diverge while the series iti2 to converge. The number of iterations L to get a (1+ϵ)-approximation of the SEB depends on the underlying geometry and the sequence {tl}l. For example, in Euclidean geometry, setting tl=1l+1 with L=1ϵ2 steps yield a (1+ϵ)-approximation of the SEB [47].

We start by recalling the Riemannian generalization of the BC algorithm, and then consider the Siegel spaces.

6.1. Approximating the Smallest Enclosing Ball in Riemannian Spaces

We first instantiate a particular example of Riemannian space, the space of Symmetric Positive-Definite matrix manifold (PD or SPD manifold for short), and then consider the general case on a Riemannian manifold (M,g).

Approximating the SEB on the SPD Manifold

Given n positive-definite matrices [103,104 P1,,Pn of size d×d, we ask to calculate the SEB with circumcenter P* minimizing the following objective function:

minPPD(d)maxi{1,,n}ρPD(P,Pi). (195)

This is a minimax optimization problem. The SPD cone is not a complete metric space with respect to the Fröbenius distance, but is a complete metric space with respect to the natural Riemannian distance.

When the minimization is performed with respect to the Fröbenius distance, we can solve this problem using techniques of Euclidean computational geometry [33,47] by vectorizing the PSD matrices Pi into corresponding vectors vi=vec(Pi) of Rd×d such that PPF=vec(P)vec(P)2, where vec(·):Sym(d,R)Rd×d vectorizes a matrix by stacking its column vectors. In fact, since the matrices are symmetric, it is enough to half-vectorize the matrices: PPF=vec+(P)vec+(P)2, where vec+(·):Sym++(d,R)Rd(d+1)2, see [50].

Property 2.

The smallest enclosing ball of a finite set of positive-definite matrices is unique.

Let us mention the two following proofs:

  • The SEB is well-defined and unique since the SPD manifold is a Bruhat–Tits space: That is, a complete metric space enjoying a semi-parallelogram law: For any P1,P2PD(d) and geodesic midpoint P12=P1(P11P2)12 (see below), we have:
    ρPD2(P1,P2)+4ρPD2(P,P12)2ρPD2(P,P1)+2dPD2(P,P2),PPD(d). (196)

    See [44] page 83 or [105] Chapter 6). In a Bruhat–Tits space, the SEB is guaranteed to be unique [44,106].

  • Another proof of the uniqueness of the SEB on a SPD manifold consists of noticing that the SPD manifold is a Cartan-Hadamard manifold [46], and the SEB on Cartan-Hadamard manifolds are guaranteed to be unique.

We shall use the invariance property of the Riemannian distance by congruence:

ρPDCP1C,CP2C=ρPD(P1,P2),CGL(d,R). (197)

In particular, choosing C=P112, we get

ρPD(P1,P2)=ρI,P112P2P112. (198)

The geodesic from I to P is γI,P(α)=Exp(αLogP)=Pα. The set {λi(Pα)} of the d eigenvalues of Pα coincide with the set {λi(P)α} of eigenvalues of P raised to the power α (up to a permutation).

Thus, to cut the geodesic I#tPDP, we must solve the following problem:

ρPD(I,Pα)=t×ρPD(I,P). (199)

That is

ilog2λi(P)α=t×ilog2λi(P), (200)
α×ilog2λi(P)=t×ilog2λi(P). (201)

The solution is α=t. Thus, I#tPDP=Pt. For arbitrary P1 and P2, we first apply the congruence transformation with C=P112, use the solution I#tPDCPC=(CPC)t, and apply the inverse congruence transformation with C1=P112. It follows the theorem:

Theorem 7 (Geodesic cut on the SPD manifold). 

For any t(0,1), we have the closed-form expression of the geodesic cut on the manifold of positive-definite matrices:

P1#tPDP2=P112ExptLogP112P2P112P112, (202)
=P112P112P2P112tP112, (203)
=P1(P11P2)t, (204)
=P2(P21P1)1t. (205)

The matrix P112P2P112 can be rewritten using the orthogonal eigendecomposition as UDU, where D is the diagonal matrix of generalized eigenvalues. Thus, the PD geodesic can be rewritten as

P1#tPDP2=P112UDtUP112. (206)

We instantiate the algorithm of Badoiu and Clarkson [47] to a finite set P={P1,,Pn} of n positive-definite matrices in Algorithm 1.

Algorithm 1: Algorithm to approximate the circumcenter of a set of positive-definite matrices.
graphic file with name entropy-22-01019-i001.jpg

The complexity of the algorithm is in O(d3nT) where T is the number of iterations, d the row dimension of the square matrices Pi and n the number of matrices.

Observe that the solution corresponds to the arc-length parameterization of the geodesic with boundary values on the SPD manifold:

γP1,P2(t)=P112exp(tLog(P112P2P112))P112. (207)

The curve γP1,P2(t) is a geodesic for any affine-invariant metric distance ρψ(P1,P2)=LogP112P2P112ψ where Mψ=ψ(λ1(M),,λd(M)) is a symmetric gauge norm [107].

In fact, we have shown the following property:

Property 3 (Riemannian geodesic cut). 

Let γp,q(t) denote the Riemannian geodesic linking p and q on a Riemannian manifold (M,g) (i.e., parameterized proportionally to the arc-length and with respect to the Levi–Civita connection induced by the metric tensor g). Then we have

p1#tgp2=γp1,p2(t)=γp2,p1(1t). (208)

We report the generic Riemannian approximation algorithm in Algorithm 2.

Algorithm 2: Algorithm to approximate the Riemannian circumcenter of a set of points.
graphic file with name entropy-22-01019-i002.jpg

Theorem 1 of [46] guarantees the convergence of the Algorithm 2 algorithm provided that we have a lower bound and an upper bound on the sectional curvatures of the manifold (M,g). The sectional curvatures of the PD manifold have been proven to be negative [108]. The SPD manifold is a Cartan-Hadamard manifold with scalar curvature 18d(d+1)(d+2) [109] depending on the dimension d of the matrices. Notice that we can identify PPD(d) with an element of the quotient space GL(d,R)/O(d) since O(d) is the isotropy subgroup of the GL(d,R) for the action PCPC (i.e., ICIC=I when CO(d)). Thus, we have PD(d)GL(d,R)/O(d). The SEB with respect to the Thompson metric

ρT(P1,P2):=maxlogλmax(P2P11),logλmax(P1P21) (209)

has been studied in [107].

6.2. Implementation in the Siegel–Poincaré Disk

Given n d×d complex matrices W1,,WnSD(d), we ask to find the smallest-radius enclosing ball with center W* minimizing the following objective function:

minWSD(d)maxi{1,,n}ρD(W,Wi). (210)

This problem may have potential applications in image morphology [110] or anomaly detection of covariance matrices [39]. We may model the dynamics of a covariance matrix time-series Σ(t) by the representation (Σ(t),Σ˙(t)) where Σ˙(t)=ddtΣ(t)Sym(d,R) and use the Siegel SEB to detect anomalies, see [40] for detection anomaly based on Bregman SEBs.

The Siegel–Poincaré upper plane and disk are not Bruhat–Tits space, but spaces of non-positive curvatures [111]. Indeed, when d=1, the Poincaré disk is not a Bruhat space.

Notice that when d=1, the hyperbolic ball in the Poincaré disk have Euclidean shape. This is not true anymore when d>1: Indeed, the equation of the ball centered at the origin 0:

Ball(0,r)=WSD(d):log1+WO1WOr, (211)

amounts to

Ball(0,r)=WSD(d):WOer1er+1. (212)

when d=1, WO=|w|=(Re(w),Im(w))2, and Poincaré balls have Euclidean shapes. Otherwise, when d>1, WO=σmax(W) and σmax(W)er1er+1 is not a complex Fröbenius ball.

To apply the generic algorithm, we need to implement the geodesic cut operation W1#tW2. We consider the complex symplectic map ΦW1(W) in the Siegel disk that maps W1 to 0 and W2 to W2=ΦW1(W2). Then the geodesic between 0 and W2 is a straight line.

We need to find α(t)W=0#tSDW (with α(t)>0) such that ρD(0,α(t)W)=tρD(0,W). That is, we shall solve the following equation:

log1+α(t)WO1α(t)WO=t×log1+WO1WO. (213)

We find the exact solution as

α(t)=1WO(1+WO)t(1WO)t(1+WO)t+(1WO)t. (214)

Proposition 3 (Siegel–Poincaré geodesics from the origin). 

The geodesic in the Siegel disk is

γ0,WSD(t)=α(t)W (215)

with

α(t)=1WO(1+WO)t(1WO)t(1+WO)t+(1WO)t.

Thus, the midpoint W1#SDW2:=W1#12SDW2 of W1 and W2 can be found as follows:

W1#SDW2=ΦW110#SDΦW1(W2), (216)

where

0#SDW=α12W, (217)
=1WO1+WO1WO1+WO+1WOW. (218)

To summarize, Algorithm 3 recenters at every step the current center Ct to the Siegel disk origin 0.

Algorithm 3: Algorithm to approximate the circumcenter of a set of matrices in the Siegel disk.
graphic file with name entropy-22-01019-i003.jpg

The farthest point to the current approximation of the circumcenter can be calculated using the data-structure of the Vantage Point Tree (VPT), see [112].

The Riemannian curvature tensor of the Siegel space is non-positive [1,113] and the sectional curvatures are non-positive [111] and bounded above by a negative constant. In our implementation, we chose the step sizes tl=1l+1. Barbaresco [14] also adopted this iterative recentering operation for calculating the median in the Siegel disk. However at the end of his algorithm, he does not map back the median among the source matrix set. Recentering is costly because we need to calculate a square root matrix to calculate ΦC(W). A great advantage of Siegel–Klein space is that we have straight geodesics anywhere in the disk so we do not need to perform recentering.

6.3. Fast Implementation in the Siegel–Klein Disk

The main advantage of implementing the Badoiu and Clarkson’s algorithm [47] in the Siegel–Klein disk is to avoid to perform the costly recentering operations (which require calculation of square root matrices). Moreover, we do not have to roll back our approximate circumcenter at the end of the algorithm.

First, we state the following expression of the geodesics in the Siegel disk:

Proposition 4 (Siegel–Klein geodesics from the origin). 

The geodesic from the origin in the Siegel–Klein disk is expressed

γ0,KSK(t)=α(t)K (219)

with

α(t)=1KO(1+KO)t(1KO)t(1+KO)t+(1KO)t. (220)

The proof follows straightforwardly from Proposition 3 because we have ρK(0,K)=12ρD(0,K).

7. Conclusions and Perspectives

In this work, we have generalized the Klein model of hyperbolic geometry to the Siegel disk domain of complex matrices by considering the Hilbert geometry induced by the Siegel disk, an open-bounded convex complex matrix domain. We compared this Siegel–Klein disk model with its Hilbert distance called the Siegel–Klein distance ρK to both the Siegel–Poincaré disk model (Kobayashi distance ρW) and the Siegel–Poincaré upper plane (Siegel distance ρU). We show how to convert matrices W of the Siegel–Poincaré disk model into equivalent matrices K of Siegel–Klein disk model and matrices Z in the Siegel–Poincaré upper plane via symplectic maps. When the dimension d=1, we have the following equivalent hyperbolic distances:

ρD(w1,w2)=ρK(k1,k2)=ρU(z1,z2). (221)

Since the geodesics in the Siegel–Klein disk are by construction straight, this model is well-suited to implement techniques of computational geometry [33]. Furthermore, the calculation of the Siegel–Klein disk does not require the recentering of one of its arguments to the disk origin, a computationally costly Siegel translation operation. We reported a linear-time algorithm for computing the exact Siegel–Klein distance ρK between diagonal matrices of the disk (Theorem 4), and a fast way to numerically approximate the Siegel distance by bisection searches with guaranteed lower and upper bounds (Theorem 5). Finally, we  demonstrated the algorithmic advantage of using the Siegel–Klein disk model instead of the Siegel–Poincaré disk model for approximating the smallest-radius enclosing ball of a finite set of complex matrices in the Siegel disk. In future work, we shall consider more generally the Hilbert geometry of homogeneous complex domains and investigate quantitatively the Siegel–Klein geometry in applications ranging from radar processing [14], image morphology [28], computer vision, to machine learning [24]. For example, the fast and robust guaranteed approximation of the Siegel–Klein distance may prove useful for performing clustering analysis in image morphology [28,38,110].

Acknowledgments

The author would like to thank Marc Arnaudon, Frédéric Barbaresco, Yann Cabanes, and Gaëtan Hadjeres for fruitful discussions, pointing out several relevant references, and feedback related to the Siegel domains.

Abbreviations

The following notations and main formulas are used in this manuscript:

Complex matrices:
Number field F Real R or complex C
M(d,F) Space of square d×d matrices in F
Sym(d,R) Space of real symmetric matrices
0 matrix with all coefficients equal to zero (disk origin)
Fröbenius norm MF=i,j|Mi,j|2
Operator norm MO=σmax(M)=maxi{|λi(M)|}
Domains:
Cone of SPD matrices PD(d,R)={P0:PSym(d,R)}
Siegel–Poincaré upper plane SH(d)=Z=X+iY:XSym(d,R),YPD(d,R)
Siegel–Poincaré disk SD(d)=WSym(d,C):IW¯W0
Distances:
Siegel distance ρU(Z1,Z2)=i=1dlog21+ri1ri
ri=λiR(Z1,Z2)
R(Z1,Z2):=(Z1Z2)(Z1Z¯2)1(Z¯1Z¯2)(Z¯1Z¯2)1
Upper plane metric dsU(Z)=2trY1dZY1dZ¯
PD distance ρPD(P1,P2)=Log(P11P2)F=i=1dlog2λi(P11P2)
PD metric dsPD(P)=tr(P1dP)2
Kobayashi distance ρD(W1,W2)=log1+ΦW1(W2)O1ΦW1(W2)O
Translation in the disk ΦW1(W2)=(IW1W¯1)12(W2W1)(IW¯1W2)1(IW¯1W1)12
Disk distance to origin ρD(0,W)=log1+WO1WO
Siegel–Klein distance ρK(K1,K2)=12logα+(1α)α(α+1),K1K2,0K1=K2
(1α)K1+αK2O=1 (α<0), (1α+)K1+α+K2O=1 (α+>1)
Seigel-Klein distance to 0 ρK(0,K)=12log1+KO1KO
Symplectic maps and groups:
Symplectic map ϕS(Z)=(AZ+B)(CZ+D)1 with SSp(d,R) (upper plane)
ϕS(W) with SSp(d,C) (disk)
Symplectic group Sp(d,F)=ABCD,AB=BA,CD=DC,ADBC=I
A,B,C,DM(d,F)
group composition law matrix multiplication
group inverse law S(1)=:DBCA
Translation in H(d) of Z=A+iB to iI TU(Z)=(B12)0(AB12)(B12)
symplectic orthogonal matrices SpO(2d,R)=ABBA:AA+BB=I,ABSym(d,R)
(rotations in SH(d))
Translation to 0 in SD(d) ΦW1(W2)=(IW1W¯1)12(W2W1)(IW¯1W2)1(IW¯1W1)12
Isom+(S) Isometric orientation-preserving group of generic space S
Moeb(d) group of Möbius transformations

Supplementary Materials

The following are available online at https://franknielsen.github.io/SiegelKlein/.

Appendix A. The Deflation Method: Approximating the Eigenvalues

A matrix MM(d,C) is diagonalizable if there exists a non-singular matrix P and a diagonal matrix Λ=diag(λ1,,λd) such that M=PΛP1. A Hermitian matrix (i.e., M=M*:=M¯) is a diagonalizable self-adjoint matrix which has all real eigenvalues and admits a basis of orthogonal eigenvectors. We can compute all eigenvalues of a Hermitian matrix M by repeatedly applying the (normalized) power method using the so-called deflation method (see [114], Chapter 10, and [115], Chapter 7). The deflation method proceeds iteratively to calculate numerically the (normalized) eigenvalues λi’s and eigenvectors vi’s as follows:

  1. Let l=1 and M1=M.

  2. Initialize at random a normalized vector x0Cd (i.e., x0 on the unit sphere with x0*x0=1)

  3. For j in (0,,Ll1):
    xj+1Mlxjxj+1xj+1xj+1*xj+1
  4. Let vl=xLl and λl=xLl*MlxLl

  5. Let ll+1. If ld then let Ml=Ml1λl1vl1vl1* and goto 2.

The deflation method reports the eigenvalues λi’s such that

|λ1|>|λ2||λd|,

where λ1 is the dominant eigenvalue.

The overall number of normalized power iterations is L=i=1dLi (matrix-vector multiplication), where the number of iterations of the normalized power method at stage l can be defined such that we have |xLlxLl1|ϵ, for a prescribed value of ϵ>0. Notice that the numerical errors of the eigenpairs (λi,vi)’s propagate and accumulate at each stage. That is, at stage l, the deflation method calculates the dominant eigenvector on a residual perturbated matrix Ml. The overall approximation of the eigendecomposition can be appreciated by calculating the last residual matrix:

Mi=1dλivivi*F. (A1)

The normalized power method exhibits linear convergence for diagonalizable matrices and quadratic convergence for Hermitian matrices. Other numerical methods for numerically calculating the eigenvalues include the Krylov subspace techniques [114,115,116].

  • Snippet Code

We implemented our software library and smallest enclosing ball algorithms in Java™.

The code below is a snippet written in Maxima (available in the supplementary material): A computer algebra system, freely downloadable at http://maxima.sourceforge.net/

  • /* Code in Maxima */

  • /* Calculate the Siegel metric distance in the Siegel upper space */

  • load(eigen);

  • /* symmetric */

  • S1: matrix( [0.265,   0.5],

  •     [0.5 , -0.085]);

  • /* positive-definite */

  • P1: matrix( [0.235,   0.048],

  •     [0.048 ,  0.792]);

  • /* Matrix in the Siegel upper space */

  • Z1: S1+%i*P1;

  • S2:  matrix( [-0.329,  -0.2],

  •    [-0.2 , -0.382]);

  • P2: matrix([0.464,   0.289],

  •     [0.289  , 0.431]);

  • Z2: S2+%i*P2;

  • /* Generalized Moebius transformation */

  • R(Z1,Z2) :=

  • ((Z1-Z2).invert(Z1-conjugate(Z2))).((conjugate(Z1)-conjugate(Z2)).invert(conjugate(Z1)-Z2));

  • R12: ratsimp(R(Z1,Z2));

  • ratsimp(R12[2][1]-conjugate(R12[1][2]));

  • /* Retrieve the eigenvalues: They are all reals */

  • r: float(eivals(R12))[1];

  • /* Calculate the Siegel distance */

  • distSiegel: sum(log( (1+sqrt(r[i]))/(1-sqrt(r[i]))  )**2, i, 1, 2);

Funding

This research received no external funding.

Conflicts of Interest

The authors declare no conflict of interest.

References

  • 1.Siegel C.L. Symplectic geometry. Am. J. Math. 1943;65:1–86. doi: 10.2307/2371774. [DOI] [Google Scholar]
  • 2.Hua L.K. On the theory of automorphic functions of a matrix variable I: Geometrical basis. Am. J. Math. 1944;66:470–488. doi: 10.2307/2371910. [DOI] [Google Scholar]
  • 3.Siegel C.L. Einführung in die Theorie der Modulfunktionen n-ten Grades. Math. Ann. 1939;116:617–657. doi: 10.1007/BF01597381. [DOI] [Google Scholar]
  • 4.Blair D.E. Riemannian Geometry of Contact and Symplectic Manifolds. Springer Science & Business Media; Berlin/Heidelberg, Germany: 2010. [Google Scholar]
  • 5.Freitas P.J. Ph.D. Thesis. University of Illinois at Chicago; Chicago, IL, USA: 1999. On the Action of the Symplectic Group on the Siegel upper Half Plane. [Google Scholar]
  • 6.Koufany K. Ph.D. Thesis. Université Henri Poincaré; Nancy, France: 2006. Analyse et Géométrie des Domaines Bornés Symétriques. [Google Scholar]
  • 7.Cartan É. Abhandlungen aus dem Mathematischen Seminar der Universität Hamburg. Volume 11. Springer; Berlin/Heidelberg, Germany: 1935. Sur les domaines bornés homogènes de l’espace de n variables complexes; pp. 116–162. [Google Scholar]
  • 8.Koszul J.L. Exposés sur les Espaces Homogènes Symétriques. Sociedade de Matematica; Rio de Janeiro, Brazil: 1959. [Google Scholar]
  • 9.Berezin F.A. Quantization in complex symmetric spaces. Math. USSR-Izv. 1975;9:341. doi: 10.1070/IM1975v009n02ABEH001480. [DOI] [Google Scholar]
  • 10.Förstner W., Moonen B. Geodesy-the Challenge of the 3rd Millennium. Springer; Berlin/Heidelberg, Germany: 2003. A metric for covariance matrices; pp. 299–309. [Google Scholar]
  • 11.Harandi M.T., Salzmann M., Hartley R. European Conference on Computer Vision. Springer; Cham, Switzerland: 2014. From manifold to manifold: Geometry-aware dimensionality reduction for SPD matrices; pp. 17–32. [Google Scholar]
  • 12.Barbaresco F. Innovative tools for radar signal processing based on Cartan’s geometry of SPD matrices & information geometry; Proceedings of the 2008 IEEE Radar Conference; Rome, Italy. 26–30 May 2008; pp. 1–6. [Google Scholar]
  • 13.Barbaresco F. Robust statistical radar processing in Fréchet metric space: OS-HDR-CFAR and OS-STAP processing in Siegel homogeneous bounded domains; Proceedings of the 12th IEEE International Radar Symposium (IRS); Leipzig, Germany. 7–9 September 2011; pp. 639–644. [Google Scholar]
  • 14.Barbaresco F. Matrix Information Geometry. Springer; Berlin/Heidelberg, Germany: 2013. Information geometry of covariance matrix: Cartan-Siegel homogeneous bounded domains, Mostow/Berger fibration and Fréchet median; pp. 199–255. [Google Scholar]
  • 15.Barbaresco F. Information geometry manifold of Toeplitz Hermitian positive definite covariance matrices: Mostow/Berger fibration and Berezin quantization of Cartan-Siegel domains. Int. J. Emerg. Trends Signal Process. 2013;1:1–11. [Google Scholar]
  • 16.Jeuris B., Vandebril R. The Kähler mean of block-Toeplitz matrices with Toeplitz structured blocks. SIAM J. Matrix Anal. Appl. 2016;37:1151–1175. doi: 10.1137/15M102112X. [DOI] [Google Scholar]
  • 17.Liu C., Si J. Positive Toeplitz operators on the Bergman spaces of the Siegel upper half-space. Commun. Math. Stat. 2019;8:113–134. doi: 10.1007/s40304-019-00187-2. [DOI] [Google Scholar]
  • 18.Chevallier E., Forget T., Barbaresco F., Angulo J. Kernel density estimation on the Siegel space with an application to radar processing. Entropy. 2016;18:396. doi: 10.3390/e18110396. [DOI] [Google Scholar]
  • 19.Burbea J. Informative Geometry of Probability Spaces. Pittsburgh Univ. PA Center; Pittsburgh, PA, USA: 1984. Technical report. [Google Scholar]
  • 20.Calvo M., Oller J.M. A distance between multivariate normal distributions based in an embedding into the Siegel group. J. Multivar. Anal. 1990;35:223–242. doi: 10.1016/0047-259X(90)90026-E. [DOI] [Google Scholar]
  • 21.Calvo M., Oller J.M. A distance between elliptical distributions based in an embedding into the Siegel group. J. Comput. Appl. Math. 2002;145:319–334. doi: 10.1016/S0377-0427(01)00584-2. [DOI] [Google Scholar]
  • 22.Tang M., Rong Y., Zhou J. An information geometric viewpoint on the detection of range distributed targets. Math. Probl. Eng. 2015;2015 doi: 10.1155/2015/930793. [DOI] [Google Scholar]
  • 23.Tang M., Rong Y., Zhou J., Li X.R. Information geometric approach to multisensor estimation fusion. IEEE Trans. Signal Process. 2018;67:279–292. doi: 10.1109/TSP.2018.2879035. [DOI] [Google Scholar]
  • 24.Krefl D., Carrazza S., Haghighat B., Kahlen J. Riemann-Theta Boltzmann machine. Neurocomputing. 2020;388:334–345. doi: 10.1016/j.neucom.2020.01.011. [DOI] [Google Scholar]
  • 25.Ohsawa T. The Siegel upper half space is a Marsden–Weinstein quotient: Symplectic reduction and Gaussian wave packets. Lett. Math. Phys. 2015;105:1301–1320. doi: 10.1007/s11005-015-0780-z. [DOI] [Google Scholar]
  • 26.Froese R., Hasler D., Spitzer W. Transfer matrices, hyperbolic geometry and absolutely continuous spectrum for some discrete Schrödinger operators on graphs. J. Funct. Anal. 2006;230:184–221. doi: 10.1016/j.jfa.2005.04.004. [DOI] [Google Scholar]
  • 27.Ohsawa T., Tronci C. Geometry and dynamics of Gaussian wave packets and their Wigner transforms. J. Math. Phys. 2017;58:092105. doi: 10.1063/1.4995233. [DOI] [Google Scholar]
  • 28.Lenz R. Siegel Descriptors for Image Processing. IEEE Signal Process. Lett. 2016;23:625–628. doi: 10.1109/LSP.2016.2542850. [DOI] [Google Scholar]
  • 29.Richter-Gebert J. Perspectives on Projective Geometry: A Guided Tour through Real and Complex Geometry. Springer Science & Business Media; Berlin/Heidelberg, Germany: 2011. [Google Scholar]
  • 30.Hilbert D. Über die gerade Linie als kürzeste Verbindung zweier Punkte (About the straight line as the shortest connection between two points) Math. Ann. 1895;46:91–96. doi: 10.1007/BF02096204. [DOI] [Google Scholar]
  • 31.Papadopoulos A., Troyanov M. Handbook of Hilbert Geometry, Volume 22 of IRMA Lectures in Mathematics and Theoretical Physics. European Mathematical Society (EMS); Zürich, Switzerland: 2014. [Google Scholar]
  • 32.Liverani C., Wojtkowski M.P. Generalization of the Hilbert metric to the space of positive definite matrices. Pac. J. Math. 1994;166:339–355. doi: 10.2140/pjm.1994.166.339. [DOI] [Google Scholar]
  • 33.Boissonnat J.D., Yvinec M. Algorithmic Geometry. Cambridge University Press; Cambridge, UK: 1998. [Google Scholar]
  • 34.Nielsen F., Nock R. Hyperbolic Voronoi diagrams made easy; Proceedings of the 2010 IEEE International Conference on Computational Science and Its Applications; Fukuoka, Japan. 23–26 March 2010; pp. 74–80. [Google Scholar]
  • 35.Nielsen F., Muzellec B., Nock R. Classification with mixtures of curved Mahalanobis metrics; Proceedings of the 2016 IEEE International Conference on Image Processing (ICIP); Phoenix, AZ, USA. 25–28 September 2016; pp. 241–245. [Google Scholar]
  • 36.Nielsen F., Nock R. Visualizing hyperbolic Voronoi diagrams; Proceedings of the Thirtieth Annual Symposium on Computational Geometry; Kyoto, Japan. 8–11 June 2014; pp. 90–91. [Google Scholar]
  • 37.Nielsen F., Nock R. The hyperbolic Voronoi diagram in arbitrary dimension. arXiv. 20121210.8234 [Google Scholar]
  • 38.Angulo J., Velasco-Forero S. Geometric Theory of Information. Springer; Berlin/Heidelberg, Germany: 2014. Morphological processing of univariate Gaussian distribution-valued images based on Poincaré upper-half plane representation; pp. 331–366. [Google Scholar]
  • 39.Tavallaee M., Lu W., Iqbal S.A., Ghorbani A.A. A novel covariance matrix based approach for detecting network anomalies; Proceedings of the 6th IEEE Annual Communication Networks and Services Research Conference (cnsr 2008); Halifax, NS, Canada. 5–8 May 2008; pp. 75–81. [Google Scholar]
  • 40.Cont A., Dubnov S., Assayag G. On the information geometry of audio streams with applications to similarity computing. IEEE Trans. Audio Speech Lang. Process. 2010;19:837–846. doi: 10.1109/TASL.2010.2066266. [DOI] [Google Scholar]
  • 41.Mazumdar A., Polyanskiy Y., Saha B. On Chebyshev radius of a set in hamming space and the closest string problem; Proceedings of the 2013 IEEE International Symposium on Information Theory; Istanbul, Turkey. 7–12 July 2013; pp. 1401–1405. [Google Scholar]
  • 42.Welzl E. New Results and New Trends in Computer Science. Springer; Berlin/Heidelberg, Germany: 1991. Smallest enclosing disks (balls and ellipsoids) pp. 359–370. [Google Scholar]
  • 43.Nielsen F., Hadjeres G. Proceedings of the International Conference on Geometric Science of Information, Palaiseau, France, 28–30 October 2015. Springer; Berlin/Heidelberg, Germany: 2015. Approximating covering and minimum enclosing balls in hyperbolic geometry; pp. 586–594. [Google Scholar]
  • 44.Lang S. Math Talks for Undergraduates. Springer Science & Business Media; Berlin/Heidelberg, Germany: 2012. [Google Scholar]
  • 45.Nielsen F., Bhatia R. Matrix Information Geometry. Springer; Berlin/Heidelberg, Germany: 2013. [Google Scholar]
  • 46.Arnaudon M., Nielsen F. On approximating the Riemannian 1-center. Comput. Geom. 2013;46:93–104. doi: 10.1016/j.comgeo.2012.04.007. [DOI] [Google Scholar]
  • 47.Badoiu M., Clarkson K.L. Smaller core-sets for balls; Proceedings of the Fourteenth Annual ACM-SIAM Symposium on Discrete Algorithms; Baltimore, MD, USA. 12–14 January 2003; Philadelphia, PA, USA: Society for Industrial and Applied Mathematics; 2003. pp. 801–802. [Google Scholar]
  • 48.Tsang I.H., Kwok J.Y., Zurada J.M. Generalized core vector machines. IEEE Trans. Neural Netw. 2006;17:1126–1140. doi: 10.1109/TNN.2006.878123. [DOI] [PubMed] [Google Scholar]
  • 49.Paulsen V.I., Raghupathi M. An Introduction to the Theory of Reproducing Kernel Hilbert Spaces. Volume 152 Cambridge University Press; Cambridge, UK: 2016. [Google Scholar]
  • 50.Nielsen F., Nock R. Computational Information Geometry. Springer; Berlin/Heidelberg, Germany: 2017. Fast (1+ϵ)-Approximation of the Löwner Extremal Matrices of High-Dimensional Symmetric Matrices; pp. 121–132. [Google Scholar]
  • 51.Moakher M. A differential geometric approach to the geometric mean of symmetric positive-definite matrices. SIAM J. Matrix Anal. Appl. 2005;26:735–747. doi: 10.1137/S0895479803436937. [DOI] [Google Scholar]
  • 52.Niculescu C., Persson L.E. Convex Functions and Their Applications: A Contemporary Approach. 2nd ed. Springer Science & Business Media; Berlin/Heidelberg, Germany: 2018. [Google Scholar]
  • 53.Lanczos C. An Iteration Method for the Solution of the Eigenvalue Problem of Linear Differential and Integral Operators1. J. Res. Natl. Bur. Stand. 1950;45:255–282. doi: 10.6028/jres.045.026. [DOI] [Google Scholar]
  • 54.Cullum J.K., Willoughby R.A. Lanczos Algorithms for Large Symmetric Eigenvalue Computations: Vol. 1: Theory. Volume 41 SIAM; Philadelphia, PA, USA: 2002. [Google Scholar]
  • 55.Cannon J.W., Floyd W.J., Kenyon R., Parry W.R. Hyperbolic geometry. Flavors Geom. 1997;31:59–115. [Google Scholar]
  • 56.Goldman W.M. Complex Hyperbolic Geometry. Oxford University Press; Oxford, UK: 1999. [Google Scholar]
  • 57.Amari S.I. Information Geometry and Its Applications. Volume 194 Springer; Berlin/Heidelberg, Germany: 2016. [Google Scholar]
  • 58.Nielsen F. An elementary introduction to information geometry. arXiv. 2018 doi: 10.3390/e22101100.1808.08271 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 59.Ratcliffe J.G. Foundations of Hyperbolic Manifolds. Volume 3 Springer; Berlin/Heidelberg, Germany: 1994. [Google Scholar]
  • 60.Jin M., Gu X., He Y., Wang Y. Conformal Geometry: Computational Algorithms and Engineering Applications. Springer; Berlin/Heidelberg, Germany: 2018. [Google Scholar]
  • 61.Hotelling H. Spaces of statistical parameters. Bull. Am. Math. Soc. 1930;36:191. [Google Scholar]
  • 62.Rao C.R. Information and accuracy attainable in the estimation of statistical parameters. Bull Calcutta. Math. Soc. 1945;37:81–91. [Google Scholar]
  • 63.Nielsen F. Connected at Infinity II. Springer; Berlin/Heidelberg, Germany: 2013. Cramér-Rao lower bound and information geometry; pp. 18–37. [Google Scholar]
  • 64.Sun K., Nielsen F. Relative Fisher information and natural gradient for learning large modular models; Proceedings of the International Conference on Machine Learning; Sydney, Australia. 6–11 August 2017; pp. 3289–3298. [Google Scholar]
  • 65.Komaki F. Bayesian prediction based on a class of shrinkage priors for location-scale models. Ann. Inst. Stat. Math. 2007;59:135–146. doi: 10.1007/s10463-006-0102-4. [DOI] [Google Scholar]
  • 66.Namikawa Y. Toroidal Compactification of Siegel Spaces. Springer; Berlin/Heidelberg, Germany: 1980. The Siegel upperhalf plane and the symplectic group; pp. 1–6. [Google Scholar]
  • 67.Riemann B. Theorie der Abel’schen Functionen. J. Für Die Reine Und Angew. Math. 1857;54:101–155. [Google Scholar]
  • 68.Riemann B. Über das Verschwinden der Theta-Functionen. Borchardt’s [= Crelle’s] J. Für Reine Und Angew. Math. 1865;65:214–224. [Google Scholar]
  • 69.Swierczewski C., Deconinck B. Computing Riemann Theta functions in Sage with applications. Math. Comput. Simul. 2016;127:263–272. doi: 10.1016/j.matcom.2013.04.018. [DOI] [Google Scholar]
  • 70.Agostini D., Chua L. Computing Theta Functions with Julia. arXiv. 20191906.06507 [Google Scholar]
  • 71.Agostini D., Améndola C. Discrete Gaussian distributions via theta functions. SIAM J. Appl. Algebra Geom. 2019;3:1–30. doi: 10.1137/18M1164937. [DOI] [Google Scholar]
  • 72.Bucy R., Williams B. A matrix cross ratio theorem for the Riccati equation. Comput. Math. Appl. 1993;26:9–20. doi: 10.1016/0898-1221(93)90030-Y. [DOI] [Google Scholar]
  • 73.Mackey D.S., Mackey N. On the Determinant of Symplectic Matrices. Manchester Centre for Computational Mathematics; Manchester, UK: 2003. [Google Scholar]
  • 74.Rim D. An elementary proof that symplectic matrices have determinant one. Adv. Dyn. Syst. Appl. (ADSA) 2017;12:15–20. [Google Scholar]
  • 75.Hua L.K. Geometries of matrices. II. Study of involutions in the geometry of symmetric matrices. Trans. Am. Math. Soc. 1947;61:193–228. doi: 10.2307/1990217. [DOI] [Google Scholar]
  • 76.Wan Z., Hua L. Geometry of matrices. World Scientific; Singapore: 1996. [Google Scholar]
  • 77.Clerc J.L. Proceedings of the Tenth International Conference on Geometry, Integrability and Quantization, Varna, Bulgaria, 6–11 June 2008. Institute of Biophysics and Biomedical Engineering, Bulgarian Academy; Varna, Bulgaria: 2009. Geometry of the Shilov boundary of a bounded symmetric domain; pp. 11–55. [Google Scholar]
  • 78.Freitas P.J., Friedland S. Revisiting the Siegel upper half plane II. Linear Algebra Its Appl. 2004;376:45–67. doi: 10.1016/j.laa.2003.06.001. [DOI] [Google Scholar]
  • 79.Bassanelli G. On horospheres and holomorphic endomorfisms of the Siegel disc. Rend. Del Semin. Mat. Della Univ. Padova. 1983;70:147–165. [Google Scholar]
  • 80.Kobayashi S. Invariant distances on complex manifolds and holomorphic mappings. J. Math. Soc. Jpn. 1967;19:460–480. doi: 10.2969/jmsj/01940460. [DOI] [Google Scholar]
  • 81.Carathéodory C. Uber eine spezielle Metrik, die in der Theorie der analytischen Funktionen auftritt. Atti Pontif. Acad. Sc. Nuovi Lincei. 1927;80:135–141. [Google Scholar]
  • 82.Sra S. On the matrix square root via geometric optimization. arXiv. 2015 doi: 10.13001/1081-3810.3196.1507.08366 [DOI] [Google Scholar]
  • 83.Mitchell J. Potential theory in the geometry of matrices. Trans. Am. Math. Soc. 1955;79:401–422. doi: 10.1090/S0002-9947-1955-0072242-6. [DOI] [Google Scholar]
  • 84.Rong F. Non-diagonal holomorphic isometric embeddings of the Poincaré disk into the Siegel upper half-plane. Asian J. Math. 2018;22:665–672. doi: 10.4310/AJM.2018.v22.n4.a3. [DOI] [Google Scholar]
  • 85.Beardon A. The Klein, Hilbert and Poincaré metrics of a domain. J. Comput. Appl. Math. 1999;105:155–162. doi: 10.1016/S0377-0427(99)00012-6. [DOI] [Google Scholar]
  • 86.Nielsen F., Sun K. Clustering in Hilbert’s Projective Geometry: The Case Studies of the Probability Simplex. Geom. Struct. Inf. 2018:297–331. [Google Scholar]
  • 87.Nielsen F., Shao L. On Balls in a Hilbert Polygonal Geometry (Multimedia Contribution); Proceedings of the 33rd International Symposium on Computational Geometry (SoCG 2017); Brisbane, Australia. 4–7 July 2017; Wadern, Germany: Schloss Dagstuhl-Leibniz-Zentrum fuer Informatik; 2017. [Google Scholar]
  • 88.Klein F. Über die sogenannte nicht-Euklidische Geometrie. Math. Ann. 1873;6:112–145. doi: 10.1007/BF01443189. [DOI] [Google Scholar]
  • 89.Beltrami E. Saggio di interpretazione della geometria non-euclidea. G. Mat. 1868;IV:284. [Google Scholar]
  • 90.Cayley A. A sixth memoir upon quantics. Philos. Trans. R. Soc. Lond. 1859;149:61–90. [Google Scholar]
  • 91.De La Harpe P. On Hilbert’s metric for simplices. Geom. Group Theory. 1993;1:97–119. [Google Scholar]
  • 92.Marsaglia G. Bounds for the Rank of the Sum of Two Matrices. BOEING SCIENTIFIC RESEARCH LABS; Seattle, WA, USA: 1964. Technical report. [Google Scholar]
  • 93.Speer T. Isometries of the Hilbert metric. arXiv. 20141411.1826 [Google Scholar]
  • 94.El Ghaoui L., Niculescu S.L. Advances in Linear Matrix Inequality Methods in Control. SIAM; Philadelphia, PA, USA: 2000. [Google Scholar]
  • 95.Bustamante M.D., Mellon P., Velasco M. Solving the problem of simultaneous diagonalisation via congruence. arXiv. 20191908.04228 [Google Scholar]
  • 96.Kuczyński J., Woźniakowski H. Estimating the largest eigenvalue by the power and Lanczos algorithms with a random start. SIAM J. Matrix Anal. Appl. 1992;13:1094–1122. doi: 10.1137/0613066. [DOI] [Google Scholar]
  • 97.Higham N.J., Al-Mohy A.H. Computing matrix functions. Acta Numer. 2010;19:159–208. doi: 10.1017/S0962492910000036. [DOI] [Google Scholar]
  • 98.Li Y., Woodruff D.P. Approximation, Randomization, and Combinatorial Optimization. Algorithms and Techniques (APPROX/RANDOM) Schloss Dagstuhl-Leibniz-Zentrum fuer Informatik; Wadern, Germany: 2016. Tight bounds for sketching the operator norm, Schatten norms, and subspace embeddings. [Google Scholar]
  • 99.Nock R., Nielsen F. Proceedings of the European Conference on Machine Learning, Porto, Portugal, 3–7 October 2005. Springer; Berlin/Heidelberg, Germany: 2005. Fitting the smallest enclosing Bregman ball; pp. 649–656. [Google Scholar]
  • 100.Nielsen F., Nock R. On approximating the smallest enclosing Bregman balls; Proceedings of the Twenty-Second Annual Symposium on Computational Geometry; Sedona, AZ, USA. 5–7 June 2006; pp. 485–486. [Google Scholar]
  • 101.Nielsen F., Boissonnat J.D., Nock R. Visualizing Bregman Voronoi diagrams; Proceedings of the Twenty-Third Annual Symposium on Computational Geometry; Gyeongju, Korea. 6–8 June 2007; pp. 121–122. [Google Scholar]
  • 102.Boissonnat J.D., Nielsen F., Nock R. Bregman Voronoi diagrams. Discret. Comput. Geom. 2010;44:281–307. doi: 10.1007/s00454-010-9256-1. [DOI] [Google Scholar]
  • 103.Bougerol P. Kalman filtering with random coefficients and contractions. SIAM J. Control. Optim. 1993;31:942–959. doi: 10.1137/0331041. [DOI] [Google Scholar]
  • 104.Fletcher P.T., Moeller J., Phillips J.M., Venkatasubramanian S. Workshop on Algorithms and Data Structures. Springer; Berlin/Heidelberg, Germany: 2011. Horoball hulls and extents in positive definite space; pp. 386–398. [Google Scholar]
  • 105.Bhatia R. Positive Definite Matrices. Volume 24 Princeton University Press; Princeton, NJ, USA: 2009. [Google Scholar]
  • 106.Bruhat F., Tits J. Groupes réductifs sur un corps local: I. Données radicielles valuées. Publ. Math. De L’IHÉS. 1972;41:5–251. doi: 10.1007/BF02715544. [DOI] [Google Scholar]
  • 107.Mostajeran C., Grussler C., Sepulchre R. Proceedings of the International Conference on Geometric Science of Information, Toulouse, France, 27–29 August 2019. Springer; Berlin/Heidelberg, Germany: 2019. Affine-Invariant Midrange Statistics; pp. 494–501. [Google Scholar]
  • 108.Helgason S. Differential Geometry, Lie Groups, and Symmetric Spaces. Academic Press; Cambridge, MA, USA: 1979. [Google Scholar]
  • 109.Andai A. Ph.D. Thesis. BUTE; Dhaka, Bangladesh: 2004. Information geometry in quantum mechanics. (In Hungarian) [Google Scholar]
  • 110.Angulo J. Structure tensor image filtering using Riemannian L1 and L∞ center-of-mass. Image Anal. Stereol. 2014;33:95–105. doi: 10.5566/ias.v33.p95-105. [DOI] [Google Scholar]
  • 111.D’Atri J., Dotti Miatello I. A characterization of bounded symmetric domains by curvature. Trans. Am. Math. Soc. 1983;276:531–540. doi: 10.1090/S0002-9947-1983-0688960-X. [DOI] [Google Scholar]
  • 112.Nielsen F., Piro P., Barlaud M. Bregman vantage point trees for efficient nearest neighbor queries; Proceedings of the 2009 IEEE International Conference on Multimedia and Expo; New York, NY, USA. 28 June–3 July 2009; pp. 878–881. [Google Scholar]
  • 113.Hua L.K. The estimation of the Riemann curvature in several complex variables. Acta Math. Sin. Chin. Ser. 1954;4:143–170. [Google Scholar]
  • 114.Loehr N. Advanced Linear Algebra. CRC Press; Boca Raton, FL, USA: 2014. [Google Scholar]
  • 115.Izaac J., Wang J. Computational Quantum Mechanics. Springer; Berlin/Heidelberg, Germany: 2018. [Google Scholar]
  • 116.Sun J., Zhou A. Finite Element Methods for Eigenvalue Problems. CRC Press; Boca Raton, FL, USA: 2016. [Google Scholar]

Articles from Entropy are provided here courtesy of Multidisciplinary Digital Publishing Institute (MDPI)

RESOURCES