+ All Categories
Home > Documents > Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate...

Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate...

Date post: 08-Mar-2021
Category:
Upload: others
View: 1 times
Download: 0 times
Share this document with a friend
23
Radiation boundary conditions for waves: the solved, the unsolved, and potential applications to numerical relativity Tom Hagstrom SMU Collaborators in rbc work: S.I. Hariharan, U. Akron - first implementations of arbitrary order Bayliss-Turkel type rbcs Leslie Greengard NYU/Flatiron and Brad Alpert NIST - compressed exact nonlocal rbcs Manuela de Castro, UFRGS Brazil - error estimates for the “classical” methods Tim Warburton, Virginia Tech - codeveloper of convenient formulation of arbitrary order local rbcs on boxes (or polygons) and of complete radiation boundary conditions (CRBC) Stephen Lau, UNM - formulations of exact and approximate radiation conditions for Maxwell Kurt Stein, APL - full 3d, high-order implementations of CRBC for acoustics John Lagrone, Tulane - 3d CRBC implementations for Maxwell (Yee scheme), Shidong Jiang, NJIT - extension (extraction) algorithms Dan Givoli, Daniel Rabinowitz Technion, Daniel Baffet Basel, and Jacobo Bielak CMU - DAB formulation of CRBCs and extensions to elastic waves Seungil Kim, Kyung Hee, Korea - CRBC for Helmholtz Fritz Juhnke, Bethel - High order CRBC for the wave equation Brian Citty - UQ for rbcs in random media
Transcript
Page 1: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Radiation boundary conditions for waves: the solved, the

unsolved, and potential applications to numerical relativity

Tom Hagstrom SMU

Collaborators in rbc work:S.I. Hariharan, U. Akron - first implementations of arbitrary order Bayliss-Turkel type rbcsLeslie Greengard NYU/Flatiron and Brad Alpert NIST - compressed exact nonlocal rbcsManuela de Castro, UFRGS Brazil - error estimates for the “classical” methodsTim Warburton, Virginia Tech - codeveloper of convenient formulation of arbitrary orderlocal rbcs on boxes (or polygons) and of complete radiation boundary conditions (CRBC)Stephen Lau, UNM - formulations of exact and approximate radiation conditions for MaxwellKurt Stein, APL - full 3d, high-order implementations of CRBC for acousticsJohn Lagrone, Tulane - 3d CRBC implementations for Maxwell (Yee scheme),Shidong Jiang, NJIT - extension (extraction) algorithmsDan Givoli, Daniel Rabinowitz Technion, Daniel Baffet Basel, and Jacobo Bielak CMU -DAB formulation of CRBCs and extensions to elastic wavesSeungil Kim, Kyung Hee, Korea - CRBC for HelmholtzFritz Juhnke, Bethel - High order CRBC for the wave equationBrian Citty - UQ for rbcs in random media

Page 2: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Goal: develop automatic, spectrally convergent near-field radiation boundary conditionsfor all linear hyperbolic problems (in homogeneous or stratified media)

Solved for a large class of important equations (wave equation, Maxwell’s equations, acous-tics) - complete radiation boundary conditions (CRBC)

For these equations the main remaining issue is their stable implementation in the widevariety of discretization schemes used to solve wave equations - we are trying to developa software library for this www.rbcpack.org - so far it only contains implementationsfor second order difference methods - but higher order difference and DG and CG imple-mentations will come (some day - F90 implementations are tested but not documented oravailable with user-friendly interfaces. I am happy to take suggestions on what aninterface should look like!

Extensions: dispersive equations (e.g. Lorentz, Drude models of EM waves in dispersivemedia - including metamaterial models), stratified media, elastic waves in simple settings,Schrodinger equations - we have shown that the method works but it is not yet fullyoptimized.

Page 3: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Unsolved:

• Local radiation conditions for problems with multiple dispersion relations and reversedmodes - i.e. waves with group and phase velocities misaligned relative to the boundary -the classic examples are elastic waves in certain anisotropic media or even in waveguidesfor isotropic elasticity.

My current belief is that our optimal local conditions cannot be generalized to thiscase - however compressed nonlocal conditions should be fine and some of the ideasdiscussed below (phase space filters) should also work.

• General variable coefficients and nonlinearities - for decaying potentials and weak non-linearities a perturbative approach is possible - (being used by Citty for random media)- we have ideas for making this efficient but they have not been carried out as yet, andcertainly not analyzed.

The phase space filter method has been applied to such problems - more work is needed tomake it more automatic.

Compactification combined with damping (e.g. the so-called supergrid method) and theuse of special coordinates (e.g. hyperboloidal layers, bicharacteristics).

Page 4: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Symmetric-hyperbolic system and boundary conditions in a half-space (add in physicalboundary conditions for waveguides and corner/edge conditions for free space - we knowhow to do this):

∂u

∂t+ A

∂u

∂x+∑j

Bj∂u

∂yj= 0

where Bj = BTj and

A =

A− 0 00 A+ 00 0 0

where A± are, respectively, negative-definite and positive-definite symmetric matrices. Thecorresponding partition of the solution, u = (u−, u+, u0)

T , corresponds to incoming, outgo-ing, and tangential variables.

We have block-diagonalized the matrix corresponding to x-derivatives in preparation forderiving boundary conditions on the hyperplane x = 0. For our error estimates we willassume that sources/scatterers/inhomogeneities are located a (small) distance δ from theboundary.

Page 5: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

'

&

$

%

x = −δ x = 0

Ω

Computational domain, Ω, for a scattering problem with a rectangular artificial boundary.

Page 6: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Exact radiation conditions can be characterized by Fourier-Laplace transformation -here s is dual to time k is dual to y. To properly label waves as causally incoming andoutgoing (produced by sources to the left or right of the boundary), it is important to take<s > 0. To develop approximations we will take

<s =1

T

where T is a time scale over which we want to guarantee accuracy - for example thesimulation time. Then incoming waves (which we must eliminate) correspond to solutionsof

su+ λAu+∑j

ikjBju = 0, <λ > 0

Projecting out the incoming waves leads to:

u− = R(s,k)u+

Page 7: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

In real space this condition takes the form

u− = F−1 (K ∗ (Fu+))

Where F is a spatial Fourier/spherical harmonic expansion and K∗ is a temporal convolu-tion - e.g. for Maxwell’s equations (H. and Lau, J. Comput. Math. 2007):

Plane K = |k|t J1(|k|t)

∂t(E2 −B3) +

1

2R (E2 −B3) +

1

2

∂E1

∂y− 1

2

∂B1

∂z= 0,

∂t(E3 +B2) +

1

2R (E3 +B2) +

1

2

∂E1

∂z+

1

2

∂B1

∂y= 0,

Sphere (Here the expansions are in terms of the tangential pure-spin spherical harmonics

- e.g. E =∑ErlmYlm + E

(1)lmΨlm + E

(2)lmΦlm), K = −

∑`k=1 (z`,k/R) ez`,kt/R where z`,k

are the roots of the Macdonald function K`+1/2:

∂t

(E

(2)lm +B

(1)lm

)+

1

RRE(2)

lm = 0,

∂t

(E

(1)lm −B

(2)lm

)− 1

RRB(2)

lm = 0,

,

Page 8: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

This may look hopelessly expensive due to the space-time integrals, but in fact we (and oth-ers) have constructed a fast, low-memory compression of the time integral operator (Alpert,Greengard, H. (SINUM 2000, JCP 2002), Lubich and Schadle, (SISC 2002), Hiptmair andSchadle, (Computing 2003), Sofronov (Russ. Acad. Sci. Dokl. Math. 1993, Euro. J.Appl. Math. 1998), book by Han and Wu (2014)). These are all based on spectrallyconvergent rational approximations to K. Directly, we replace the convolution withthe solution of Np ordinary differential equations. With these the complexity of applyingthe exact condition is essentially N · Np where N is the maximum harmonic index (bandlimit).

Np = O

(ln

1

ε· lnN

)For example assuming:

The tolerance, ε = 10−8

The harmonic index N is less than or equal to 1024

cT < 104 (plane - no restriction for the sphere)

Then Np ≤ 21 for the sphere and Np ≤ 64 for the plane.

Page 9: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Local approximate radiation conditions are defined by somewhat more restrictive rationalapproximations to R, RP , implemented by evolving P auxiliary variables on the bound-ary. (For second order equations we spread these one element/stencil width into a doubleabsorbing boundary - DAB - layer.)

The first such conditions were proposed (for the scalar wave equation) by Collino in 1993on a rectangle and for the sphere by H. and Hariharan in 1998 (Appl. Numer. Math.).Since the latter have actually been used in numerical relativity (see, e.g., Rinne, Buchman,Scheel and Pfeiffer Class. Quant. Grav. 2009) here they are:

∂u

∂t+∂u

∂r+u

R+ φ1 = 0

∂φk∂t

+k

Rφk = − 1

4R2

(∇2S + k(k − 1)

)φk−1 − φk+1,

with φ0 = u/2, φNp+1 = 0. This turns out to be exact for N ≤ Np but it is also quiteaccurate for δ > 0 and T <∞ for higher order modes.

The goal of our “new” formulation of local conditions (H. and Warburton Wave Motion2004) was to allow general polygonal boundaries (though too many corners and edgesis expensive) and to produce more standard hyperbolic systems for the auxiliary variables.

Skipping the motivation, in the end we solve for a collection of Np auxiliary functions φ onthe boundary with u− = Qφ

∂φ

∂t+∑j

Lj∂φ

∂yj+ Σφ = W

∂u+∂t

+∑j

Pj∂u+∂yj

+Mu+

Page 10: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Going to transform space we can write down the approximate radiation condition:

Rp = Q(s+∑j

ikjLj + Σ)−1(sW +∑j

ikjPj +M)

Using Parseval’s relation errors up time T are controlled by

ρ = max<s=T−1

e−<λ+δ‖R−Rp‖

For the solved problems constructing Rp can be reduced to the problem of approximatingthe square root function,

λ = (s2 + c2|k|2)1/2

Page 11: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

We compute optimal (minimax for ρ via the Chebyshev Theorem) approximations on <s =T−1 using rational interpolants of λ

In particular we interpolate λ whenever

λ = cos θjs+sin2 θj

cos θjcT

Theorem (H. and Warburton SINUM 2009): we can choose the parameters θj to guaranteean error less than ε up to time T with

NP ∝ ln1

ε· ln cT

δ.

Directly we show that the claimed estimate holds for approximations of the form:

cos θj =

(2

δ

cT ln 1ε

)j/(2NP )

, j = 0, . . . , 2NP − 1.

In practice we can use the Remez algorithm to compute optimal θj with these as an initalguess - convergence is essentially instantaneous.

User provides ε, cT/δ and we compute the optimal rbc.

Page 12: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

0 5 10 15 20 25 3010

−14

10−12

10−10

10−8

10−6

10−4

10−2

100

Order

Com

plex

Ref

lect

ion

Coef

ficie

ntConvergence of the Complete Radiation Boundary Conditions

η=10−3

η=10−4

Page 13: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Advantages of the local radiation conditions:

• No need for not-so-fast spatial transforms

• Applicable on polygonal radiation boundaries - the software in rbcpack assumes rightangles but the method works more generally with non-acute internal angles.

The idea is to construct corner/edge compatibility conditions (for first order equations) orcorner/edge layers as in the DAB formulation. In both cases these involve multiply indexedauxiliary variables which satisfy the equations from all neighboring faces. (Conceptuallysimple but algebraically messy.)

For example, on an edge we evolve N 2P auxiliary functions satisfying coupled hyperbolic

pdes and at a corner we evolve N 3P auxiliary functions satisfying odes.

The edge functions are forced by the face functions and provide boundary conditions for theface functions. The corner functions are forced by the edge functions and provide boundaryconditions for the edge functions.

Page 14: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Here are some numerical examples illustrating the accuracy obtained when the new approx-imations are included. The computations are due to Kurt Stein.

In the first we solve the acoustic system in a duct with cross-section [−1, 1]× [−1, 1] withforcing

F = 10 sin9 (2πt) sin10 (πx)(0, cos (5πy), sin (5πy), sin (5πz))

In the second we solve in free space with corner and edges closures and a point source.

The CRBCs were imposed at x = ±1.1. The solution is well-resolved in space and time-grid-stabilized 8th order spatial differencing (H. and Hagstrom, JCP 2007, JCP 2012)combined 4th order Runge-Kutta time stepping.

We use 4 − 12 terms in the boundary condition and compare actual errors with the apriori bounds. In all cases we match the a priori error estimate once the mesh issufficiently refined.

Page 15: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

0 10 20 30 40 50 60 70 80 90 10010

−10

10−9

10−8

10−7

10−6

10−5

10−4

10−3

10−2

time

||Q

exa

ct −

Qsim

ula

ted

|| /

ma

x(Q

exa

ct)

3d Duct Waveguide using Complete Radiation Boundary Conditions

P = 4

ρ(P = 4, η = 0.001)

P = 8

ρ(P = 8, η = 0.001)

P = 12

ρ(P = 12, η = 0.001)

Page 16: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

10−3

10−2

10−1

100

101

102

10−10

10−9

10−8

10−7

10−6

10−5

10−4

10−3

Free Radiating Box, Absolute Errors and Reflection Coefficients, δx=2/502, δt=1/1250, 0 < t < 100, x ∈ [−1,1]3

||P=4||

ρ(η=0.01, P=4)

||P=8||

ρ(η=0.01, P=8)

||P=12||

ρ(η=0.01, P=12)

||P=12|| − High Resolution ( δx =2/1002; δt = 1/5000)

Page 17: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Extraction - for data on a sphere the extraction operator (wave equation, Maxwell’s equa-tions) looks very similar to the operator appearing in the exact radiation condition - inessence we must simply make the relacement:

K ′`+1/2(Rs)

K`+1/2(Rs)→

K`+1/2(R+s)

K`+1/2(Rs).

Unfortunately, this operator seems to be not compressible with the same asymptoticcomplexity as the radiation kernel. (Although the poles are the same, the residues growexponentially fast with the harmonic index.) Nontheless we have a stable implementationwhich we have tested up to N = 130 (Greengard, H., Jiang for the wave equation (JCP2014) and using Debye potentials for Maxwell (JCP 2015). The algorithm has the form(with R = 1, r > 1:

φ0(t) = u`m(1, t)

φj(t) = φj−1(t) +

(1− 1

r

)z`,j

∫ t

0

ez`,j(t−p)φj−1(p)dp

u`m(r, t) =1

rφ`(t− r + 1).

(For stability the ordering of the poles matters!)

At least forN not too large, extraction with the advantage of limited angles and no harmonictransforms can be based of the auxiliary functions in the local rbcs on the sphere mentionedearlier - see Grote and Sim, JCP 230 2011.

Page 18: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Potential applications to numerical relativity - new issues not seen in the solved problemslisted above:

• More complicated linear problems (for linearized far fields) - slowly decaying back-ground metric

• Nonlinear effects if we move the boundary close to the action

• Lots of extra fields - constraint-preserving boundary conditions, gauge-related bound-ary conditions (10 wave equations but a 2-parameter family of waves).

A good discussion of the form of well-posed radiation conditions based on linear theory,but with compelling arguments suggesting they will be well-posed for the full problem inharmonic coordinates is Ruiz, Rinne and Sarbach Class. Quant. Grav. 30 2007.

One can project (locally) onto three types of terms:

Constraints - these must be imposed but can be written in “Sommerfeld-like” form.

Gauge - here there is a lot of freedom - in examples “Sommerfeld-like” conditions aresuggested but for our formulations it might be useful to apply radiation conditions onthese.

Physical - here accurate radiation conditions are needed.

Page 19: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

For the linearized problem the ideas used for Maxwell and acoustics can be generalized tosome extent:

Compressed Exact Conditions There have been successful generalizations of the AGHapproach to compressing the exact boundary conditions for the Regge-Wheeler equa-tion by Lau (Class. Quantum Grav. 2004, JCP 2004). The effectiveness of thecompression Lau finds is comparable to what is found for AGH in the case of the waveequation.

Local Conditions on a Sphere As mentioned earlier, these have been applied in theframework discussed above by Rinne, Buchman, Scheel and Pfeiffer.

CRBC? I have just started implementing these (and writing my first Einstein code) - Ihope to present some results in the next workshop!

What about (somehwat speculative) ideas for moving the boundary in closer?

Page 20: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Perturbative approach:

• Start with a limiting operator we can handle (e.g. flat space)

• Develop a formal expansion of the radiation condition assuming linear and nonlinearperturbations are small (fixed point iteration).

Citty has carried this out in the linear case for a random wave speed → random nonlocalboundary condition. The pole locations depend on the random process and the residuesare random variables.

The defect of the approach is a proliferation of poles - to be more practical one must applya pole reduction algorithm. The least squares algorithm used in AGH is an example of thisbut there are simpler and more automatic alternatives which only require linear algebra.J.-R. Li reproduced much of the AGH results using balanced truncation (Lin. Alg. Applic.2003), Beylkin and coworkers have built algorithms from solutions of the so-called con-eigenvalue problem (SIMAX 2012, Applied Comput. Harmon. Anal. 2009,2010).

Page 21: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Phase-space filter of Soffer and Stucchio - (JCP 2007, FACM 2008, CPAM 2009). Theydo apply it to problems with decaying potentials, reverse modes, and nonlinearities. Theconstruction is as follows:

i. Compute a localized Fourier transform in a layer around the computational domain

ii. Using the dispersion relation/asymptotics filter out waves which will certainly not affectthe computational domain.

iii. What remains after the filtering process are generally lower frequency waves - usingthis extend the domain with a coarser discretization.

iv. Repeat steps (i.-iii.) on the corser domain, recursively if needed.

The authors show that this can be made to work - issues are the correct tuning of the variousfiltering parameters. Here one might be able to use the con-eigenvalue stable algorithmsfor Prony’s method by Beylkin and Monzon mentioned above.

Page 22: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

Compactifications - an automatically stable procedure which can be made to converge fairlyrapidly for the bad elastic problems, and is also used for nonlinear problems, is the so-called“supergrid” layer (Appelo and Colonius JCP 2009). It involves two pieces:

i. Grid stretching so that waves cannot reach the end of the layer in time T - this leads tohighly oscillatory solutions in the layer which cannot be resolved

ii. High order damping to kill the unresolved waves before they reflect

As mentioned in talks here, one can also look at coordinate changes to produce less oscilla-tory solutions in the layer (e.g. the hyperboloidal layer of Zenginoglu or coordinates basedon geometrical optics (e.g. old work by Radvogin in the USSR).

Analysis:

i. Fourier-Laplace transform in the tangential direction and time;

ii. Semidiscretize the layer in the normal direction;

L(s,k)[u0, . . . , uN ]T = Q(s,k)u+

iii. Solve the resulting algebraic problem to express the relationship between incoming andoutgoing variables as a rational matrix function of the spectral parameters:

u0,− = u− = RP (s, k)u+

We have tried this with spectral discretizations and simple optimization procedures, butso far this has not produced anything as good as the local boundary conditions. But themethods are quite general and can bemade to work with enough tuning

Page 23: Radiation boundary conditions for waves: the solved, the … · 2020. 10. 7. · Local approximate radiation conditions are de ned by somewhat more restrictive rational approximations

THANK YOU!


Recommended