+ All Categories
Home > Documents > efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

Date post: 14-Apr-2018
Category:
Upload: comvanroose
View: 227 times
Download: 0 times
Share this document with a friend

of 27

Transcript
  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    1/27

    AN EFFICIENT MULTIGRID CALCULATION OF THE FAR FIELD

    MAP FOR HELMHOLTZ AND SCHRODINGER EQUATIONS

    SIEGFRIED COOLS, BRAM REPS , AND WIM VANROOSE

    Abstract. In this paper we present a new highly efficient calculation method for the far fieldamplitude patterns that arise from scattering problems governed by the d-dimensional Helmholtzequation and, by extension, Schrodingers equation. The method is based upon a reformulationof the classical real-valued Greens function integral expression for the far field amplitude to anintegral over a complex contour. On this complex contour (or manifold, in multiple dimensions)the scattered wave can be calculated very efficiently using an iterative multigrid method as a solverfor the discretized scattered wave system, resulting in a fast and scalable calculation of the far fieldmap. The so-called full complex contour approach is successfully validated on model problems intwo and three spatial dimensions, and multigrid convergence results are provided to demonstrate thewavenumber scalability and overall performance of the proposed method.

    Key words. Far field map, Helmholtz equation, Schrodinger equation, multigrid, complexcontour, cross sections.

    AMS subject classifications. Primary: 78A45, 65D30, 65N55. Secondary: 65F10, 35J05,35J10, 81V55.

    DOI.

    1. Introduction. Scattering problems are of key importance in many areas ofscience and engineering since they carry information about an object of interest overlarge distances, remote from the given target. Consequently, ever since their originalstatement a variety of applications of scattering problems have arisen in many differentscientific subdomains. In chemistry and quantum physics, for example, virtuallyall knowledge about the inner workings of a molecule has been obtained throughscattering experiments [36]. Similarly, in many real-life electromagnetic or acousticscattering problems information about a far away object is obtained through radar orsonar [16], intrinsically requiring the solution of 2D or 3D wave equations.

    New state-of-the-art experimental techniques measure the full 4 angular depen-dency of multiple particles escaping from a molecular reaction [35]. Through theseexperiments, the cross section of reactions involving multiple particles can be detectedin coincidence. Many experiments are being planned at facilities such as e.g. theDESY Free-electron laser (FLASH) in Hamburg or the Linac Coherent Light Source(LCLS) in Stanford. The accurate prediction of the corresponding amplitudes start-ing from first principles requires the use of efficient numerical methods to solve thehigh-dimensional Helmholtz or Schrodinger problems, which can scale up to 6D or 9Din this context. Indeed, after discretization one generally obtains a large, sparse andindefinite system of equations in the unknown scattered wave. Direct solution of thissystem is usually prohibited due to the massive size of the problem in higher spatialdimensions.

    Preconditioned Krylov subspace methods are currently among the most efficientnumerical algorithms for the solution of general high-dimensional equations that arisefrom discretizations of partial differential equations, as they exploit the sparsity struc-ture of the discretized system of equations and allow for reasonably good scaling withrespect to the number of unknowns. Indeed, preconditioned Krylov subspace methods

    Dept. Math. & Comp. Sc., University of Antwerp, Middelheimlaan 1, 2020 Antwerp, BelgiumIntelR ExaScience Lab, Kapeldreef 75, B-3001 Leuven, Belgium

    1

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    2/27

    2 S. COOLS, B. REPS AND W. VANROOSE

    are able to solve some symmetric positive definite systems in only O(n) iterations,wheren is the number of unknowns in the system [49]. However, scattering problemsare often described by Helmholtz equations, which after discretization lead to highlyindefinite linear systems that are notoriously hard to solve using the current gener-

    ation of iterative methods. Moreover, the highly efficient iterative multigrid method[10, 12, 13, 47, 48] is known to break down when applied to these type of problems[18, 24].

    Over the past decade significant research has been performed on the constructionof good preconditioners for Helmholtz problems. Recent work includes the wave-rayapproach [11], the idea of separation of variables [38], algebraic multilevel methods[9], multigrid deflation [44, 45] and a transformation of the Helmholtz equation intoan advection-diffusion-reaction problem [26]. In 2004 the Complex Shifted Laplacian(CSL) was proposed by Erlangga, Vuik and Oosterlee [21, 22, 23] as an effectiveKrylov subspace method preconditioner for Helmholtz problems. The key idea be-hind this preconditioner is to formulate a perturbed Helmholtz problem that includesa complex-valued wave number. Given a sufficiently large complex shift, this im-plies a damping in the problem, thus making the perturbed problem solvable using

    multigrid in contrast to the original Helmholtz problem with real-valued wavenum-bers. By introducing the complex shifted problem as a preconditioner, the resultingKrylov method profits from advantageous spectral properties, leading to a reasonableconvergence rate. The concept of CSL has been further generalized in a variety ofpapers among which [2, 19, 20, 37]. The choice of a sufficiently large complex shiftparameter, commonly denoted by, is vital to the stability of the multigrid solutionmethod. The general rule of thumb for the choice of the complex shift suggestedin the literature is = 0.5 [22, 39]. This experimental guideline was recently con-firmed through a rigorous LFA analysis for the constant-k problem in [17], provingthe multigrid correction scheme to be generally stable for shifts larger than 0.5.

    Recently a variation on the Complex Shifted Laplacian scheme by the name ofComplex Stretched Grid (CSG) was proposed in [40, 41], introducing a complex-

    valued grid distance instead of a complex-valued wavenumber in the preconditioningsystem. It was furthermore shown in [39] that the resulting Krylov subspace methodhas very similar convergence properties. Indeed, the CSG preconditioner can beshown to be generally equivalent to the CSL scheme, and thus can be solved equallyefficiently using multigrid. However, despite its overall qualitative performance, theCSL/CSG preconditioned Krylov subspace solution method suffers from a significantwavenumber dependency of the convergence rate [39]. Additionally, convergence ratesquickly deteriorate in the presence of evanescent waves in the Helmholtz solution.

    This paper focuses on calculating the far field map resulting from Helmholtz andSchrodinger type scattering problems [3], which yields a 360 representation of thescattered wave amplitude at large distances from the ob ject of interest. The calcu-lation of the far field map can typically be considered a two-step process. First aHelmholtz problem with absorbing boundary conditions is solved on a finite numer-

    ical box covering the object of interest. In the second step a volume integral overthe Greens function and the numerical solution is calculated to obtain the angular-dependent far field amplitude map. This strategy was successfully applied to cal-culate impact ionization in hydrogen [42] and double photo-ionization in molecules[51, 52] described by the Schrodinger equation, which in this case translates into a6-dimensional Helmholtz problem.

    In this paper we propose a new method for the calculation of the far field map.

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    3/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 3

    The method reformulates the integral over the Greens function on a complex con-tour. This modified approach requires the solution of the Helmholtz equation on acomplex contour. It is shown that the latter problem is equivalent to a ComplexShifted Laplacian problem that can be solved very efficiently by a multigrid method.

    To validate our approach, the method is successfully illustrated on both 2D and 3DHelmholtz and Schrodinger equations for a variety of discretization levels. The ab-sorbing boundary conditions used in this paper are based on the principle ofExteriorComplex Scaling (ECS) that was introduced in the 1970s [1, 4, 46], and is nowadaysfrequently used in scattering applications. This method is equivalent to a complexstretching implementation ofPerfectly Matched Layers (PML) [7, 15].

    The outline of the article is the following. In Section 2 we introduce the nota-tion and terminology that will be used throughout the text. Additionally, we brieflyillustrate the classical calculation of the far field map for Helmholtz type scatteringproblems. In the second part of this section we introduce an alternative way of calcu-lating the far field mapping based upon a reformulation of the integral over a complexcontour, for which the corresponding Helmholtz system is very efficiently solved it-eratively. The new technique is validated and convergence results are shown for a

    variety of Helmholtz type model scattering problems in both 2D and 3D in Section3, where it is found that the method allows for a very fast and scalable far field mapcalculation. In Section 4, the method is validated and extensively tested on severalSchrodinger type model problems in two and three spatial dimensions respectively.Benchmark problems include quantum-mechanical model problem situations in whichsingle, double and/or triple ionization occur. Finally, along with a discussion on thetopic, conclusions are drawn in Section 5.

    2. The Helmholtz equation and the far field map. In this section we in-troduce the general notation used throughout the text and we illustrate the classicalderivation of the far field scattered wave solution and calculation of its amplitudefrom a general Helmholtz type scattering problem.

    2.1. Derivation of the far field mapping. The Helmholtz equation is a simplemathematical representation of the physics behind a wave scattering at an objectdefined on a compact support areaO located within a domain Rd. The equationis given by k2(x)u(x) = f(x), x Rd, (2.1)with dimension d 1, where is the Laplace operator, f designates the right handside or source term, and k is the (spatially dependent) wavenumber, representing thematerial properties inside the object of interest. Indeed, the wavenumber functionkis defined as

    k(x) = k1(x), for x O,

    k0, for x \ O,(2.2)

    where k0 R is a scalar constant denoting the wave number outside the object ofinterest. The scattered wave solution is given by the unknown function u. Throughoutthe text we will use the following convenient notation

    (x) :=k2(x) k20

    k20, (2.3)

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    4/27

    4 S. COOLS, B. REPS AND W. VANROOSE

    such that k2(x) = k20(1 + (x)). Note that the function is trivially zero outsidethe object of interest O where the space-dependent wavenumber k(x) is reduced tok0. Defining the incoming wave as uin(x) = e

    ik0x, where is the unit vector thatdefines the direction, the right-hand side is typically given by f(x) =k20(x)uin(x).

    Reformulating (2.1), we obtain k2(x)u(x) = k20(x)uin(x), x Rd. (2.4)This equation is typically formulated on the domain with outgoing wave boundaryconditions on, and can in principle be solved on a numerical box (i.e. a discretizedsubset of N ) covering the support of, with absorbing boundary conditionsalong all edges. Let us assume that the numerical solution satisfying (2.4) on this boxhas been calculated and is denoted by uN.

    In order to calculate the far field scattered wave pattern the above equation isreorganized as

    k20

    u(x) = k20(x) (uin(x) + u(x)) , x Rd. (2.5)

    Note that we can replace the function u(x) in the right hand side of this equation withthe numerical solution uN(x) obtained from equation (2.4). In doing so, the aboveequation becomes an inhomogeneous Helmholtz equation with constant wavenumber k20 u(x) = g(x), x Rd, (2.6)where the short notationg(x) := k20(x)(uin(x)+ u

    N(x)) is introduced for readabilityand notational convenience. It holds thatg(x) = 0 forx Rd\O. The above equationcan easily be solved analytically using the Helmholtz Greens functionG(x,x), i.e.

    u(x) =

    Rd

    G(x,x) g(x) dx, x Rd. (2.7)

    Since the function g is only non-zero inside the numerical box that was used to solve

    equation (2.4), the above integral over Rd

    can be replaced by a finite integral over

    u(x) =

    G(x,x)k20(x)

    uin(x) + uN(x)

    dx, x Rd. (2.8)

    In practice, this expression allows us to calculate the scattered wave solution u in anypoint x Rd \ N outside the numerical box, using only the information x Ninside the numerical box.

    Given the integral expression (2.8), the asymptotic form of the Greens functioncan be used to compute the far field map of the scattered wave u. In the followingthis will be illustrated for a 2D model example where the Greens function is givenexplicitly by

    G(x,x) = i

    4H

    (1)

    0 (k0

    |x

    x

    |), x,x

    Rd. (2.9)

    where i represents the imaginary unit and H(1)0 is the 0-th order Hankel function of

    the first kind. An analogous derivation can be performed in 3D, where we mentionfor completeness that the Greens function is given by

    G(x,x) = eik0|xx

    |

    4|x x| , x,x Rd. (2.10)

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    5/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 5

    To calculate the angular dependence of the far field map, the direction of the unitvector is introduced that is in 2D defined by a single angle with the positivehorizontal axis, i.e.= (cos , sin )T. Rewriting the spatial coordinatesx in polar

    coordinates as x = ( cos , sin )T

    the asymptotic form of the Greens function for

    |x| 1 ( ) is given byi

    4H

    (1)0 (k0|x x|) =

    i

    4

    2

    ei/4

    1k0

    eik0eik0x cosik0y sin

    = i

    4

    2

    ei/4

    1k0

    eik0eik0x (2.11)

    where we have used the fact that the Hankel function H(1)0 is asymptotically given by

    H(1)0 (r) =

    2

    rexp

    i(r

    4)

    , r R, r 1. (2.12)

    This leads to the following asymptotic form of the 2D scattered wave solution

    u(, ) = i

    4

    2

    ei/4

    eik0k0

    eik0xg(x) dx, (2.13)

    for . The above expression is called the 2D far field wave pattern ofu, withthe integral being denoted as thefar field (amplitude) map

    F() =

    eik0xg(x) dx. (2.14)

    The value of the integral depends only on the direction (or, in 2D, on the angle) and the wave number k0. Expression (2.13) readily extends to thed-dimensionalcase, where it holds more generally that

    lim

    u(,) = D()F(), Rd, (2.15)

    for a functionD() which is known explicitly and a far field map F() given by (2.14).Note that this far field map is in fact a Fourier integral of the function g .

    Summarizing, we conclude that the calculation of the far field wave pattern ofthe scattered wave u consists of two main steps. First, one has to solve a Helmholtzequation with a spatially dependent wave number on a numerical box with absorbingboundary conditions as in (2.4). Once the numerical solution is obtained, it is followedby the calculation of a Fourier integral (2.14) over the aforementioned numericaldomain. The main computational bottleneck of this calculation generally lies withinthe first step, since it requires an efficient and computationally inexpensive methodfor the solution of the high dimensional indefinite Helmholtz system with absorbingboundary conditions.

    The statement of the far field map presented in this section relies on the factthat the object of interest, represented by the function , is compactly supported. Inparticular, this is used when computing the numerical solution uN to equation (2.4)on a bounded numerical box that covers the support of. The above reasoning canhowever be readily extended to the more general class of analytical object functions that vanish at infinity, i.e. V where V = {f : Rd R analytical| >0,K

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    6/27

    6 S. COOLS, B. REPS AND W. VANROOSE

    {z}

    {z}

    Fig. 2.1. Schematic representation of the complex contour for the far field integral calculationillustrated in 1D. The full line represents the real domain , the dotted and dashed lines representthe subareas Z1 = {xei : x R} and Z2 = {bei : b , [0, ]} of the complex contourrespectively.

    Rd compact,x Rd \ K :|f(x)| < }. Indeed, due to the existence of smoothbump functions [29, 33], functions with compact support can be shown to be densewithin the space of functions that vanish at infinity. Consequently, every analyticalfunction V can be arbitrarily closely approximated by a series of compactlysupported functions

    {n

    }n. This in turn implies that the corresponding solutions

    {uNn }n on a limited computational box can be arbitrarily close to the solution of theHelmholtz equation generated with the analytical object of interest V. Intuitively,this means that if is analytical but sufficiently small everywhere outside O, thecomputational domain may be retricted to a numerical box covering O as if wascompactly supported. Hence, the far field map (2.14) is well-defined for analyticalfunctions that vanish at infinity. This observation will prove particularly useful inthe next section.

    2.2. Calculation on a complex contour. In this section we will illustrate howthe integral (2.14) can be reformulated on a complex contour and why this is usefulin terms of numerical computation. First, we note that the integral can be split intoa sum of two contributions F() = I1+ I2 with

    I1 =

    eik0x(x)uin(x)dx and I2 =

    eik0x(x)uN(x)dx. (2.16)

    Calculation of first integral I1 is generally easy, since it only requires the expressionfor the incoming wave, which is known analytically. The second integral howeverrequires the solution of the Helmholtz equation on the numerical box, which is knownto be notoriously hard to obtain using iterative methods. In particular, the highlyefficient multigrid solution method is unable to solve these type of indefinite Helmholtzequations due to instability in both the coarse grid correction and relaxation scheme.This divergence is due to close-to-zero eigenvalues of the discretized operator on someintermediate multigrid levels [18].

    However, if both u and are analytical functions the integral can be calculatedover a complex contour rather than the real axis as follows. Let us define a complexcontour along the rotated real domain Z1 =

    {z

    C

    |z = xei : x

    }, where is

    a fixed rotation angle, followed by the curved segment Z2 ={z C | z = bei : b, 0}, as presented schematically on Figure 2.1. The integralI2 can thenbe written as

    I2 =

    Z1

    eik0z(z)uN(z)dz+Z2

    eik0z(z)uN(z)dz. (2.17)

    The second term in the above expression however vanishes, as the function is per

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    7/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 7

    {z}

    {z}

    Fig. 2.2. Schematic representation of a real grid with ECS boundaries vs. a full complex grid,illustrated in 1D.

    definition zero everywhere outside the object of interest O, thus notably in all pointsz Z2. Hence one ultimately obtains

    I2 =

    Z1

    eik0z(z)uN(z)dz=

    eik0eix(xei)uN(xei)eidx. (2.18)

    Note that for 0 < < /2 the exponential ofxei is increasing in all directions. At

    the same time, the scattered wave solution uN, which consists of outgoing waves onthe complex domain Z1, is decaying in all directions. Additionally, the function ispresumed to have a bounded support (or vanish at infinity, see Section 2.1) makingthe above integral calculable on a limited numerical domain.

    Expression (2.18) for the integral I2 indicates that the far field map can (atleast partially) be computed over the full complex contour Z1, i.e. a rotation of theoriginal real domain over an anglein all spatial dimensions. The advantage of thisapproach is that we only need the value ofuN evaluated along this complex contour;thus we now have to solve the Helmholtz equation (2.4) on a complex contour. Onthis contour it is a damped equation which is much easier to solve than the Helmholtzequation along the real axis. Indeed, given a sufficiently large value of, it has beenshown in the literature [23, 40] that the multigrid scheme is a very effective solutionmethod for the Helmholtz equation on a complex domain.

    2.3. Solving the Helmholtz equation on a complex contour. We nowshow that the Helmholtz problem on the complex domain Z1 is very similar to acomplex shifted Laplacian system [21], and can as such be solved efficiently using amultigrid solver. Consider the Helmholtz problem with a complex shifted wavenumber (1 + i)k2(x)u(x) = f(x) (2.19)with Dirichlet boundary conditionsu(x|) = 0 and a complex shift parameter R.After finite difference discretization on a d-dimensional Cartesian grid with fixed griddistanceh in every spatial dimension, one typically obtains a linear system

    1

    h2L + (1 + i)k2uh= bh (2.20)

    where L is the matrix operator expressing the stencil structure of the Laplacian. In2D, for exampleL = kron(I, diag(1, 2, 1)+kron(diag(1, 2, 1), I), where the sizeofL intrinsically depends on h. After dividing both sides in linear system (2.20) by(1 + i), we immediately obtain the equivalent system

    1

    (1 + i)h2L + k2

    uh=

    bh1 + i

    , (2.21)

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    8/27

    8 S. COOLS, B. REPS AND W. VANROOSE

    (rad.) /8 /7 /6 /5 /4 /3 (deg.) 7.5 8.5 9.9 11.8 14.6 19.1

    Table 2.1

    ECS angle and corresponding rotation angle for the full complex grid. Values based on (2.24).

    which is identical to the discretization of the original Laplacian with grid distanceh =

    1 + i h. This scheme is known as Complex Stretched Grid, and it was shown

    in [40] to yield exactly the same convergence as the Complex Shifted Laplacian whenboth are used as a preconditioner for a general Krylov method.

    It is known that problem (2.20), or equivalently (2.21), can be solved efficientlywith multigrid for values of the complex shift > 0.5, see [17, 21]. Note that thisrequirement is based on a multigrid cycle with standard weighted Jacobi or Gauss-Seidel smoothing. This rule of thumb can easily be translated into an angle for thecomplex scaling. Writing (1 +i) = exp(i) with =

    1 + 2 and = arctan ,

    one readily obtains

    h=

    1 + i h= exp(i/2)h (2.22)

    Consequently, as the shift is required to be larger than 0.5, the grid rotation angle= /2 must satisfy

    >arctan(0.5)

    2 = 0.2318 13.28 (2.23)

    Note that when substituting the standard multigrid relaxation schemes like -Jacobior Gauss-Seidel by a more robust iterative scheme like e.g. GMRES(m), the rotationangle may be chosen even smaller, up to a minimum of approximately 9.5 (see[41]).

    In this paper we have chosen to link the grid rotation angle to the standard

    ECS absorbing layer angle , see Figure 2.2. This is in no way imperious for thefunctionality of the method, but it appears quite naturally from the fact that bothangles perturb (part of) the grid into the complex plane. Suppose the ECS boundarylayer measures one quarter of the length of the entire real domain in every spatialdimension, which is a common choice, we readily derive that the relation between therotation angle and the ECS angle is given by

    = arctan

    sin

    2 + cos

    . (2.24)

    Table 2.1 shows some standard values of the ECS angle and corresponding valuesaccording to (2.24). Note that for a multigrid scheme with -Jacobi or Gauss-Seidelsmoothing to be stable, should be chosen no smaller than /4, according to (2.23).

    Using the more efficient GMRES(3) method as a smoother replacement, the ECS anglecan be chosen somewhat smaller, i.e. an angle around = /6 suffices to guarantee astable multigrid solution.

    3. Numerical results for 2D and 3D Helmholtz problems. In this sec-tion, we validate the theoretical result presented above by a number of numericalexperiments in both two and three spatial dimensions. It will be shown that the pro-posed method results in a very fast and wavenumber independent solution method

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    9/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 9

    Fig. 3.1. Top: 2D object of interest |(x)| given by (3.1). Mid: solution to the Helmholtzproblem (2.4) (in modulus) on a nx ny = 256 256 grid solved using LU factorization (left) ona double ECS contour with = /4, and using a series of multigrid V-cycles (right) with -Jacobismoother on the corresponding full complex contour up to a residual reduction tolerance of 1e-6.Bottom: resulting 2D Far field mapsF()calculated following (2.14). Normalized errors with respectto anx ny = 1024 1024 grid benchmark Far field map solutionFex(): Fre Fex2/Fex2 =9.37e-5(left), Fco Fex2/Fex2 = 1.39e-4 (right), Fre Fco2/Fex2 = 1.77e-4.

    for the scattered wave system, hence yielding a remarkably efficient method for thecalculation of the far field map.

    The model problem used throughout this section is a Helmholtz equation of theform (2.4) with k2(x) = k20(1 +(x)). The equation is discretized on a nd-point

    uniform mesh covering a square numerical domain = [20, 20]d using second orderfinite differences. In the 2D case the space-dependent wavenumber is defined as

    k20(x, y) = 1/5

    e(x2+(y4)2) + e(x

    2+(y+4)2)

    , (x, y) [20, 20]2, (3.1)

    i.e. the object of interest takes the form of two circular point-like objects with mass

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    10/27

    10 S. COOLS, B. REPS AND W. VANROOSE

    nx ny nz 163 323 643 1283 2563

    k0

    1/4 10(10) 9 (59) 9(560) 9(4456) 9(35165)

    0.24 0.20 0.21 0.20 0.20

    1/2 12 (12) 10(63) 10(611) 10(4937) 9(35405)

    0.31 0.24 0.22 0.23 0.21

    1 7 (8) 13 (83) 11(691) 10(4899) 10(38975)

    0.13 0.32 0.27 0.24 0.24

    2 2 (4) 8 (54) 13 (809) 11(5418) 10(38051)

    0.01 0.14 0.33 0.27 0.24

    4 1 (3) 2 (17) 7 (457) 13 (6337) 11(41848)

    0.01 0.01 0.12 0.33 0.26

    Table 3.1

    3D Helmholtz problem (2.4) solved on a full complex grid with = /6 using a series ofmultigrid V(1,1)-cycles with GMRES(3) smoother up to residual reduction tolerance1e-6. Displayedare the number of V-cycle iterations, number of work units and average convergence factor for

    various wavenumbers k0 and different discretizations. 1 WU is calibrated as the cost of 1 V(1,1)-cycle on the163-points gridk0 = 1/4 problem. Discretizations respecting the k0h

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    11/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 11

    nx ny nz 163 323 643 1283 2563

    k0

    1/4 8(11) 6(52) 5(384) 5(3190) 5 (25241)

    1.93e-9 1.77e-9 2.46e-9 2.68e-9 3.00e-9

    1/2 9 (12) 8(68) 6(452) 6(3392) 6 (30215)

    1.27e-8 1.87e-9 3.37e-9 1.30e-9 1.25e-9

    1 5 (8) 9 (68) 8(572) 7(4013) 6 (30747)

    1.33e-8 1.51e-8 4.07e-9 1.76e-9 3.66e-9

    2 1 (5) 5 (43) 9 (600) 8(4456) 7 (36367)

    5.99e-13 1.18e-8 1.91e-8 5.28e-9 2.67e-9

    4 1 (4) 1 (18) 5 (357) 9 (5038) 8 (39038)

    8.90e-20 2.86e-13 5.19e-9 1.97e-8 4.65e-9

    Table 3.2

    3D Helmholtz problem (2.4) solved on a full complex grid with = /6 using an FMG cyclewith GMRES(3) smoother up to residual reduction tolerance of 1e-6. Displayed are the number ofV-cycle iterations on the designated finest grid, number of work units and resulting residual norm

    for various wavenumbersk0 and different discretizations. 1 WU is calibrated as the cost of 1 V(1,1)-cycle on the163-points gridk0 = 1/4 problem. Discretizations respecting the k0h

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    12/27

    12 S. COOLS, B. REPS AND W. VANROOSE

    Fig. 3.2. Left: 3D object of interest|(x)| given by (3.2). Shown are the|(x)|= c isosurfacesfor c = 1e-1, 1e-2, 1e-10, 1e-100 and1e-300. Right: 3D Far field map, resulting from Helmholtzproblem (2.4) with k0 = 1 solved on anx ny nz = 64 64 64 full complex grid with = /6(9.9) using a series of multigrid V-cycles with GMRES(3) smoother up to residual reductiontolerance1e-6.

    nx ny nz 163 323 643 1283 2563

    CPU time 0.20 s. 0.78 s. 6.24 s. 53.3 s. 462 s.r2 3.3e-5 7.9e-5 2.7e-5 1.1e-5 4.6e-6

    Table 3.3

    3D Helmholtz problem (2.4) with wavenumberk0 = 1 solved on a full complex grid with = /6using one FMG-cycle with GMRES(3) smoother. Displayed are the CPU time (in s.) and theresulting residual norm for various discretizations. System specifications: IntelRCoreTM i7-2720QM2.20GHz CPU, 6MB Cache, 8GB RAM.

    Table 3.2 shows convergence results for the solution of the 3D scattered waveequation (2.4) using an FMG scheme. The setting is comparable to that of Table3.1, as a residual reduction tolerance of 106 is imposed for each wavenumber and atevery level of the FMG cycle, yielding a finenxnynz = 2563 grid residual of orderof magnitude 109. Note that the number of V-cycles performed on each level in theFMG cycle is decaying as a function of the growing grid size due to the increasinglyaccurate initial guess, resulting in a relatively small number of V-cycles (five to nine)to be performed on the finest level. Consequently, the number of work units (and thusthe computational time) required to reach the designated residual reduction toleranceis significantly lower than the work unit load of the pure V-cycle scheme displayed inTable 3.1.

    Timing and residual results from a standard FMG sweep performing only oneV(1,1)-cycle on each level on the 3D Helmholtz scattering problem with a moderatewavenumber k0 = 1 are shown in Table 3.3 for different discretizations. Note that

    timings were generated using a basic non-parallelized Matlab code, using only a singlethread on a simple midrange personal computer (system specifications: see captionTable 3.3) and taking less than 8 minutes to solve a 3D Helmholtz problem with 256gridpoints in every spatial dimension.

    4. Application to Schrodinger equations. This section illustrates the ap-plication of the proposed complex contour method to high-dimensional Schrodingerequations that are used to describe quantum mechanical scattering problems. The

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    13/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 13

    d-dimensional time-independent Schrodinger equation for a system with unit mass isgiven by

    1

    2

    + V(x)

    E(x) = (x), for x

    Rd, (4.1)

    where is the d-dimensional Laplacian,V(x) is the potential, is the wave functionand is the right-hand side, which is often related to the ground state of the system.Depending on the total energyE, the above system allows for scattering solutions, inwhich case the equation can be reformulated as a Helmholtz equation of the form

    ( k2(x)) (x) = 2(x), for x Rd, (4.2)where the spatially dependent wavenumber k(x) is defined by k 2(x) = 2(E V(x)).The experimental observations from this type of quantum mechanical systems aretypically far field maps of the solution [51, 52]. Indeed, in an experimental setup,detectors are typically placed at large distances from the object compared to thesize of the system. These detectors consequently measure the probability of parti-

    cles escaping from the system in certain directions. In many quantum mechanicalsystems the potential V(x) is an analytical function, which suggests analyticity ofthe wavenumberk(x) in the above Helmholtz equation. Additionally, the potential isoften exponentially decaying in function of the spatial coordinates. Hence, for thesetypes of problems, the wavenumber naturally satisfies all conditions for the use of theproposed complex contour method to efficiently calculate the corresponding far fieldmap.

    In the paragraphs below, we first discuss a 2D model problem in which singleand double ionization occur, corresponding to waves describing respectively a singleparticle or two particles escaping from the quantum mechanical system. The firstleads to very localized evanescent waves that propagate along the boundaries of thecomputational domain, while the latter gives rise to waves traversing the full domain.The corresponding 2D Schrodinger problem will be solved on a discretized numerical

    domain for a range of energies Ebelow and above the double ionization threshold.For each level of energy, we extract the single and double ionization cross sections,which correspond to probabilities of particles escaping from the system, with the helpof an integral of the Greens function over the numerical box. The cross sections arecalculated using both a traditional method, where the Helmholtz equation is solved ona standard ECS-bounded grid [31], and the new complex contour method, introducedin Section 2.2.

    The main purpose of the calculations in Sections 4.1 to 4.4 is to validate the resultsobtained by the complex contour method when applied to Schrodingers equation. InSection 4.5 the multigrid performance for solving the 2D complex-valued scatteredwave system is benchmarked. Note, however, that these 2D problems essentially donot require a multigrid solver, since a direct sparse solver performs well for theserelatively small-size problems.

    In Section 4.6, we illustrate the convergence of a multigrid solver on a 3D Schro-dinger equation, with energies that allow for triple ionization as well as double andsingle ionization. The previous attempts to solve these problems with the help of thecomplex shifted Laplacian as a preconditioner to a general Krylov method showed anotable deterioration in the convergence behavior in function of the total energy E[40, 8]. However, it will be shown that the new complex contour method, which allowsmultigrid to be used as a solver, performs well for these problems.

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    14/27

    14 S. COOLS, B. REPS AND W. VANROOSE

    Although the benchmark problems considered in this paper mainly use modelpotentials, we believe that the calculations presented below are an important steptowards the application of the method on realistic quantum mechanical systems.

    4.1. Cross sections of the 2D Schrodinger problem. Our primary aim is to

    validate the applicability of the new complex contour method on the 2D Schr odingerequation describing a quantum mechanical scattering problem. This problem orig-inates from the expansion of a 6D scattering problem in spherical harmonics, see[3, 51, 8], in which each particle is expressed in terms of its spherical coordinates.The resulting partial waves fit the two-dimensional Schrodinger equation

    12

    + V1(x) + V2(y) + V12(x, y) E

    u(x, y) = (x, y), x, y 0, (4.3)

    with boundary conditions

    u(x, 0) = 0 for x 0u(0, y) = 0 for y

    0

    outgoing for x or y ,(4.4)

    where represents the 2D Laplacian, V1(x) and V2(y) are the one-body potentials,V12(x, y) is a two-body potential and E is the total energy of the system. Sincethe arguments x and y are in fact radial coordinates in the partial wave expansion,homogeneous Dirichlet boundary conditions are implied at the x = 0 and y = 0boundaries. The potentials V1, V2 and V12 are generally analytical functions thatdecay (exponentially) as the radial coordinates x and y become large.

    Depending on the strength of the one-body potentials V1 and V2, the problemallows for so-calledsingle ionization waves, which are localized evanescent waves thatpropagate along the edges of the domain. We refer the reader to Sections 4.2 and 4.3for a more detailed physical clarification. We expound on the situation with a strongpotential V1 in the x-direction; the case with a strong V2 potential is completelyanalogous. If V1 is strong enough, there exists a one-dimensional eigenstate n(x)for every negative eigenvalue n < 0, characterized by a one-dimensional Helmholtzequation

    12

    d2

    dx2+ V1(x)

    n(x) = n n(x), forx 0. (4.5)

    Note thatn(0) = 0 andn(x ) = 0.The far field maps of this system are then again Greens integrals over the solu-

    tion, see [31]. Indeed, the single ionization amplitude orcross section sn(E), whichrepresents the total number of single ionized particles, is given by

    sn(E) =

    kn(x)n(y) ((x, y)

    V12(x, y)u(x, y))dxdy, (4.6)

    wherekn=

    2(E n),nis a one-body eigenstate which is the solution of equation(4.5) with a corresponding eigenvaluen, and the functionkn is a regular, normalizedsolution of the homogeneous Helmholtz equation

    12

    d2

    dx2+ V1(x) 1

    2k2

    k = 0, (4.7)

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    15/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 15

    wherek = kn and kn is normalized with 1/

    kn.Similarly, the double ionization cross section f(k1, k2), which measures the total

    number of double ionized particles, is defined by the integral

    f(k1, k2) =

    k1(x)k2(y) ((x, y) V12(x, y)u(x, y))dx d y, x, y 0, (4.8)

    where both k1(x) and k2(y) are solutions to (4.7), with k1 =

    2Esin() andk2 =

    2Ecos() respectively, i.e. such that k21 +k

    22 = 2E. The total double ionization

    cross section is defined as the integral

    tot(E) =

    E0

    (

    2,

    2(E )) d, (4.9)

    where

    (k1, k2) =82

    k20

    1

    k1k2|f(k1, k2)|2. (4.10)

    The above integral expressions are obtained through a reorganization similar to theone performed in Section 2, see (2.5)(2.6). For example, to calculate the singleionization cross section, equation (4.3) is reorganized as

    12

    + V1(x) E

    u(x, y) = (x, y)(V2(y)+V12(x, y)) u(x, y), x, y 0. (4.11)

    Since the left hand side is separable, the corresponding Greens function allows us towrite

    u(x, y) =

    G(x, y|x, y) (x, y) (V2(y) + V12(x, y)) uN(x, y) dx dy.(4.12)

    Using the asymptotic form of the Greens function, the above ultimately results inintegral formulation (4.6). The double ionization integral expression (4.8) can be

    derived in a similar way.

    4.2. Spectral Properties. To obtain more insight in the numerical solution ofthe two-dimensional Schrodinger problem, we briefly discuss the spectral propertiesof the discretized Schrodinger operator. The discretized 2D Hamiltonian H2d corre-sponding to equation (4.3) can be written as a sum of two Kronecker products and atwo-body potential, i.e.

    H2d =H1d I+ I H1d + V12(x, y), (4.13)where H1d =1/2 +Vi (i = 1, 2) is the one-dimensional Hamiltonian, discretizedusing finite differences. When the two-body potential V12(x, y) is weak relative to theone-body potentials, the eigenvalues of the 2D Hamiltonian can be approximated by

    2d

    1d

    i + 1d

    j , 1 i,j, n. (4.14)Hence, to form a better understanding of the spectral properties ofH2d, let us firstconsider the eigenvalues ofH1d. After discretization using second order finite differ-ences, the one-dimensional Hamiltonian can be written as a tridiagonal matrix, wherethe stencil

    1

    h21 2 1 (4.15)

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    16/27

    16 S. COOLS, B. REPS AND W. VANROOSE

    2 0 2 4 6 8 108

    6

    4

    2

    0

    real

    imag

    2 0 2 4 6 8 108

    6

    4

    2

    0

    real

    imag

    2 0 2 4 6 88

    6

    4

    2

    0

    real

    imag

    2 0 2 4 6 88

    6

    4

    2

    0

    real

    imag

    Fig. 4.1. Spectrum (close-up) of the discretized 1D (top) and 2D (bottom) Hamiltonian (4.14),i.e. wih E = 0. Left: standard discretization with real-valued grid distance h. Right: complexcontour discretization with complex-valued grid distanceh= eih, with= /6. The spectrum isrotated down into the complex plane over2= /3.

    approximates the second derivatives, and the potential is a diagonal matrix evaluated

    in the grid points. The spectrum ofH1d

    closely resembles the spectrum of the Lapla-cian (1/2), however the presence of the potential modifies the smallest eigenvalues.The resulting spectrum is shown on the top left panel of Figure 4.1, which presents aclose-up of the eigenvalues near the origin. A single negative eigenvalue 1d0 = 1.0215can be observed, which is due to the attractive potential. The remaining spectrumconsists of a series of positive eigenvalues which are located along the positive realaxis. The top right panel of Figure 4.1 shows the eigenvalues ofH1d, discretized alonga complex-valued contour, i.e. the real grid rotated by ei. The grid distance used isnowh= hei, which results in the following stencil for the second derivative

    e2i 1

    h21 2 1 . (4.16)

    This implies that the spectrum of the Laplacian is rotated down into the complex planeby an angle 2. Figure 4.1 shows that most of the eigenvalues are rotated downwardsover 2, with the exception of the bound state eigenvalue 1d0 , which remains on thenegative real axis. These spectral properties are well known in the physics literature,see for example [34].

    We consequently turn to the two-dimensional problem setting, where the eigenval-ues of the Hamiltonian H2d are the sums of the one-dimensional operator eigenvaluesH1d I+ I H1d. The resulting eigenvalues are shown on the bottom two panels

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    17/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 17

    of Figure 4.1. Again, the eigenvalues of the 2D Hamiltonian are rotated down inthe complex plane when the system is discretized along a complex-valued contour.In 2D, an isolated eigenvalue appears around 1d0 +

    1d0 =2.043, and two series of

    eigenvalues emerge from the real axis: a first branch of eigenvalues starting at 1.012,which originates from the sum of the negative eigenvalue

    1d0 of the first 1D Hamil-

    tonian combined with all the positive eigenvalues of the second 1D Hamiltonian; anda second series of eigenvalues starting at the origin, originating from the sums of thepositive eigenvalues of both one-dimensional Hamiltonians.

    4.3. Solution types: single and double ionization. The Schrodinger equa-tion (4.3) can be written shortly as (HE)u= , whereH= (1/2)+ V1 +V2 +V12andEis the total energy of the system. Depending on this energyE, the Schrodingersystem has different types of solutions. In this section we briefly expound on thephysical interpretation of these solution types, using a model problem example. Thissection may prove less interesting to readers who are primarily interested in the com-putational aspects of the solution, and as such, can be skipped at will.

    When the energy is larger that the smallest (negative) eigenvalue of the Hamilto-nian, i.e.

    0< E, one-body eigenstate solutions to (4.5) arise. These eigenstates can

    be combined into separable waves of the form

    un(x, y) = n(x)exp(ikny), (4.17)

    with kn =

    2(E n). This expression effectively is a solution to the Schrodingerproblem (4.3) in the region where x is small and y . Indeed, wheny is large,the potentialsV2 andV12 are negligibly small and the resulting Schrodinger equationbecomes separable in variables, where n(x) and exp(ikny) are the solutions of theseparated operators respectively. An analogous argument holds for the case when V2is large, in which case there exist evanescent waves of the form

    un(x, y) = n(y) exp(iknx). (4.18)

    These separable waves are solutions of the Schrodinger system forx

    andy small,

    and can be derived similarly to (4.17). When bothV1 and V2 are large, (4.17) and(4.18) exist simultaneously. Note that we can associate such a separable wave witheach eigenstate n of equation (4.5) that corresponds to a negativeeigenvalue of theHamiltonian. These localized waves are called single ionization wavesin the physicsliterature, since they correspond to a quantum mechanical system in which a singleparticle is ionized. Single ionization waves are present in the solution as soon as theenergyEis above the0 threshold. When there is a second eigenstate with negativeenergy, say 1 with 1, an additional single ionization wave appears in the problemas soon as E > 1. We refer to the specialized literature for a detailed discussion ofthe ionization process, see [36, 25].

    The left panel of Figure 4.2 shows the solution to (4.3) for a total energy E= 0.5.The model problem under consideration fits equation (4.3), with a right-hand sidegiven by (x, y) = exp(

    3(x + y)2). The one-body potentials are defined by V1(x) =

    4.5 exp(x2) and V2(y) =4.5 exp(y2), yielding an eigenstate of equation (4.5)with energy 0 =1.0215. The two-body potential equalsV12(x, y) = 2 exp((x+y)2). The equation is discretized on a [0, 20]2 domain using 500 grid points in everyspatial dimension. An ECS absorbing layer consisting of an additional 250 grid pointsdamps the outgoing waves along the right and top edges of the domain. Note fromFigure 4.2 how the single ionization eigenstate solutions given by (4.17)-(4.18) appearalong the edges of the domain.

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    18/27

    18 S. COOLS, B. REPS AND W. VANROOSE

    Single ionization Double ionization

    Fig. 4.2. Scattered wave solutions u(x, y) to model problem (4.3). Model specifications: seeaccompanying text. Left: solution for energy E =0.5 where only single ionization occurs. Right:solution for energyE= 1.5 where both double and single ionization occur. Single ionization wavesare localized solely along the edges of the domain (left), while double ionization waves appear bothalong the edges and in the middle of the domain (right).

    When the total energy E exceeds zero, i.e. E >0, additional scattering solutionsto the Schrodinger equation appear when both x and y . If all potentialsare asymptotically zero, equation (4.3) boils down to a Helmholtz equation with wavenumber k =

    2E for x and y . The resulting waves are known as

    double ionization waves and physically correspond to the simultaneous ejection oftwo particles from the quantum mechanical system. In the far field, i.e. forx and y , double ionization waves behave as ei

    2E

    x2+y2 . At the same time, it

    is still possible to have single ionization, since we have E > 0. The right panel ofFigure 4.2 shows the solution to the above model problem with a total energy E= 1.5,clearly displaying the double ionization waves. Note how single and double ionizationwaves coexist in the solution. Additionally, one observes that double ionization wavesoscillate faster in the x- ory-direction than a free wave with wave number k = 2E,sincekn k.

    4.4. Validation of the complex contour method on the 2D Schrodinger

    problem. In physical experiments, the total number of single ionized or double ion-ized particles is typically observed for a range of energy levels Eusing advanced detec-tors. These observations are made far away from the object and effectively measurethe far field amplitudes of the solutions. The outcome of this type of experiments canbe predicted by calculating the single (4.6) and double ionization (4.8) cross sections,using the numerical solution of equation (4.3), see [31]. Indeed, in order to calculatethese cross sections, the numerical solution uN(x, y) to (4.3) is required, which isgenerally hard to obtain, especially in higher spatial dimensions. However, since thepotentialsV1, V2 andV12 are analytical functions, the integrals for single and double

    ionization can be calculated along a complex contour rather than the classical realdomain, in analogy to the discussion in Section 2.1. Consequently, one requires thescattering solution of equation (4.3) on a complex contour, which is generally mucheasier to compute numerically.

    In the following, we calculate the single and double ionization cross sections for anumber of energiesEbetween 1 and 3 using both the classical real-valued discretiza-tion and the complex contour approach. The corresponding 2D scattering problems

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    19/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 19

    Fig. 4.3. Scattered wave solutions u(x, y) to model problem (4.3) for E = 1. Left: solutionon a real grid with ECS absorbing boundary layer ( = /7 25). Right: solution on a straightcomplex scaled contour ( 8.5), resulting in a damped scattered wave solution.

    (4.3) are solved on a numerical domain = [0, 15]2 covered by a finite difference gridconsisting of 300 grid points in every spatial dimension. Additionally, an ECS absorb-ing boundary layer starting at x= 15 and y = 15 respectively is used to implementthe outgoing boundary conditions, adding an additional 150 grid points in every spa-tial dimension. The ECS angle is = /7 25.7. Alternatively, a complex scaledgrid with an overall complex rotation angle 8.5 is used. SolutionsuN(x, y) to(4.3) for a total energy E= 1 on both the classical real-valued grid and the complexcontour are presented on Figure 4.3. Note how the solution is damped when evaluatedalong the complex contour.

    Figure 4.4 shows the rate of single and double ionization as a function of the totalenergy E. The dashed and dotted lines represent the single and double ionizationamplitudes calculated using the traditional real-valued method with ECS absorbingboundary conditions [31]. The solid line is the total cross section and is calculated

    using the optical theorem, see [36]. One observes that single ionization occurs startingfromE > 1.0215. Double ionization only occurs when E >0, and comprises only afraction of the single ionization cross section (cf. Figure 4.2). Note how the energy ofthe single ionized bound states rises as the total energy grows, and remains presenteven whenE >0. Results obtained using the complex contour approach are indicatedby the and symbols on Figure 4.4. In this case, the Schrodinger equation (4.3)is first solved on a complex contour, yielding a damped solution as shown by Figure4.3 (right panel), followed by the calculation of the integrals (4.6) and (4.8) along thiscomplex contour. Identical results are obtained by both calculation methods, thusvalidating the applicability of the complex contour approach on Schrodinger-typeproblems.

    4.5. Multigrid performance on the 2D Schrodinger problem. In this sec-tion, we benchmark the performance of multigrid as a solver for the 2D Schrodingerscattering problem on a complex-valued grid. It appears that the multigrid conver-gence rate critically depends on the value of the total energy E. Indeed, Figure 4.5shows the convergence rate of a standard multigrid V(1,1)-cycle for the 2D modelproblem described in the sections above. We observe that the multigrid scheme failsto converge for total energies Ebetween1 and 0. Note that this corresponds pre-cisely to the energy range where only single ionization occurs. However, for energylevels E > 0, where both single and double ionization occur, multigrid succesfully

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    20/27

    20 S. COOLS, B. REPS AND W. VANROOSE

    1 0 1 2 30

    1

    2

    3

    4

    103

    E

    Crosssection

    Single ionization (real)

    Single ionization (complex)

    Double ionization (real)

    Double ionization (complex)Total cross section

    Fig. 4.4. Comparison of the single and double ionization total cross sections calculated usingthe scattered wave solution uN of (4.3) calculated on (a) a traditional real-valued ECS grid with = /7 and (b) a full complex contour with = 8.5. The energy range starts at the singleionization threshold E = 1, corresponding to a strictly positive cross section. Double ionizationoccurs for energy levels E >0.

    converges.

    The observed convergence behaviour can be explained using the spectral proper-ties of the Hamiltonian operator which were presented in Section 4.2. The bottomright panel of Figure 4.1 shows the eigenvalues ofH1d I+ IH1d, discretized alonga complex contour, which is an approximate representative of the spectrum ofH2d.Changing the total energy Ewill shift the spectrum of the Hamiltonian to the left or

    right. For energy levels1< E 0. In contrast,the purely single ionized problem (with V12 = 0) can be solved in a one-dimensional

    Helmholtz setting, see (4.5), where multigrid can indeed be shown to perform well forenergy levels1< E 0, they do not undermine the multigrid convergence in this regime. This isremarkable, because single ionization waves are very localized evanescent waves alongthe edges of the domain, which generally cannot be represented efficiently on coarsergrids, since there might not be enough grid points covering these regions. However,

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    21/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 21

    2 1 0 1 2 30

    0.2

    0.4

    0.6

    0.8

    1

    E

    MultigridConvergencerate

    Fig. 4.5. 2D Schrodinger problem (4.3) for a total energy range E [2, 3] solved on a fullcomplex grid with 8.5. Displayed is the average multigrid convergence rate of a V(1,1)-cyclewith GMRES(3) smoother as a function of the energy E. Average (rk/r0)

    1/k calculated fromexperimental results based upon k= 4 consecutive V-cycles.

    despite the fact that the coarsening strategy of the multigrid method used in thiswork is not adapted to evanescent waves, the natural damping implied by the complexcontour evaluation ensures good multigrid performance.

    4.6. Solution of a 3D Schrodinger equation. As demonstrated on a 2Dmodel problem in the previous sections, the far field map (cross section) of a gen-eral Schrodinger problem can be accurately calculated using the complex contourapproach. In this section, we focus on the numerical solution of the 3D Schrodingerequation on the complex contour using multigrid. In the three-dimensional case, the

    use of a direct solver is prohibited due to the size of the problem.We consider the 3D Schrodinger equation, modelling a realistic scattering problem

    that includes single, double and triple ionization. As discussed above, this problemfeatures very localized waves, which require sufficiently high-resolution solution meth-ods. The model problem for the 3D partial wave expansion is

    12

    + V1(x) + V2(y) + V3(z)

    + V12(x, y) + V23(y, z) + V31(z, x) E

    u(x,y,z) = (x,y,z), x, y, z 0,(4.19)

    with boundary conditions

    u(x,y, 0) = 0 for x, y 0u(0, y , z) = 0 for y, z 0u(x, 0, z) = 0 for x, z 0outgoing for x or y or z ,

    (4.20)

    Let us discuss a system in which V1, V2 andV3 are identical one-body potentials andV12, V23 and V31 are, similarly, identical two-body potentials. Let the strength of

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    22/27

    22 S. COOLS, B. REPS AND W. VANROOSE

    the one-body potential be such that there is a single negative eigenvalue for the 1Dsubsystem

    1

    2

    d2

    dx2

    + V(x)0(x) = 0 0(x), x 0, (4.21)

    with 0 < 0, where we have dropped the subscript on the 1D potential V. If thetwo-body potential V12(x, y) is negligibly small, then there automatically exists abound state of the 2D subsystem. Indeed, the state0(x)0(y) is an eigenstate of theseparable Hamiltonian (1/2) + V(x) + V(y) with eigenvalue 20. In the presenceof a small but non-negligible two-body potential, this state will be slightly perturbed,resulting in an eigenstate0(x, y) that fits the 2D subsystem

    12

    + V(x) + V(y) + V12(x, y)

    0(x, y) = 00(x, y), x, y 0. (4.22)

    The corresponding eigenvalue is 0 20 < 0 < 0. This ordering is typical forrealistic atomic and molecular systems [4]. Similarly, the 3D system will have an

    eigenstate that looks approximately like 0(x, y)0(z), or any of its coordinate per-mutations. This 3D eigenstate 0(x,y,z) fits the equation

    12

    + V1(x) + V2(y) + V3(z)

    + V12(x, y) + V23(y, z) + V31(z, x)

    0(x,y,z) = 0 0(x,y,z), x, y, z 0,(4.23)

    where0 0+ 0 30.Assuming that the potentials are such that 0 < 0 < 0 < 0, there are now

    four possible regimes of interest in equation (4.19), depending on the total energyE. First, for E < 0, the problem is positive definite, and hence easy to solvenumerically. However, in this regime no interesting physical reactions occur. Similarly,

    for 0 < E < 0, there are no scattering states in the solution. For energy levels0 < E < 0, single ionization scattering occurs. Consequently, in this regime, thereexist scattering solutions that are localized along one of the three axes in the 3Ddomain. These solutions take the form v(z)0(x, y) as z , where 0(x, y) is theeigenstate of (4.22) andv(z) is a scattering solution satisfying outgoing wave boundaryconditions. Similar solutions are found for the respective coordinate permutations.For energy levels 0 < E < 0, both single and double ionization occurs. For theseenergy levels, the solution contains besides single ionization waves also doubleionization waves of the form w(y, z)0(x), where 0(x) is an eigenstate of (4.21) andw(y, z) is a 2D scattering state satisfying the outgoing wave boundary conditions.Together with coordinate permutations, these waves are localized along the faces ofthe 3D domain, where one of the three coordinates, x, y or z, is small. Finally, forE >0, the solution additionally contains triple ionization waves. These are waves thatdescribe a quantum mechanical system that is fully broken up into its sub-particles.In this case, all three relative coordinatesx, y and z can become large, resulting in awave which extends to the entire domain.

    Note that in fact only the latter problem, when E > 0 and triple ionization ispresent, requires a full 3D description. For the regimes in which only single ionizationoccurs, a 1D description should be sufficient, due to the separated character of thesolution. Similarly, for problems with both single and double ionization, but no triple

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    23/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 23

    E < 0 0 < E < 0 0 < E < 0 0 < E 0 regime.

    4.7. Multigrid performance on the 3D Schrodinger problem. We nowstudy the convergence of a multigrid solver for the 3D Schr odinger equation (4.19)for energies E that cover all possible scattering regimes. The model problem underconsideration is a straightforward generalization of the 2D model presented in Section4.3, featuring one-body potentials V1(x) =4.5 exp(x2), V2(y) =4.5exp(y2)and V3(z) =4.5 exp(z2), and two-body potentials V12(x, y) = 2exp((x+ y)2),V23(y, z) = 2 exp((y + z)2) andV31(x, z) = 2 exp((x + z)2). These potentials implythe existence of a 1D eigenstate in (4.21) with corresponding energy 0 =1.0215,a 2D eigenstate solution of (4.22) with energy 0 =1.841, and an additional 3Deigenstate in (4.23), which has energy 0 =2.751. The problem is solved for arange of different total energies E, using an identical right-hand side (x,y,z) =exp(3(x+y +z)2) for all energies. The discretization comprises 2553 points, coveringthe complex-valued cube domain [0, 15ei/12]3.

    The 3D model problem described above is now solved using a full multigrid F(5)-cycle [48]. This implies that the problem is first discretized on a 7 3-point grid, whereit is solved exactly. The solution obtained on this level is consecutively interpolatedand used as an initial guess to the same problem discretized using 153 grid points,after which 5 V(1,1)-cycles are applied. This process is repeated recursively until wearrive at the finest level in the multigrid hierarchy, which consists of 2553 grid points.On this level the V-cycle convergence rate is measured by averaging the residualreduction rate over three consecutive V-cycles. Figure 4.6 shows the convergence rateas a function of the total energyE. We see acceptable convergence behavior for energylevels E

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    24/27

    24 S. COOLS, B. REPS AND W. VANROOSE

    4 2 0 2 4 6 80

    0.2

    0.4

    0.6

    0.8

    1

    E

    MultigridConvergencerate

    Fig. 4.6. 3D Schrodinger problem (4.19) for a total energy range E [4, 8] solved on a fullcomplex grid with= /12 = 15. Displayed is the average multigrid convergence rate of a V(1,1)-cycle with GMRES(3) smoother as a function of the energy E. Average (rk/r0)

    1/k calculatedfrom experimental results based uponk = 3 consecutive V-cycles.

    eigenvalue, either 2D or 1D, a series of eigenvalues arises from just below the real axisinto the negative half of the complex plane, cf. Figure 4.1. Changing the energyEwillshift the distribution of these eigenvalues in the direction of the real axis. For energylevels 0 < E < 0, there are series of eigenvalues both in the third and the fourthquadrant in the complex plane. Both series start close to the real axis, resulting in anindefinite problem with eigenvalues closely near the origin, causing poor convergenceof the multigrid method. Contrarily, in the 0< Eregime, all eigenvalues are boundedaway from the origin. Indeed, in this case all eigenvalue series start from eigenvalues

    along the negative real axis. The largest real-valued eigenvalue lies at a distance|E|to the left of origin, implying the entire spectrum can be distinctly separated fromthe origin by a virtual straight line, which results in good multigrid convergence.

    Note, however, that from a physical point of view, the lack of convergence forenergy levels E < 0 is not a concern, since the solutions in this energy regime canbe described either by a 1D or 2D equation (see higher), and a full 3D description isgenerally not required.

    5. Conclusions and discussion. In this paper we have developed a novelhighly efficient method for the calculation of the far field map resulting from d-dimensional Helmholtz and Schrodinger type scattering problems where the wavenum-ber is an analytical function. Our approach is based on the reformulation of theclassically real-valued Greens function volume integral for the far field map to an

    equivalent volume integral over a complex-valued domain.The advantage of the proposed reformulation lies in the scattered wave solution

    of the Helmholtz problem on a complex domain, which can be calculated efficientlyusing a multigrid method, in particular for high-dimensional problems. Indeed, thereformulation of the Helmholtz forward problem on the full complex contour is shownto be equivalent to a Complex Shifted Laplacian problem, for which multigrid hasbeen proven in the literature to be a fast and scalable solver. However, whereas the

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    25/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 25

    Complex Shifted Laplacian was previously only used as a preconditioner for highlyindefinite Helmholtz problems, the complex-valued far field map calculation proposedin this paper effectively allows for multigrid to be used as a solver on the perturbedproblem.

    The functionality of the method is primarily validated on 2D and 3D Helmholtztype model problems. It is confirmed that the values of the far field map calculated onthe full complex grid exactly matches the values of the classical real-valued integral.Furthermore, the number of multigrid iterations is shown to be largely wavenumberindependent, yielding a fast overall far field map calculation.

    One area of scientific computing where the proposed technique might be particu-larly valuable is in the numerical solution of quantum mechanical scattering problems.These are generally high-dimensional scattering problems where the wavenumber isindeed an analytical function, and where 6D or 9D problems are common. We havevalidated that for a 2D Schrodinger type model problem the proposed method canaccurately calculate the cross sections that are measured in physical experiments. Inaddition, we have studied the convergence rate for a 3D Schrodinger equation. Resultsshow reasonable multigrid convergence rates for the energy range of interest.

    Despite their use as benchmark problems, the model problems described in thispaper form an important testing framework for more realistic applications. However,further analysis of the convergence rates are necessary for realistic Coulomb potentialsto make the method more robust, and eventually usable by computational physicistsand chemists.

    Finally, we note that a number of modifications can be made to improve theefficiency of the method even further, like e.g. choosing the shape of the complexcontour for the integral based on a steepest descent scheme, as proposed in [28].

    6. Acknowledgments. This research was partly funded by the Fonds voorWetenschappelijk Onderzoek (FWO) project G.0.120.08 and Krediet aan navorserproject number 1.5.145.10. Additionally, this work was partly funded by IntelRandby the Institute for the Promotion of Innovation through Science and Technology in

    Flanders (IWT). The authors would like to thank Hisham bin Zubair for sharing amultigrid implementation and D. Huybrechs, C.W. McCurdy and D.J. Haxton forfruitful discussions on the subject.

    REFERENCES

    [1] J. Aguilar and J.M. Combes. A class of analytic perturbations for one-body Schrodinger Hamil-tonians. Communications in Mathematical Physics, 22(4):269279, 1971.

    [2] T. Airaksinen, E. Heikkola, A. Pennanen, and J. Toivanen. An algebraic multigrid based shifted-Laplacian preconditioner for the Helmholtz equation. Journal of Computational Physics,226(1):11961210, 2009.

    [3] M. Baertschy, T.N. Rescigno, W.A. Isaacs, X. Li, and C.W. McCurdy. Electron-impact ioniza-tion of atomic hydrogen. Physical Review A, 63(2):022712, 2001.

    [4] E. Balslev and J.M. Combes. Spectral properties of many-body Schrodinger operators withdilatation-analytic interactions. Communications in Mathematical Physics, 22(4):280294,1971.

    [5] A. Bayliss, C.I. Goldstein, and E. Turkel. An iterative method for the Helmholtz equation.Journal of Computational Physics, 49(3):443457, 1983.

    [6] A. Bayliss, C.I. Goldstein, and E. Turkel. On accuracy conditions for the numerical computationof waves. Journal of Computational Physics, 59(3):396404, 1985.

    [7] J.-P. Berenger. A perfectly matched layer for the absorption of electromagnetic waves. Journalof computational physics, 114(2):185200, 1994.

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    26/27

    26 S. COOLS, B. REPS AND W. VANROOSE

    [8] H. bin Zubair, B. Reps, and W. Vanroose. A preconditioned iterative solver for the scatter-ing solutions of the Schrodinger equation. Communications in Computational Physics,11(2):415, 2012.

    [9] M. Bollhofer, M.J. Grote, and O. Schenk. Algebraic multilevel preconditioner for the Helmholtzequation in heterogeneous media.SIAM Journal on Scientific Computing, 31(5):37813805,

    2009.[10] A. Brandt. Multi-level adaptive solutions to boundary-value problems. Mathematics of com-

    putation, 31(138):333390, 1977.

    [11] A. Brandt and I. Livshits. Wave-ray multigrid method for standing wave equations. ElectronicTransactions on Numerical Analysis, 6:162181, 1997.

    [12] A. Brandt and S. Taasan. Multigrid method for nearly singular and slightly indefinite problems.Multigrid Methods II, Lecture Notes in Math., 1228:99121, 1986.

    [13] W.L. Briggs, V.E. Henson, and S.F. McCormick. A Multigrid Tutorial. Society for IndustrialMathematics, Philadelphia, 2000.

    [14] H. Calandra, S. Gratton, R. Lago, X. Pinel, and X. Vasseur. Two-level preconditioned Krylovsubspace methods for the solution of three-dimensional heterogeneous Helmholtz problemsin seismics. Technical report, TR/PA/11/80, CERFACS, Toulouse, France, 2011.3, 2011.

    [15] W.C. Chew and W.H. Weedon. A 3D perfectly matched medium from modified Maxwells equa-tions with stretched coordinates.Microwave and Optical Technology Letters, 7(13):599604,2007.

    [16] D. Colton and R. Kress. Inverse acoustic and electromagnetic scattering theory, volume 93.Springer, 1998.

    [17] S. Cools and W. Vanroose. Local Fourier Analysis of the Complex Shifted Laplacian pre-conditioner for Helmholtz problems. Numerical Linear Algebra with Applications, (DOI:10.1002/nla.1881), 2013.

    [18] H.C. Elman, O.G. Ernst, and D.P. OLeary. A multigrid method enhanced by Krylov sub-space iteration for discrete Helmholtz equations. SIAM Journal on Scientific Computing,23(4):12911315, 2002.

    [19] Y.A. Erlangga and R. Nabben. On a multilevel Krylov method for the Helmholtz equation pre-conditioned by shifted Laplacian. Electronic Transactions on Numerical Analysis, 31(403-424):3, 2008.

    [20] Y.A. Erlangga and R. Nabben. Algebraic multilevel Krylov methods. SIAM Journal on Sci-entific Computing, 31:34173437, 2009.

    [21] Y.A. Erlangga, C.W. Oosterlee, and C. Vuik. On a class of preconditioners for solving theHelmholtz equation. Applied Numerical Mathematics, 50(3-4):409425, 2004.

    [22] Y.A. Erlangga, C.W. Oosterlee, and C. Vuik. A novel multigrid based preconditioner for het-erogeneous Helmholtz problems. SIAM Journal on Scientific Computing, 27(4):14711492,2006.

    [23] Y.A. Erlangga, C. Vuik, and C.W. Oosterlee. Comparison of multigrid and incomplete LUshifted-Laplace preconditioners for the inhomogeneous Helmholtz equation. Applied Nu-merical Mathematics, 56(5):648666, 2006.

    [24] O.G. Ernst and M.J. Gander. Why it is difficult to solve Helmholtz problems with classical iter-ative methods. In Numerical Analysis of Multiscale Problems. Durham LMS Symposium.Citeseer, 2010.

    [25] H. Friedrich and H. Friedrich. Theoretical atomic physics. Springer-Verlag, 1991.

    [26] E. Haber and S. MacLachlan. A fast method for the solution of the Helmholtz equation.Journalof Computational Physics, 230(12):44034418, 2011.

    [27] E. Hewitt and K. Stromberg. Real and abstract analysis: a modern treatment of the theory offunctions of a real variable. 1975.

    [28] D. Huybrechs and S. Vandewalle. On the evaluation of highly oscillatory integrals by analyticcontinuation. SIAM Journal on Numerical Analysis, 44(3):10261048, 2006.

    [29] S.G. Johnson. Saddle-point integration of C bump functions. Manuscript. Available athttp://math.mit.edu/stevenj/bump-saddle.pdf, 2007.

    [30] A. Laird and M. Giles. Preconditioned iterative solution of the 2D Helmholtz equation. Tech-nical report, NA-02/12, Comp. Lab. Oxford University UK, 2002.

    [31] C.W. McCurdy, M. Baertschy, and T.N. Rescigno. Solving the three-body coulomb breakupproblem using exterior complex scaling. Journal of Physics B: Atomic, Molecular andOptical Physics, 37(17):R137, 2004.

  • 7/27/2019 efficient Multigrid calculation of far fields maps of Helmholtz and SChrodinger equation

    27/27

    MULTIGRID CALCULATION OF THE FAR FIELD MAP 27

    [32] C.W. McCurdy, T.N. Rescigno, and D. Byrum. Approach to electron-impact ionization thatavoids the three-body Coulomb asymptotic form. Physical Review A, 56(3):1958, 1997.

    [33] K.O. Mead and L.M. Delves. On the convergence rate of generalized Fourier expansions. IMAJournal of Applied Mathematics, 12(3):247259, 1973.

    [34] Nimrod Moiseyev. Quantum theory of resonances: calculating energies, widths and cross-

    sections by complex scaling. Physics Reports, 302(5):212293, 1998.

    [35] R. Moshammer, M. Unverzagt, W. Schmitt, J. Ullrich, and H. Schmidt-Bocking. A 4 recoil-ion electron momentum analyzer: a high-resolution microscope for the investigation of thedynamics of atomic, molecular and nuclear reactions. Nuclear Instruments and Methods inPhysics Research Section B: Beam Interactions with Materials and Atoms, 108(4):425445,1996.

    [36] R.G. Newton. Scattering theory of waves and particles. Dover publications, 2002.

    [37] D. Osei-Kuffuor and Y. Saad. Preconditioning Helmholtz linear systems. Applied NumericalMathematics, 60(4):420431, 2010.

    [38] R.E. Plessix and W.A. Mulder. Separation-of-variables as a preconditioner for an iterativeHelmholtz solver. Applied Numerical Mathematics, 44(3):385400, 2003.

    [39] B. Reps and W. Vanroose. Analyzing the wave number dependency of the convergence rate ofa multigrid preconditioned Krylov method for the Helmholtz equation with an absorbinglayer. Numerical Linear Algebra with Applications, 19(2):232252, 2012.

    [40] B. Reps, W. Vanroose, and H. bin Zubair. On the indefinite Helmholtz equation: Complexstretched absorbing boundary layers, iterative analysis, and preconditioning. Journal ofComputational Physics, 229(22):83848405, 2010.

    [41] B. Reps, W. Vanroose, and H. bin Zubair. GMRES-based multigrid for the complex scaled pre-conditioner for the indefinite Helmholtz equation. Submitted to Numerical Linear Algebrawith Applications, 2013.

    [42] T.N. Rescigno, M. Baertschy, W.A. Isaacs, and C.W. McCurdy. Collisional breakup in a quan-tum system of three charged particles. Science, 286(5449):24742479, 1999.

    [43] C.D. Riyanti, Y.A. Erlangga, R.E. Plessix, W.A. Mulder, C. Vuik, and C. Oosterlee. A newiterative solver for the time-harmonic wave equation. Geophysics, 71(5):E57E63, 2006.

    [44] A.H. Sheikh, D. Lahaye, and C. Vuik. A scalable Helmholtz solver combining the shifted Laplacepreconditioner with multigrid deflation. Technical report, DIAM 11-01, Delft University ofTechnology, 2011.

    [45] A.H. Sheikh, D. Lahaye, and C. Vuik. On the convergence of shifted Laplace preconditionercombined with multilevel deflation. Numerical Linear Algebra with Applications, 2013.

    [46] B. Simon. The definition of molecular resonance curves by the method of Exterior ComplexScaling. Physics Letters A, 71(2):211214, 1979.

    [47] K. Stuben and U. Trottenberg. Multigrid methods: Fundamental algorithms, model problemanalysis and applications. Multigrid methods, Lecture Notes in Math., 960:1176, 1982.

    [48] U. Trottenberg, C.W. Oosterlee, and A. Schuller. Multigrid. Academic Press, New York, 2001.

    [49] H.A. Van der Vorst. Iterative Krylov methods for large linear systems, volume 13. CambridgeUniversity Press, 2003.

    [50] H.A. van Gijzen, Y. Erlangga, and C. Vuik. Spectral analysis of the discrete Helmholtz op-erator preconditioned with a shifted Laplacian. SIAM Journal on Scientific Computing,29(5):19421985, 2007.

    [51] W. Vanroose, D.A. Horner, F. Martin, T.N. Rescigno, and C.W. McCurdy. Double photoion-ization of aligned molecular hydrogen. Physical Review A, 74(5):052702, 2006.

    [52] W. Vanroose, F. Martin, T.N. Rescigno, and C.W. McCurdy. Complete photo-induced breakupof the H2 molecule as a probe of molecular electron correlation. Science, 310(5755):17871789, 2005.

    [53] R.S. Varga. Matrix iterative analysis. Englewood Cliffs, N.J., Prentice-Hall, 2 edition, 1962.


Recommended