Expand this Topic clickable element to expand a topic
Skip to content
Optica Publishing Group

Fast wave-front reconstruction by solving the Sylvester equation with the alternating direction implicit method

Open Access Open Access

Abstract

Large degree-of-freedom real-time adaptive optics (AO) control requires reconstruction algorithms that are computationally efficient and readily parallelized for hardware implementation. In particular, we find the wave-front reconstruction for the Hudgin and Fried geometry can be cast into a form of the well-known Sylvester equation using the Kronecker product properties of matrices. We derive the filters and inverse filtering formulas for wave-front reconstruction in two-dimensional (2-D) Discrete Cosine Transform (DCT) domain for these two geometries using the Hadamard product concept of matrices and the principle of separable variables. We introduce a recursive filtering (RF) method for the wave-front reconstruction on an annular aperture, in which, an imbedding step is used to convert an annular-aperture wave-front reconstruction into a square-aperture wave-front reconstruction, and then solving the Hudgin geometry problem on the square aperture. We apply the Alternating Direction Implicit (ADI) method to this imbedding step of the RF algorithm, to efficiently solve the annular-aperture wave-front reconstruction problem at cost of order of the number of degrees of freedom, O(n). Moreover, the ADI method is better suited for parallel implementation and we describe a practical real-time implementation for AO systems of order 3,000 actuators.

©2004 Optical Society of America

1. Introduction

Adaptive optics is an ideal technology developed for compensation of aberrations in optical systems or due to atmospheric turbulence to achieve unprecedented quality of astronomical observations and measurements. Wave-front reconstructors are an indispensable element of most AO systems. Whatever configuration used in these systems, such as extreme AO or multi-conjugate AO, fast and efficient algorithms allowing for hardware implementations are required to realize real time reconstruction and control for future giant telescope [1].

The most commonly used geometries for wave-front reconstruction are Hudgin and Fried geometries [23]. We will consider both geometries and develop a new wave-front reconstruction algorithm - the RF algorithm. Freischalad et al [4] have used the 2-D discrete Fourier transform (DFT) domain filtering method to perform wave-front estimation for various types of wave-front slope sampling geometry on a rectangular aperture, and Poyneer et al [5] have demonstrated further this algorithm using a curl-free boundary method to reduce the period boundary error, and derived a 2-D inverse filtering formula in the DFT domain for the Fried geometry. These algorithms scale as O(nlogn) when implemented with fast Fourier transforms, where n is the degree of the freedom for the wave-front sensor. Gilles et al [6] have described an O(nlog n) multigrid preconditioned conjugate gradient method, as well as an O(n) sparse minimum-variance open-loop wave-front reconstructor based on multigrid preconditioning with a symmetrical Gauss-Seidel smoothing function [7]. MacMartin [8] has proposed hierarchic iterative wave-front reconstructors which scale linearly using a local influence function assumption. Shi et al have validated them experimentally at Palomar Observatory [9].

The fundamental algebraic structure of the wave-front reconstruction problem for the Hudgin geometry has been studied using a matrix representation and the least square principle by Hunt [10]. However, the reconstructor he developed is slow due to the particular iterative methods he adopted. By casting the reconstruction problem into the language of traditional image processing, we can create fast algorithms that have been specifically designed for astronomical adaptive optics systems, and overcome this limitation. In this theoretical context, we write the gradient matrix into a Kronecker product [11] form and use it with the least square wave-front reconstructor to derive a novel reconstructor formulated as the Sylvester Equation. We then derive the inverse filtering formulas in the 2-D DCT domain for the Hudgin and Fried geometries wavefront reconstruction using the spectral theorem for symmetrical real matrices [12, 15], the Hadamard product definition of matrices [11], and the principle of separation of variables. We have recently developed a RF algorithm [12]. In this algorithm, we exploited an imbedding step to change the annular-aperture wave-front reconstruction problem for the Fried geometry to a square-aperture wave-front reconstruction problem for the Hudgin geometry, and then the square-aperture wave-front reconstruction problem was solved by the method of inverse filtering performed in the 2-D DCT domain and the multigrid method performed in the original image domain. The RF algorithm developed there scales as O(nlogn) and O(n) respectively when these two methods are used. In this investigation, we extend the RF algorithm by combining the square-aperture wave-front reconstructor based on the Sylvester equation with the RF algorithm, and then we solve the imbedding step in the RF algorithm using both ADI method [13] and exact Bartels-Stewart (BS) method [14]. We show that the ADI method is an O(n) method, and compare the performance of both the ADI and the BS methods by simulating the wave-front reconstruction process for a large adaptive optics system using the Monte Carlo method. We will not consider the phase branch-point problem here, but it is a problem that needs to be solved when adaptive optics is used in the airborne laser and laser communication systems.

2. The Sylvester equation for wave-front reconstruction on a square aperture

We will solve the following wave-front slope measurement equation for a single-conjugate adaptive optics system [10],

s=Pϕ+η,

where s is the wave-front phase difference vector, which is calculated from the centroid measurements in the subapertures of a Shack-Hartmann wave-front sensor (and interpreted according to the assuming sensor geometry), ϕ is the incident wave-front phase vector, η is a vector representing noise on the slopes measurement. The matrix P is the influence matrix representing the gradient operator that transforms phase into phase difference. For convenience, the vectors s, ϕ and η are arranged in a lexicographical order along the row direction of the corresponding 2-D images as described in Ref. [10]. The least squares estimation of Eq. (1) is equivalent to solving the following equation [10],

PTPϕ=PTs.

The matrix P can be expressed with two partitions,

P=[P1P2],

where P 1 and P 2 are sparse phase difference matrices along the x and y directions respectively. In this study, we concentrate mainly on the algebraic structure of the left-hand side of the Eq. (2). The right-hand side can be calculated directly using sparse matrix technique, though we will find it convenient to rewrite this as

r=PTs=P1Tsx+P2Tsy,

where sx and sy are wave-front phase differences along the row and column directions respectively.

We will derive the Sylvester equation for wave-front reconstruction using Eq. (2) with the wave-front phase ϕ defined on a N×N square-aperture sampling grid as defined in Ref. [10], for two different sensor geometries, those introduced by Hudgin [2] and Fried [3].

2.1 The Hudgin geometry

Assuming we solve Eq. (1) for the Hudgin geometry, we can write P 1 and P 2 in Eq. (3) as the following form,

P1=ID1,
P2=D1I,

in which, ⊗ is the Kronecker product [11]. For a matrix Y of size m×n and a matrix Z of size j×k, YZ is defined as

YZ=[y11Zy12Zy1nZy21Zy22Zy2nZym1Zym2ZymnZ],

YZ is seen to be a matrix of size mj×nk. In Eq. (5), I is an identity matrix of order N, and the matrix D 1 is a 1-D phase difference matrix of size (N-1)×N for the Hudgin geometry [10],

D1=[11111111].

From equations (3) and (5), we obtain

PTP=(ID1)T(ID1)+(D1I)T(D1I).

Using the transpose property of the Kronecker product [11],

(YZ)T=YTZT,

and its mixed product property [11],

(YZ)(WX)=(YW)(ZX),

we can rewrite Eq. (8) as,

PTP=IA+AI,

where A=D1T D 1, is a matrix of size N×N having the following form [10],

A=[1112112111].

This matrix is a tridiagonal matrix obtained from the 1-D central second differences. From Eq. (2) and (4), we immediately find that the least squares solution of the wave-front estimation Eq. (1) is equivalent to solution of the following equation in Kronecker product form,

(IA+AI)ϕ=r.

For compactness, we now define the vec operator as [11]

vecA=[a1a2aN],

which creates a large column vector from matrix A by stacking together all of its column vectors. The vec operator therefore reorders an image in a lexicographical order along the column direction. Because we previously defined ϕ and r to be vectors formed by stacking the represented images in a lexicographical order along their row direction, therefore from Eq. (13), we obtain the following representation of Eq. (2),

(IA+AI)vec(ΦT)=vec(RT),

where Φ and R are 2-D matrices of size N×N representing the solution and residue images respectively, and with the image matrix row and column index defined as in Ref. [10]. From Eq. (15), using the symmetry properties of A and the vec operator property of the Kronecker product [11] defined as

vec(AYB)=(BTA)vecY,

we finally obtain the following Sylvester equation for the wave-front reconstruction problem assuming a Hudgin geometry,

AΦ+ΦA=R.

This form of equation is also sometimes referred to as a Lyapunov equation.

2.2 The Fried geometry

We use a similar method as above to derive the Sylvester equation for wave-front reconstruction on an N×N square-aperture sampling grid for the Fried sensor geometry. However, to account for the character of the Fried geometry, we introduce a 1-D interpolation matrix F of size (N-1)×N as follows,

F=[0.50.50.50.50.50.50.50.5].

We use the Kronecker product technique along the row and column directions for the Fried geometry, and then we find that P 1 and P 2 in Eq. (3) have the following forms,

P1=FD1,
P2=D1F,

where matrix D 1 is the same (N-1)×N matrix as in Eq. (7) for the Hudgin geometry. The matrices P 1 and P 2 are sparse phase difference matrices along the row and column directions respectively for the Fried geometry. From Eq. (3) and (19), we obtain

PTP=(FD1)T(FD1)+(D1F)T(D1F).

Once again, using the transpose property and mixed product property of Kronecker product as in Eq. (9) and (10), we obtain

PTP=HA+AH,

in which, H=FT F is a matrix of size N × N, having the following form

H=14[1112112111],

and the matrix A takes the same form as in Eq. (12). From Eq. (2) and (4), we immediately find the following Kronecker product form of the wave-front estimation equation,

(HA+AH)ϕ=r.

Using the vec operator definition in Eq. (14), and the procedures described in the previous subsection, we obtain the generalized Sylvester equation for the Fried-geometry wave-front reconstruction as

AΦH+HΦA=R,

in which, Φ and R are the matrices representing solution and residue images as described in previous subsection for those in Eq. (17).

3. Solution of the Sylvester equation for wave-front reconstruction in 2-D DCT domain

Several computationally efficient techniques for solving Eq. (17) and (24) are available. In this section, we derive the Hudgin and Fried Filters formulas and the filtering relationship in 2-D DCT domain for the wave-front reconstruction on a square aperture.

3.1 DCT and the Hudgin filter for the Hudgin geometry

An efficient fast transform method for solving the Sylvester Equation (17), corresponding to the Hudgin geometry, can be derived by exploiting the spectral theorem for real symmetrical matrices [12, 15], and the fact that matrix A in Eq. (12) is real symmetric. Accordingly, we know that A can be diagonalized by an orthonormal real matrix M of size N×N, such that,

A=MΛAMT.

Substituting Eq. (25) into (17) and using the definition of an orthonormal real matrix, namely that M -1=MT or MMT =MTM=I, we obtain

ΛAMTΦM+MTΦMΛA=MTRM.

In the real orthonormal matrix M, every column is a real orthonormal eigenvector (basis) of matrix A, and matrix ΛA is a real eigenvalue matrix whose every diagonal value is a real eigenvalue of matrix A, we call it the spectrum matrix (or spectrum) of matrix A.

On the right-hand side of Eq. (26), right multiplication of R with a transform matrix M is equivalent to transforming it with respect to its rows; left multiplication of R with a transposed transform matrix MT is equivalent to transforming it with respect to its columns. According to the property of the separable transform [16], the right-hand side is just a 2-D orthonormal transform of R, but implemented by applying two 1-D orthonormal transforms to its rows and columns sequentially. Applying the same argument to the left-hand side of Eq. (26), we know MTΦ M is also equivalent to a 2-D orthonormal transform of the wave-front image Φ into a spectral image in this transform domain. The left multiplication of MTΦ M by ΛA is equivalent to multiplying every row of the 2-D spectrum with the eigenvalue in the corresponding row of matrix ΛA . The right multiplication of MTΦ M by ΛA is equivalent to multiplying every column of the 2-D spectrum with the eigenvalue in the corresponding column of matrix ΛA , so we can write Eq. (26) as,

(λuT+uλT)(MTΦM)=MTRM,

where u=[1, 1, …, 1] T , is a column vector of size N full of ones in it; and λ=diag(ΛA ), is a column vector of size N, obtained from the diagonal of the eigenvalue matrix; and the symbol ∘ represents the Hadamard product [11], which is a entrywise product defined as (YZ) ij =Yij * Zij for matrix Y and Z. We can see from Eq. (27) that its left-hand side is an entrywise multiplication of two matrices. We can solve for Φ by first dividing the spectral image MT R M by the filter image λuT + T entrywisely, and then transform the result back into the original domain by an inverse 2-D orthonormal transform. The solution process is represented by the following equation,

Φ=M(MTRMλuT+uλT)MT=M(MTRMTH)MT.

We refer to (TH )-1 as the Hudgin filter in a 2-D orthonormal transform domain. In order to solve equation (28), we need to know λ and M. From Ref. [16], matrix A in Eq. (12) is the inverse of the covariance matrix of the Markov-1 signal when the adjacent correlation coefficient ρ approaching to 1. However, from physical interpretation, matrix A is also the Laplacian matrix corresponding to the 1-D central second differences, therefore from these two perspectives, we know that matrix A can be diagonalized by the 1-D DCT matrix M, whose elements are defined as

Mmn=2Nκmcos[m(2n+1)π2N],(m,n=0,1,,N1),

in which, κm =1/√2 for m=0, otherwise κm =1. This transform matrix is an orthonormal matrix, in which every column vector is an eigenvector of matrix A, the eigenvalues correspondingly are defined as

λm=4sin2(mπ2N),(m=0,1,,N1),

for the eigenvalue column vector λ. From the above equation, the filter, λuT + T , can be rewritten as,

TmnH=4[sin2(mπ2N)+sin2(2N)],(m,n=0,1,,N1).

The 2-D Hudgin filter (TH )-1 is obtained using an element-by-element inverse of the filter image TmnH in the above equation. Because T00H corresponds to the piston mode, we suppress this singular value by assigning a zero value to the corresponding zero frequency component of the 2-D Hudgin filter.

The wave-front reconstruction Eq. (28), describes the following procedure:

∙ 2-D DCT the right-hand-side image R to obtain the spectrum image

∙ Multiply the spectrum image with the (pre-computed) 2-D Hudgin filter

∙ Recover the original wave-front by another inverse 2-D DCT transform.

The 2-D DCT transform and its inverse can be implemented using fast methods described in Ref. [16]. According to the principle of separation of variables, we can reduces the 2-D DCT transform to two 1-D DCT transforms, which means that the 2-D DCT transform can be implemented using 1-D FFT with computation cost scales as O(nlogn) when exploiting the relationship between DCT and DFT described in Ref. [16].

3.2 DCT and the Fried filter for the Fried geometry

For the Fried geometry, there is no exact transform filtering relationship as that obtained for the Hudgin geometry above. Deriving the filtering relationship for Fried-geometry wave-front reconstruction from Eq. (24) is more complex than that for the Hudgin geometry. Because the matrices A and H don’t satisfy the commutative relationship AH=HA, they can not be diagonalized by the same orthonormal transform matrix. Therefore, we can not find an exact 2-D filtering relationship for the Fried geometry, but an approximate one from the properties of matrix H. Matrix H can be exactly diagonalized by the following matrix S, whose elements are defined as

Smn=2Nκmsin[(m+1)(2n+1)π2N],(m,n=0,1,,N1),

where κm =1/√2 for m=N-1, otherwise κm =1. This orthonormal transform matrix is the 1-D Discrete Sine Transform (DST) matrix [16], while the elements of the eigenvalue vector σ for matrix H are

σm=cos2[(m+1)π2N],(m=0,1,,N1).

The above DST matrix and the DCT matrix in Eq. (29) are not commutative, in order to find a filtering relationship as in Eq. (28), we need to compromise the requirement of exact commutative relationship as above. Fortunately, the matrix H can be approximately diagonalized by the 1-D DCT matrix M, which means that we can obtain an approximate filtering relationship for the Fried geometry. The elements of the approximate eigenvalue vector corresponding to 1-D DCT transform matrix M are,

τm=cos2(mπ2N),(m=0,1,,N1).

Therefore we can approximately write H as

H=MΛHMT.

Substituting Eq. (25) and (35) into (24), using the same procedures as described in the above subsection for the Hudgin geometry, we can obtain the filtering relationship in the 2-D DCT domain for Fried-geometry wave-front reconstruction,

Φ=M(MTRMλτT+τλT)MT.

In 2-D DCT domain, the denominator of the above equation λτT + τλT can be rewritten as

TmnF=4[sin2(mπ2N)cos2(nπ2N)+sin2(nπ2N)cos2(mπ2N)],
(m,n=0,1,,N1).

The 2-D Fried filter is obtained using an element by element inverse of the image TmnF in the above equation. Because T00F and TN1N1F correspond to the piston and waffle modes respectively, we suppress these singular values by assigning zero values to the corresponding grid points in the 2-D Fried filter.

The wave-front reconstruction for the Fried geometry can be performed using the same procedures described at the end of the last subsection for the Hudgin geometry. The 2-D DCT inverse filtering can also be combined with a regularization scheme to take into account the prior covariance information of the atmospheric turbulence and the noise of the wave-front slopes measurement. In another work of ours [12], this regularization scheme was discussed and the cost of this filtering method was shown scales as O(n log n). We will next develop a faster method to solve the Sylvester Equation (17) and (24) for wave-front reconstruction on an annular aperture using the RF algorithm found recently by us.

4. RF algorithm

Most telescope entrance pupils take on an annular shape. Thus, we must in general find ways to solve the wave-front reconstruction problem on an annular aperture. The strategy we adopt here is to embed the desired annular aperture in a square aperture to allow application of standard fast methods for solution of the Sylvester Equation (17) and (24).

The RF algorithm for open-loop wavefront reconstruction is described in the flowchart shown in Fig. 1. In this flowchart, x 0 and on are the initializing solution and null vectors of size n respectively; G is the gradient matrix generated on an annular aperture using the corresponding annular versions of Eq. (3) and (19) for the Fried geometry, or those of Eq. (3) and (5) for the Hudgin geometry; A is the matrix shown in Eq. (12) and it is multiplied with the solution image Φk on a square aperture for the Hudgin geometry; the matrix W is an annular mask image which multiplies entrywisely with the solution image Φk to transform it back into the annular aperture; the symbol ‖ ‖ represents the 2 norm operator; ε is the relative error and k max is the maximum iteration number, specified for the convergence. In the imbedding step, the Sylvester equation from Eq. (17) is used for the Hudgin-geometry wave-front reconstruction on a square aperture. For convenience of discussions, we repeat it here,

AΦk+ΦkA=Rk.

This imbedding step in the RF algorithm also serves to accelerate the convergence rate for the iterative solution process. In this step, first convert the residue vector rk to a residue image Rk ; and then using the following ADI method to obtain the solution update image Φk from the above equation; and then convert it back to a vector ϕk . In the iterative solution process, we can directly update the solution vector xk using ϕ k-1 or update it with αk and vector pk using the conjugate gradient (CG) procedure. However, for the wavefront reconstructor test purpose, we update the new residue vector using bk and the current solution estimation xk in this study,

rk=bkCxk,

where bk =G T sk , and sk is the current phase slope vector; and C=G T G is a matrix acting on an annular aperture; and xk is the current solution estimation. This residue update step is different from the CG method used elsewhere [67]. For closed-loop wavefront reconstruction, we should use rk =bk instead of Eq. (39) in the RF algorithm, and sk is generated using the optical phase output after phase compensation. The new imbedding strategy permits the fast methods designed for the Hudgin-geometry wave-front reconstruction on a square aperture to be used with the Fried-geometry wave-front reconstruction problem on an annular aperture.

5. ADI method for the RF algorithm

5.1 ADI method for the imbedding step

If matrix A is a nonsingular matrix, the Sylvester Equation (38) can usually be exactly solved using the BS method [14], which uses the Householder and QR transformations [15]. The BS method requires matrix A in Eq. (38) to be a nonsingular matrix, therefore before using it, we need to regularize the singular matrix A using an identity matrix scaled down with a small coefficient, taking into account of the signal to noise ratio (SNR) in the slopes measurement.

 figure: Fig. 1.

Fig. 1. Flowchart for the RF in which the preconditioning solution step is solved through the Sylvester equation to accelerate the convergence rate of the iterative process.

Download Full Size | PDF

This regularization procedure changes the condition of the matrix A into a nonsingular matrix. The computation cost of the BS method scales as O(n 3/2). Another efficient method for solving the Sylvester Equation (38) is the ADI method [13]. We use this method for wave-front method when applied to Eq. (38) is described by the following two iterative equations,

(A+ρjI)Φkj12=RkΦkj1(AρjI),
Φkj(A+ρjI)=Rk(AρjI)Φkj12.

In these two equations, ρj is an optimal parameter. To accelerate the convergence rate of the iterative solution process, it is adjusted to a different value for each iteration step j, where j=1, 2, …, J, where J is the total ADI iteration number. Because the iterative ADI method is used in the imbedding step of the RF algorithm, which is also an iterative process, therefore two iterative loops are involved in the RF algorithm. To solve the above two iterative ADI equations, we need to first determine the optimum parameter ρ j and the total iteration number J, then solve the tridiagonal systems of Eq. (40) and (41) for every iteration step j iteratively until the total iteration number J is reached. The parameter ρj and J are determined by solving the ADI minimax problem [13], which is discussed in next subsection. The tridiagonal equation solver is addressed in Subsection 5.3.

5.2 The ADI minimax problem

We use similar numerical technique exploited in Ref. [13] to determine the optimum parameter ρj and the total iteration number J for the ADI method. The procedures are described as follows. From Eq. (30), we can see that the spectrum of matrix A is real positive when excluding its singular spectrum (m=0), therefore the α parameter in the definition of elliptic function [13] is zero for the case here, and only limited field of the positive real axis [ϖa, ϖb] is required to consider for the ADI minimax problem. For the finite number of spectrum modes from m=1 to N-1, we define the minimum and maximum spectrum bounds ϖa and ϖb as follows,

ϖa=4sin2(π2N),
ϖb=4sin2[(N1)π2N].

The ADI parameters ρj and J are found using the following procedures. First defining a parameter h as,

h=12(ϖaϖb+ϖbϖa),

and then because h≥1, defining

g=1h+h21,
g=1g2.

The approximation for the total ADI iteration number is given by

J=ln4εln4gπ2.

The optimal parameter ρj is given by

ρj=ϖaϖbgdn(υj,g),(j=1,2,,J),

where dn(υj, g) is defined as

dn(υj,g)=2qυj2(1+q1υj+q1+υj)(1+2q)(1+q),(υj0.5),
dn(υj,g)=gdn(υJj+1,g),(υj<0.5),

where υj and q are defined as,

υj=2j12J,
q=(g4)2(1+g22).

5.3 The tridiagonal solver

To solve Eq. (40), we separate its right-hand side residue matrix and its left-hand side solution matrix into N columns respectively. In this way, the problem is changed to solving N independent tridiagonal equations of the following form,

Qx=d,

where Q is a tridiagonal matrix of order N, shown as follows,

Q=[a1f1c2a2f2cN1aN1fN1cNaN].

The tridiagonal matrix Q can be decomposed as Q=LU with the LU decomposition method, where L is a lower bidiagonal matrix and U is an upper bidiagonal matrix shown as in the following two equations,

L=[1l21lN11lN1],
U=[u1f1u2f2uN1fN1uN].

The unknown value for li and ui is computed using the following iteration equations,

u1=a1,
li=ciui,
ui=ailifi1,
(i=2,3,,N).

Let y=Ux , we can solve Ly =d first using the following forward substitution equations,

y1=d1,
yi=diliyi1,
(i=2,3,,N),

and then solving x using the following backward substitution equations,

xN=yNuN,
xi=(yixi+1fi)ui,
(i=N1,N2,,1).

After solving this tridiagonal equation for multiple right-hand side columns, we obtain the intermediate solution image by assembling all the solution columns together. Eq. (41) is solved using the same technique after transpose operations on its two sides are performed.

5.4 Computation complexity of the ADI method for the RF algorithm

We analyze the computation complexity of solving Φk using the ADI iterative equations (40) and (41). We need to solve Eq. (40) first. On the right-hand sides of Eq. (40), because the matrix A-ρjI is a tridiagonal sparse matrix, 3n multiplications and n additions are required for every iteration j, where n=N 2, is the total number of the sampling grid for the solution image. We decompose the matrix equation (40) into multiple tridiagonal equations. For one of right-hand side vectors, and one of the solution vectors, Eq. (40) is reduced to the form of Eq. (49). Therefore its computation complexity can be analyzed using Eq. (49). Because the upper diagonal and lower diagonal elements of matrix A + ρjI are all value 1, and correspond to the f and c elements in Eq. (50) respectively, therefore we save N multiplication in the substitution process shown in Eq. (53) and (55). If we precompute the li and ui value, then only 2N multiplications and 2N additions are required to solve Eq. (54) and (55) for this reduced tridiagonal equations, but we have N independent right hand-side column vectors, so totally we need only 2n multiplications and 2n additions to solve Eq. (40). Next we need to perform a transpose operation on two sides of Eq. (41), and then using the same procedure used for Eq. (40), we can solve N independent systems of tridiagonal equations. Thus in all, we need 10n multiplications and 6n additions and some overhead computation for the matrix transpose for every ADI iteration step j. The computation cost to complete the ADI iterations scales as 10Jn, where J is the total number of the ADI iterations in the imbedding step. Because it takes approximately 15n multiplications to update the solution when using a CG procedure and to calculate the residue vector, and about 5n to do that when not using a CG procedure for every recursive iteration step k, so the total operation complexity for the recursive algorithm is about 10JKn + 16Kn, and 10JKn + 6Kn when also including the masking operation using the mask W. This computation complexity estimation neither considers the overhead computation resulting from the matrix transpose operation nor the vector to image conversion and vice versa. If considering these factors, the computation complexity should be larger than this estimation. But for single processor, the transpose and conversion operation are memory access processes, the computation time for these operations is determined by the speed of memory access processes. The transpose operation permits solving the tridiagonal equation along the row direction of the right-hand side image sequentially after solving along its column direction. In Eq. (40) and (41), if we separate the right-hand side residue matrix and its left-hand side solution matrix into N columns respectively and then solve N independent tridiagonal equations for these columns, so the solution speed is can be accelerate N times if we use N processors at the same time. If the wavefront reconstruction is conducted in this way, we could use a one-dimensional mask for the masking step in the imbedding procedure, so the vector to matrix conversion and vice versa is not required, because now Φk is just ϕk , and in the solution and residue update procedure, the vectors are reduced to small vectors corresponding to one column of the whole image rather to the whole image, therefore the operation count complexity of the RF algorithm can reduce to O(n 1/2) when the ADI method is used in its imbedding step. However, the complexity analysis is complicated by the transpose operations involved in the ADI iterative solution process, because the time for matrix transpose operation is determined by the memory access patterns for a single processor computer, and also by the communication speed between the multiprocessors for multiprocessors computer. Therefore, the final effective computation complexity should be between O(n 1/2) and O(n) depending on what kind of computer architectures is used.

6. Performance metrics

We introduce the residue phase error (RPE) and the relative total root mean squared (RMS) error as the performance metrics to quantify the performance of various wave-front reconstruction algorithms. The definitions are the same as that in Ref. [12] for convenience of comparing with the results there. For every iteration step of the RF algorithm, the RPE is defined as

er=w0·*[e(v1Te)v1],

where w 0 is the annular pupil plane masking vector converted from the annular pupil mask, v 1 is the piston mode vector, e is the phase error vector for the estimation defined as e=-x, where is the reconstructed wave-front phase for every temporal step and x is the original input wave-front phase. The RMS and total RMS error are defined using RPE defined in Eq. (56) as shown in the following two equations,

RMS=(er·*er)12,
TRMS=[1nerTer]12,

where the symbol .* represents the component-wise product of two vectors, and n is the total number of sub-apertures on the annular solution aperture. From TRMS, the relative (e.g. fractional) TRMS error is defined as

rTRMS=[erTerxTx]12.

As defined in Eq. (56), RPE is a vector, but it is typically converted into an image when used as a performance metric. When we study the convergence rate of the RF algorithms, we will use rTRMS as the performance metric.

7. Simulations and discussions

Performance of our wavefront reconstruction algorithm, when applied in the single-conjugate AO system in an optical telescope, can be modeled using Monte Carlo simulations. The original wave-front was generated using the subharmonics method17 and considering the von Karman power spectrum of the optical turbulence. The wave-front phase difference vector corresponding to the centroid measurements of the Shack-Hartmann wave-front sensor is generated using annular-aperture version of Eq. (1), (3) and (19) as described in Section 4 for the Fried geometry. The Gaussian noise is added to the simulated wave-front slope to produce varying levels of subaperture slope SNR. We will apply the BS method to the regularized Sylvester equation, and then the ADI method to the non-regularized Sylvester equation in the imbedding step of the RF algorithm, and then will compare their performance using both the RPE and the rTRMS performance metrics. For wave-front reconstruction simulations, the vector bk in Eq. (39) for every iteration step of the RF algorithm is only required to be fixed to the original constant vector b 0, which is equal to G T s 0.

Numerical simulations were performed for a telescope having a 17 meters diameter annular aperture. The Shack-Hartmann wave-front sensor adopted has subaperture diameter of r 0/3, when mapped back onto the telescope entrance pupil, where r 0 is the Fried coherence length, and takes 0.2 meter in our simulations. This results in an annular pupil with 48816 sub-apertures. We embed this annular aperture in the square-aperture sampling grid of dimension 255×255 for all the simulations. The typical phase screen generated for these simulations is shown in Fig. 2. The piston mode is already removed from this phase screen, so it can act as the initial RPE image for the iterative solution process.

 figure: Fig. 2.

Fig. 2. Annular wave-front phase screen embedded in a 255×255 size square-aperture sampling grid. The colormap is shown in radians.

Download Full Size | PDF

To use the ADI method in the RF algorithm, the ADI minimax problem needs to be solved first. In our simulations, the expected rTRMS error lower bound ε is taken to be 5×10-4 and N=255, using the ADI minimax procedures described in Subsection 5.2, the J parmeter we obtained is 11, and the ρj we obtained are shown in table 1.

Tables Icon

Table 1. The ρj parameter for the ADI method when ε=5×10-4 and N=255

For the convenience of discussion, we use the notation RFCG and RFD respectively for the RF algorithm with a CG procedure and the RF algorithm used directly without a CG procedure. The convergence rate curve of the rTRMS error for RFCG algorithm, using the BS and the ADI methods to solve the Sylvester equation in the imbedding step and when SNR of the wave-front slope are 2, 8, 32, 128, respectively, are shown together in Fig. 3. From it, we can see that the convergence rates of the rTRMS error defined as in Eq. (59) are similar for these two methods. After a few iterations the curves converge. The RPE vector define as in Eq. (56) for the 50th step are converted to images and shown in Fig. 4, for wave-front reconstruction using RFCG algorithm, and with the imbedding precondtioning step done by the ADI method, for the case of subaperture slope SNR equal to 2, 8, 32 and 128. The corresponding results for the RPE and rTRMS error performance when the RFD algorithm is used are shown in Fig. 5 and 6 under the same conditions.

 figure: Fig. 3.

Fig. 3. Comparison of the rTRMS performance of the RFCG algorithm for the Fried geometry, when the imbedding step is solved using the ADI and BS methods respectively. The subaperture slope SNR is equal to 2, 8, 32 and 128, respectively, for both methods from top curves to bottom ones.

Download Full Size | PDF

We can see from Fig. 3 and 5 that the RFCG algorithm converges fast for all SNR cases, but the RFD algorithm converges fast only for the cases of SNR less than 30. It starts to slow down when SNR is larger than 30 in the simulation conditions that has just been described. From Fig. 4 and 6 we can see that the RPE performance after 50 iterations is similar for both the RFCG and the RFD algorithms when SNR less than 30. The RPE performance for the RFD algorithm becomes inferior to the RFCG method around the boundary region with SNR equal to 128, so we infer the slow convergence rate in Fig. 5 as due to the error introduced around the boundary of the aperture. From Fig. 4 and 6, we also can see the minimum and the maximum limit values of the RPE images decrease when SNR increases.

From our experience, J is usually a number smaller than 15 for the case of N≤1024, and ε≥5×10-4, which is the rTRMS range that can be achieved when SNR≤200 for the slopes measurements. Thus when we solve the Sylvester equation in the imbedding step using the ADI method, the RFCG algorithm has a computation cost of less than 166Kn plus that of both the matrix transposition and the vector-image inter-conversion operations. The RFD algorithm has a computational cost of less than 156Kn for this situation. Therefore the RFCG algorithm should be a competitive algorithm for real time implementations in future extreme AO and multi-conjugate AO systems and the RFD algorithm should also perform well when SNR for the subaperture slopes is low.

We have also completed simulations for wavefront reconstruction when applying the Hudgin filtering in the 2-D DCT domain, as discussed in Subsection 3.1, to the imbedding step of the RF algorithm. The results obtained are similar to those shown in Fig. 3 and 4 when the same simulation conditions are used, so are not included here. Additional results using a regularization scheme for the wave-front reconstruction are presented in another publication [12].

 figure: Fig. 4.

Fig. 4. RPE (in radians) after 50 iterations when solving the wave-front reconstruction for the Fried geometry using the RFCG algorithm, and the imbedding step is solved using the ADI method. The wave-front reconstruction is done in a 255×255 sized sampling grids and the subaperture slope SNR is equal to 2, 8, 32 and 128 for the RPE in image (a), (b), (c) and (d), respectively.

Download Full Size | PDF

 figure: Fig. 5.

Fig. 5. Comparison of the rTRMS performance of the RFD algorithm for the Fried geometry, when the imbedding step is solved using the ADI and BS methods respectively. The subaperture slope SNR is equal to 2, 8, 32 and 128, respectively, for both methods from top curves to bottom ones.

Download Full Size | PDF

 figure: Fig. 6.

Fig. 6. RPE (in radians) after 50 iterations when solving the wave-front reconstruction for the Fried geometry using the RFD algorithm, and the imbedding step is solved using the ADI method. The wave-front reconstruction is done in a 255×255 sized sampling grids and the subaperture slope SNR is equal to 2, 8, 32 and 128 for the RPE in image (a), (b), (c) and (d), respectively.

Download Full Size | PDF

6. Conclusion

Using the property of the Kronecker product of matrices, we have found a novel least square wave-front reconstructor based on the Sylvester equations for both the Hudgin and Fried geometry. Using the spectrum theorem for symmetrical real matrices and the Hadamard product concept, we have obtained the Hudgin and Fried filters and the filtering relationship in the 2-D DCT domain for square-aperture wave-front reconstruction problem. Furthermore, to accelerate the convergence rate of the RF algorithm when it is used for the Fried-geometry wave-front reconstruction on an annular aperture, we have exploited the Sylvester equation for the Hudgin-geometry wavefront reconstruction in the imbedding step of the RF algorithm. We use both the ADI method and the BS method to solve this Sylvester equation on a square aperture in the imbedding step, and then compare their performance when they are used with and without a CG procedure in the RF algorithm. We have solved the ADI minimax problem to determine the ADI parameter, and implemented a tridiagonal equation solver based on the LU decomposition method, and then used this tridiagonal solver to solve the tridiagonal systems of equations encountered in the ADI iterative solution process. The tridiagonal equation solver allows a parallel and highly efficient implementation using real-time computing hardware.

Acknowledgements

We appreciate Marcia Brown for improving the presentation of this paper. We acknowledge the financial support of the National Science Foundation through the Center for Adaptive Optics.

References

1. R. Dekany, J. E. Nelson, and B. Bauman, “Design considerations for CELT adaptive optics,” in Optical Design, Materials, Fabrication, and Maintenance, P. Dierickx, ed., Proc. SPIE4003, 212–225 (2000)

2. R. H. Hudgin, “Wave-front reconstruction for compensated imaging,” J. Opt. Soc. Am. 67, 375–378 (1977) [CrossRef]  

3. D. L. Fried, “Least-squire fitting a wave-front distortion estimate to an array of the phase difference measurements,” J. Opt. Soc. Am. 67, 370–375 (1977) [CrossRef]  

4. K. R. Freischlad and C. L. Koliopoulos, “Modal estimation of a wave font from difference measurements using the discrete Fourier transform,” J. Opt. Soc. Am. A 3, 1852–1861 (1986) [CrossRef]  

5. L. A. Poyneer, D.T. Gavel, and J.M. Base, “Fast wave-front reconstruction in large adaptive optics systems using the Fourier transform,” J.Opt. Soc. Am. A 19, 2100–2111 (2002) [CrossRef]  

6. L. Gilles, C. R. Vogel, and B. L. Ellerbroek, “A multigrid preconditioned conjugate gradient method for large-scale wave-front reconstruction,” J. Opt. Soc. Am. A 19, 1817–1822 (2002) [CrossRef]  

7. L. Gilles, “Order-N sparse minimum-variance open-loop reconstructor for extreme adaptive optics,” Opt. Lett. 28, 1927–1929 (2003) [CrossRef]   [PubMed]  

8. D. G. MacMartin, “Local, hierachic, and iterative reconstructors for adaptive optics,” J. Opt. Am. A 20, 1084–1093 (2003) [CrossRef]  

9. F. Shi, D. G. MacMartin, M. Troy, G. L. Brack, R. S. Burruss, and R. G. Dekany, “Sparse matrix wave-front reconstruction: simulations and experiments,” in Adaptive optical system technologiesΠ , P. Wizinowich, ed., Proc. SPIE4839, 1035–1044 (2002)

10. B. R. Hunt, “Matrix formulation fo the reconstruction of phase values from phase differences,” J. Opt. Soc. Am. 69, 393–399 (1979) [CrossRef]  

11. R. A. Horn and C. R. Johnson, Topics in matrix analysis, (Cambridge University Press, New York, 1991) [CrossRef]  

12. H. Ren and R. Dekany, “wave-front reconstruction for extreme adaptive optics based on fast recursive filtering,” submitted to applied optics

13. A. Lu and E. L. Wachspress, “Solution of Lyapunov equations by alternating direction implicit iteration,” Computers Math. Applic. 21(9), 43–58 (1991) [CrossRef]  

14. R. H. Bartels and G. W. Stewart, “Solution of the matrix equation AX + XB=C,” Comm. of ACM 15, 820–826 (1972) [CrossRef]  

15. D. S. Watkins, Fundamentals of Matrix Computations, second edition (John Wiley & Sons, inc., New York, 2002) [CrossRef]  

16. Rao and P. Yip, Discrete Cosine Transform, Algorithm, Advantages, Applications (Academic Press, inc, San Diego, 1990)

17. R. G. Lane, A. Glindemann, and J.C. Dainty, “Simulation of a Kolmogorov phase screen,” Waves in Random Media 2, 209–224 (1992) [CrossRef]  

Cited By

Optica participates in Crossref's Cited-By Linking service. Citing articles from Optica Publishing Group journals and other participating publishers are listed here.

Alert me when this article is cited.


Figures (6)

Fig. 1.
Fig. 1. Flowchart for the RF in which the preconditioning solution step is solved through the Sylvester equation to accelerate the convergence rate of the iterative process.
Fig. 2.
Fig. 2. Annular wave-front phase screen embedded in a 255×255 size square-aperture sampling grid. The colormap is shown in radians.
Fig. 3.
Fig. 3. Comparison of the rTRMS performance of the RFCG algorithm for the Fried geometry, when the imbedding step is solved using the ADI and BS methods respectively. The subaperture slope SNR is equal to 2, 8, 32 and 128, respectively, for both methods from top curves to bottom ones.
Fig. 4.
Fig. 4. RPE (in radians) after 50 iterations when solving the wave-front reconstruction for the Fried geometry using the RFCG algorithm, and the imbedding step is solved using the ADI method. The wave-front reconstruction is done in a 255×255 sized sampling grids and the subaperture slope SNR is equal to 2, 8, 32 and 128 for the RPE in image (a), (b), (c) and (d), respectively.
Fig. 5.
Fig. 5. Comparison of the rTRMS performance of the RFD algorithm for the Fried geometry, when the imbedding step is solved using the ADI and BS methods respectively. The subaperture slope SNR is equal to 2, 8, 32 and 128, respectively, for both methods from top curves to bottom ones.
Fig. 6.
Fig. 6. RPE (in radians) after 50 iterations when solving the wave-front reconstruction for the Fried geometry using the RFD algorithm, and the imbedding step is solved using the ADI method. The wave-front reconstruction is done in a 255×255 sized sampling grids and the subaperture slope SNR is equal to 2, 8, 32 and 128 for the RPE in image (a), (b), (c) and (d), respectively.

Tables (1)

Tables Icon

Table 1. The ρj parameter for the ADI method when ε=5×10-4 and N=255

Equations (73)

Equations on this page are rendered with MathJax. Learn more.

s = P ϕ + η ,
P T P ϕ = P T s .
P = [ P 1 P 2 ] ,
r = P T s = P 1 T s x + P 2 T s y ,
P 1 = I D 1 ,
P 2 = D 1 I ,
Y Z = [ y 11 Z y 12 Z y 1 n Z y 21 Z y 22 Z y 2 n Z y m 1 Z y m 2 Z y mn Z ] ,
D 1 = [ 1 1 1 1 1 1 1 1 ] .
P T P = ( I D 1 ) T ( I D 1 ) + ( D 1 I ) T ( D 1 I ) .
( Y Z ) T = Y T Z T ,
( Y Z ) ( W X ) = ( YW ) ( ZX ) ,
P T P = I A + A I ,
A = [ 1 1 1 2 1 1 2 1 1 1 ] .
( I A + A I ) ϕ = r .
vec A = [ a 1 a 2 a N ] ,
( I A + A I ) vec ( Φ T ) = vec ( R T ) ,
vec ( AYB ) = ( B T A ) vec Y ,
A Φ + Φ A = R .
F = [ 0.5 0.5 0.5 0.5 0.5 0.5 0.5 0.5 ] .
P 1 = F D 1 ,
P 2 = D 1 F ,
P T P = ( F D 1 ) T ( F D 1 ) + ( D 1 F ) T ( D 1 F ) .
P T P = H A + A H ,
H = 1 4 [ 1 1 1 2 1 1 2 1 1 1 ] ,
( H A + A H ) ϕ = r .
A Φ H + H Φ A = R ,
A = M Λ A M T .
Λ A M T Φ M + M T Φ M Λ A = M T R M .
( λ u T + u λ T ) ( M T Φ M ) = M T R M ,
Φ = M ( M T R M λ u T + u λ T ) M T = M ( M T R M T H ) M T .
M mn = 2 N κ m cos [ m ( 2 n + 1 ) π 2 N ] , ( m , n = 0 , 1 , , N 1 ) ,
λ m = 4 sin 2 ( m π 2 N ) , ( m = 0 , 1 , , N 1 ) ,
T mn H = 4 [ sin 2 ( m π 2 N ) + sin 2 ( 2 N ) ] , ( m , n = 0 , 1 , , N 1 ) .
S mn = 2 N κ m sin [ ( m + 1 ) ( 2 n + 1 ) π 2 N ] , ( m , n = 0 , 1 , , N 1 ) ,
σ m = cos 2 [ ( m + 1 ) π 2 N ] , ( m = 0 , 1 , , N 1 ) .
τ m = cos 2 ( m π 2 N ) , ( m = 0 , 1 , , N 1 ) .
H = M Λ H M T .
Φ = M ( M T RM λ τ T + τ λ T ) M T .
T mn F = 4 [ sin 2 ( m π 2 N ) cos 2 ( n π 2 N ) + sin 2 ( n π 2 N ) cos 2 ( m π 2 N ) ] ,
( m , n = 0 , 1 , , N 1 ) .
A Φ k + Φ k A = R k .
r k = b k C x k ,
( A + ρ j I ) Φ k j 1 2 = R k Φ k j 1 ( A ρ j I ) ,
Φ k j ( A + ρ j I ) = R k ( A ρ j I ) Φ k j 1 2 .
ϖ a = 4 sin 2 ( π 2 N ) ,
ϖ b = 4 sin 2 [ ( N 1 ) π 2 N ] .
h = 1 2 ( ϖ a ϖ b + ϖ b ϖ a ) ,
g = 1 h + h 2 1 ,
g = 1 g 2 .
J = ln 4 ε ln 4 g π 2 .
ρ j = ϖ a ϖ b g dn ( υ j , g ) , ( j = 1 , 2 , , J ) ,
dn ( υ j , g ) = 2 q υ j 2 ( 1 + q 1 υ j + q 1 + υ j ) ( 1 + 2 q ) ( 1 + q ) , ( υ j 0.5 ) ,
dn ( υ j , g ) = g dn ( υ J j + 1 , g ) , ( υ j < 0.5 ) ,
υ j = 2 j 1 2 J ,
q = ( g 4 ) 2 ( 1 + g 2 2 ) .
Q x = d ,
Q = [ a 1 f 1 c 2 a 2 f 2 c N 1 a N 1 f N 1 c N a N ] .
L = [ 1 l 2 1 l N 1 1 l N 1 ] ,
U = [ u 1 f 1 u 2 f 2 u N 1 f N 1 u N ] .
u 1 = a 1 ,
l i = c i u i ,
u i = a i l i f i 1 ,
( i = 2 , 3 , , N ) .
y 1 = d 1 ,
y i = d i l i y i 1 ,
( i = 2 , 3 , , N ) ,
x N = y N u N ,
x i = ( y i x i + 1 f i ) u i ,
( i = N 1 , N 2 , , 1 ) .
e r = w 0 · * [ e ( v 1 T e ) v 1 ] ,
RMS = ( e r · * e r ) 1 2 ,
TRMS = [ 1 n e r T e r ] 1 2 ,
rTRMS = [ e r T e r x T x ] 1 2 .
Select as filters


Select Topics Cancel
© Copyright 2024 | Optica Publishing Group. All rights reserved, including rights for text and data mining and training of artificial technologies or similar technologies.