534
Views
2
CrossRef citations to date
0
Altmetric
Articles

Acoustic multi-parameter full waveform inversion based on the wavelet method

Pages 220-247 | Received 06 Mar 2020, Accepted 12 Jun 2020, Published online: 26 Jun 2020

Abstract

In this paper, the acoustic full waveform inversion based on the wavelet method is proposed. It allows to determine density and velocity parameters simultaneously in the time domain. The forward problem is solved based on the wavelet method. The numerical schemes for modelling are constructed in detail. The stability condition is derived for the first time. The inversion is an optimization process for minimizing the mismatch between the synthetic data and the observed data. The computational scheme for the gradient of the objective function is constructed based on the matrix analysis technique. The inversion is implemented from low frequency to high frequency successively. Furthermore, the inversion result of current low frequency is served as the initial guess of next high frequency. This hierarchic strategy includes the smaller wavelengths progressively and improves the inversion robustness. Numerical computations for the benchmark Marmousi model demonstrate that the method has good ability to reconstruct media parameters in complex structures.

Mathematics Subject Classifications:

1. Introduction

Seismic full waveform inversion (FWI) can quantitatively determine model parameters of the media by using all information of wavefield including phase, amplitude and traveltime. It is a feasible and essential technology to build a good subsurface model to explore oil and gas reservoir in geophysics. FWI was initially proposed by Lailly and Tarantola in 1980s for the acoustic wave equation in the time domain [Citation1,Citation2]. It is in fact a data-fitting procedure based on numerical optimization. In [Citation1,Citation2], the gradient method is applied and the gradient direction is constructed by crosscorrelating forward wavefield from the sources with backward wavefield from the residuals. This gradient computational way requires only several forward computations and avoids intensive computational amount which the explicit approaches meet. This key idea was quickly applied to elastic media in the time domain using multicomponent data [Citation3,Citation4]. In 1990, the formulation of FWI in the frequency domain was developed by Pratt [Citation5,Citation6]. Each type of method has its advantages. For the time-domain method there is no need to transform data into the Fourier domain, whereas the frequency-domain needs. So the wavefield in the time domain is real valued whereas it is complex valued in the frequency domain. In addition, the parallel code implementation of FWI in the time domain is relatively easy. An overview of FWI in exploration geophysics may refer to [Citation7]. FWI also has been developed in other domains such as the Laplace domain [Citation8] and the Laplace-Fourier domain [Citation9]. Recently, FWI has been explored in viso media [Citation10] and anisotropic media [Citation11]. Due to the the significant advance of computer power in last ten years, FWI has been used both in academics and geophysical application.

FWI is a non-linear and ill-posed inverse problem and the solution is non-unique. Instead of the global optimization methods such as the simulated annealing algorithm and the genetic algorithms, the gradient-based minimization techniques are usually adopted (e.g. see [Citation7,Citation12,Citation13]). They include the steepest descent method, the Gauss-Newton and full Newton methods [Citation14], the Newton-CG method [Citation15], the truncated Newton method [Citation10,Citation12] and so on. The Newton method is quadratically convergent but requires the computation of the second-order derivatives of the objective function (Hessian matrix) with respect to the model parameters, which is not adopted generally for its huge computational cost. The main problem in FWI is that the inversion usually converges to a local minimum solution when the initial model deviates significantly from the true model. Besides the nonlinearity and non-convexity of the misfit function, the cycle skipping is another major reason to cause the phenomenon of multiple solutions. In particular, each local minimum of the misfit function corresponding to fitting the data up to one phase or several shifts. Several types of techniques have been proposed to overcome this problem. The first is the regularization strategy such as the Tikhonov regularization [Citation16,Citation17] and the total variation (TV) regularization [Citation11,Citation18], which have been applied to stabilize the ill-posedness in the nonlinear inversion process. The second is the multiscale method promoted by Bunk [Citation19], which overcomes the ill-posedness of FWI by incorporating progressively shorter wavelengths of the model. In this method, FWI is performed by starting low frequencies and moving to higher frequencies successively. This strategy includes the smaller wavelengths progressively and guarantees the inversion convergence utmost since the objective function has few local minima at low frequencies. It has been realized it is more effective than the Tikhonov regularization and TV regularization. Recently, the optimal transport method, which increases the convexity of the misfit function by the Wasserstein metric rather than the L2 metric, has been applied to FWI [Citation20,Citation21]. The multiscale method can be considered as a macro-regularization strategy.

In FWI, the forward problem is required to solve repeatedly. There are several numerical methods to solve the wave equation, for example, the finite difference method [Citation22,Citation23], the pseudo-spectral method [Citation24,Citation25], the finite volume method [Citation26], the finite element method [Citation27–29]. Each method has its own advantages and disadvantages. Among of them, the finite difference method is very popular in FWI since its high efficiency and relative easiness of code implementing. In comparison with the traditional numerical methods, the wavelet-based method for solving partial differential equations including wave equations numerically is relatively new [Citation30–34]. In wavelet methods, the wavelet basis has the good potential to capture the complex structures since its multiresolution. In this paper, we investigate and develop the wavelet-based FWI for determining the velocity and density coefficients in the acoustic wave equation.

In this paper, the time-domain acoustic FWI based on the wavelet method is investigated. The rest of the paper is organized as follows. In Section 2, the forward method by the wavelet method is investigated in detail. In Section 3, the inverse method for the density and velocity parameters in the acoustic wave equation is described. In Section 4, numerical computations are presented to illustrate the performance of the method. Finally, the conclusion is given in Section 5.

2. Forward method

The two dimensional acoustic wave equation with density and velocity can be written as (1) 1ρv22ut2div1ρu=f(t)δ(xxs)δ(zzs),(1) where u is the pressure, ρ is the density, v is the velocity, f(t) is the source functions at the point position (xs,zs). Introducing the auxiliary variables wx=ut and wz=ut, we can rewrite (Equation1) as (2) wxt=1ρux,(2) (3) wzt=1ρuz,(3) (4) 1ρv2ut=wxx+wzz+Tf(t)δ(xxs)δ(zzs)dt.(4) The initial conditions are (5) u(x,z,t)|t=0=0,ut(x,z,t)|t=0=0.(5) Equation (Equation1) or the equivalent (Equation2)–(Equation4) with (Equation5) and suitable boundary conditions form an initial boundary value problem, which the uniqueness and existence of the solution to this problem is known theoretically [Citation35]. This forward problem is also well posed. Numerically, we have several methods to solve it. For example, the finite difference method [Citation22,Citation23], the finite element method [Citation27,Citation28] and so on. If the staggered-grid finite difference method is applied to (Equation2)–(Equation4) and (Equation5), we get the following schemes (6) (wx)i+12,jn+12(wx)i+12,jn12=(12ρi+1,j+12ρi,j)Δthx(ui+1,jnui,jn),(6) (7) (wz)i,j+12n+12(wz)i,j+12n12=(12ρi,j+12ρi,j+1)Δthz(ui,j+1nui,jn),(7) (8) ui,jn+1ui,jn=ρvi,j2Δthx((wx)i+12,jn+12(wx)i12,jn+12)+ρvi,j2Δthz((wz)i,j+12n+12(wz)i,j12n+12)+ρvi,j2Δt2s=0nfi,js,(8) with initial conditions (9) (wx)i+12,j12=0,(wz)i,j+1212=0,ui,j0=0,(9) where Δt is the time step, and hx and hz are the spatial steps in the x and z directions respectively. In the following, we apply the wavelet method to solve it. We first introduce the orthonormal wavelet bases and some related properties. Then we derive the wavelet-based computational schemes for solving (Equation2)–(Equation4).

2.1. Orthonormal wavelet basis

In this subsection, we briefly review the orthonormal bases of compactly supported wavelets. For the details we refer to [Citation36–39]. The orthonormal basis of compactly supported wavelets in L2(R) is constructed by the dilation and translation of a single function ψ(x), (10) ψj,k=2j/2ψ(2jxk),(10) where j,kZ. The function ψ(x) has a companion, the scaling function ϕ(x). The functions ϕ(x) and ψ(x) satisfy the following relations (11) ϕ(x)=2k=0L1hkϕ(2xk),(11) (12) ψ(x)=2k=0L1gkϕ(2xk),(12) where (13) gk=(1)khLk1,k=0,,L1,(13) and (14) ϕ(x)dx=1.(14) In addition, the function ψ(x) has M vanishing moments (15) ψ(x)xmdx=0,m=0,,M1.(15) Where L in (Equation11)–(Equation12) is related to M. For Daubechies' wavelets [Citation37] applied in this paper, L = 2M. The coefficient sets H={hk}k=0k=L1 and G={gk}k=0k=L1 in (Equation11)–(Equation12) are quadrature mirror filters. Once the filter H has been chosen, the wavelet function ψ and the scaling function φ are determined. The wavelet coefficients of Daubechies' wavelets can be computed by multiresolution analysis algorithm [Citation39].

In the multiresolution analysis, the Hilbert space L2(R) is decomposed into a chain of closed subspaces: V2V1V0V1V2 such that jZVj=0,jZ¯Vj=L2(R). Let Wj be the orthogonal complement of Vj in Vj1: Vj1=VjWj, then L2(R) can be expressed as a direct sum of Wj, i.e. L2(R)=jZWj. For a fixed scale j, the scale functions ϕj,k(x) and the wavelets ψj,k(x) form the orthonormal bases of Vj and Wj respectively, i.e. Vj=span{ϕj,k:kZ}¯,Wj=span{ψj,k:kZ}¯. Thus fjVj, there is the following decomposition (16) fj=fj+1+f^j+1,(16) where (17) fj+1=lZcljϕj+1,kVj+1,f^j+1=lZdlj+1ψj+1,kWj+1,(17) with clj+1=fj,ϕj+1,l,dlj+1=fj,ψj+1,l, where <f,g> is defined as If(x)g(x)¯dx for any functions f(x),g(x)L2(R) on I, and ckj+1=lZh¯l2kclj,dkj+1=lZg¯l2kclj. An effective way to construct two-dimensional wavelets is by using the tensor product of one-dimensional wavelets. Define Vj2=VjVj. Here denotes the tensor product. Then similarly, L2(R2) is decomposed into a chain of closed subspaces Vj2. Making the decomposition of the direct sum, we konw Vj12=Vj2Wj2, where Wj2=(VjWj)(WjVj)(WjWj). Thus L2(R2)=jZWj2. Furthermore, {ϕj,k(x)ϕj,m(z)}k,mZ form the orthonomal bases of Vj2; {ϕj,k(x)ψj,m(z),ψj,k(x)ϕj,m(z),ψj,k(x)ψj,m(z)}k,mZ form the orthonomal bases of Wj2.

2.2. Wavelet-based forward scheme

In this subsection, we construct the forward computational scheme on staggered grids based on the wavelet method. We employ the scaling function φ to express the wavefields u, wx and wz in (Equation2)–(Equation4). Let (18) un=i,jZck,i,ju,nϕk,i(x)ϕk,j(z),(18) (19) wxn+12=i,jZck,i+12,jwx,n+12ϕk,i+12(x)ϕk,j(z),(19) (20) wzn+12=i,jZck,i,j+12wz,n+12ϕk,i(x)ϕk,j+12(z).(20) Applying φ as the test function to the source-free system (Equation2)–(Equation4), we have (21) (wxn+12wxn12,ϕk,i+12(x)ϕk,j(z))=Δtρ(unx,ϕk,i+12(x)ϕk,j(z)),(21) (22) (wzn+12wzn12,ϕk,i(x)ϕk,j+12(z))=Δtρ(unz,ϕk,i(x)ϕk,j+12(z)),(22) (23) (1ρv2(un+1un),ϕk,i(x)ϕk,j(z))=Δt(wxn+12x,ϕk,i(x)ϕk,j(z))+Δt(wzn+12z,ϕk,i(x)ϕk,j(z)).(23) We need to compute the integrals in (Equation21)–(Equation23). Let (24) rl,i=+ϕ(xl)ϕ(xi)dx,(24) (25) rl+12,i+12=+ϕ(xl12)ϕ(xi12)dx,(25) (26) rl+12,i1=+ϕ(xl12)xϕ(xi)dx,(26) (27) rl,i+121=+ϕ(xl)xϕ(xi12)dx.(27) Obviously, (28) rl,i=rl+12,i+12,rl+12,i1=rl,i+121.(28)

So by the property in multiresolution analysis, we have (29) s(l,m),(i,j)=+ϕ(xl)ϕ(zm)ϕ(xi)ϕ(zj)dxdz=+ϕ(xl)ϕ(xi)dx+ϕ(zm)ϕ(zj)dz=rl,irm,j,(29) (30) s(l+12,m),(i,j)1,x=+ϕ(xl12)xϕ(zm)ϕ(xi)ϕ(zj)dxdz=+ϕ(xl12)xϕ(xi)dx+ϕ(zm)ϕ(zj)dz=rl+12,i1rm,j,(30) (31) s(l,m+12),(i,j)1,z=+ϕ(xl)ϕ(zm12)zϕ(xi)ϕ(zj)dxdz=+ϕ(xl)ϕ(xi)dx+ϕ(zm12)zϕ(zj)dz=rl,irm+12,j1,(31) Since ϕk,i=2k/2ϕ(2kxi), then we have (32) (ϕk,l(x)ϕk,m(z),ϕk,i(x)ϕk,j(z))=+2kϕ(2kxl)ϕ(2kzm)2kϕ(2kxi)ϕ(2kzj)dxdz=s(l+12,m),(i,j)=rl,irm,j,(32) (33) (ϕk,l+12(x)xϕk,m(z),ϕk,i(x)ϕk,j(z))=+22kϕ(2kxl12)xϕ(2kzm)2kϕ(2kxi)ϕ(2kzj)dxdz=2ks(l+12,m),(i,j)1,x=2krl+12,i1rm,j,(33) (34) (ϕk,l(x)ϕk,m+12(z)z,ϕk,i(x)ϕk,j(z))=+22kϕ(2kxl)ϕ(2kzm12)z2kϕ(2kxi)ϕ(2kzj)dxdz=2ks(l,m+12),(i,j)1,z=2krl,irm+12,j1.(34) By the properties of translation and symmetry, we have (35) (ϕk,l+12(x)ϕk,m(z),ϕk,i+12(x)ϕk,j(z))=rl+12,i+12rm,j=rl,irm,j,(35) (36) (ϕk,l(x)ϕk,m+12(z),ϕk,i(x)ϕk,j+12(z))=rl,irm+12,j+12=rl,irm,j,(36) (37) (ϕk,l(x)xϕk,m(z),ϕk,i+12(x)ϕk,j(z))=2krl,i+121rm,j=2krl+12,i1rm,j,(37) (38) (ϕk,l(x)ϕk,m(z)z,ϕk,i(x)ϕk,j+12(z))=2krl,irm,j+121=2krl,irm+12,j1.(38) Therefore, we only need to compute rl,i and rl+12,i1. By the orthogonality of φ, we have (39) rl,i={1,l=i,0,li.(39) In this paper, we employ Daubechies wavelet [Citation37] with M = 4 since this wavelet is smooth. The coefficients rl+12,i1 can be computed numerically. The details are given in Appendix 1. The results are the following: (40) rl+12,l+11=rl+12,l1=1.3110341,rl+12,l+21=rl+12,l11=1.5601008E01,rl+12,l+31=rl+12,l21=4.1995747E02,rl+12,l+41=rl+12,l31=8.6543237E03,rl+12,l+51=rl+12,l41=8.3086955E04,rl+12,l+61=rl+12,l51=1.0899854E05,rl+12,l+71=rl+12,l61=4.1057155E09,rl+12,l+q1=0,q<6orq>7.(40) In numerical computations the computational domain is finite and absorbing boundary condition (ABC) is necessary to eliminate the boundary reflections. Several approaches can be used, for example, the paraxial approximation [Citation40], the exact nonreflecting conditions [Citation41,Citation42] and the perfectly matched layer (PML) method [Citation43]. The PML is the most widely used method and we adopt it in this paper. As my best knowledge, there is no work to incorporate the PML to solve the wave equation based on the wavelet method. The idea of PML is to design a particular layer around the computational domain in which the waves will be attenuated satisfactory. The details are omitted for saving space.

2.3. Stability analysis

We use the Fourier method to analyse the stability. Suppose the computational domain is Ω=[0,L~]×[0,L~]. Note that the wavelet computations map the computational domain to [0,1]×[0,1]. So the first derivative will produce a factor 1/L~. For convenience, denote the wavelet coefficients ck,i,ju,n, ck,i+12,jwx,n+12, ck,i,j+12wz,n+12 for a fixed k by ui,jn, (wx)i+12,jn+12, (wz)i,j+12n+12, k=1,,7, respectively. We rewrite (Equation21)–(Equation23) as the following recursive form in the time index n (41) (wx)i+12,jn+12(wx)i+12,jn12=Δt2kL~ρl=17r12,l1(ui+l,jnuil+1,jn),(41) (42) (wz)i,j+12n+12(wz)i,j+12n12=Δt2kL~ρl=17r12,l1(ui,j+lnui,jl+1n),(42) (43) ui,jn+1ui,jn=ρv2Δt2kL~l=17r12,l1[(wx)i12+l,jn+12(wx)i+12l,jn+12]+ρv2Δt2kL~l=17r12,l1[(wz)i,j12+ln+12(wz)i,j+12ln+12],(43) By applying the Fourier stability analysis method [Citation44], we have (44) (w^x)n+12(w^x)n12=rxρqxu^n,(w^z)n+12(w^z)n12=rzρqzu^n,u^n+1u^n=ρv2rxqx(w^x)n+12+ρv2rzqz(w^z)n+12,(44) where w^x, w^z and u^ are the the Fourier transform of wx, wz and u respectively, and (45) rx=rz=Δt2kL~,qx=2i(l=17r12,l1sin(l12)σx),qz=2i(l=17r12,l1sin(l12)σz).(45) Here i=1. Note that |l=17r12,l1sin(l12)σ|l=17|r12,l1|=1.518535998. Eliminating (w^x)n+12 and (w^z)n+12 in (Equation44), we have (46) u^n+12u^n+u^n1=v2rx2qx2u^n+v2rz2qz2u^n.(46) Let qx2=px and qz2=pz. The characteristic equation of (Equation46) is λ2(2+v2(pxrx2+pzrz2))λ+1=0. The stability requires the two characteristic roots are in the unit circle, which yields the condition (47) |2+v2(pxrx2+pzrz2)|2,(47) Solving (Equation47) we get the sufficient and necessary stability condition for the wavelet schemes (Equation41)–(Equation43) (48) Δt2kL~vmax/2×1.518535998,orrx=rz0.573815739vmax,(48) where vmax is the maximal velocity.

3. Inversion method

To develop the FWI method, we firstly define the objective function as the L2 norm of the residuals between the synthetic data u(xr,t;xs) and the observed data uobs(xr,t;xs): (49) F(m)=12xsxr0T[u(xr,t;xs)uobs(xr,t;xs)]2dt,(49) where xs is the shot position and xr the receiver position, m=(v,ρ) is the model parameters, and T is the total recording time. The summations in (Equation49) are performed over the number of all sources and receivers. The FWI is an iterative process for minimizing the objective function. The iterative formulation can be written as (50) mk+1=mk+αkΔmk,k=0,1,2,,(50) where the subscript k denotes the kth iteration, m0 is the initial model, Δmk indicates the model update, and αk is the stepsize and a scalar estimated via a line search method. In this paper, the strong Wolfe line search [Citation45] is used. Generally, the model update has the following form (51) Δmk=Gk1F(mk),(51) where Gk is a symmetric and nonsingular matrix. In the steepest descent method Gk is simply the identity matrix, whereas in Newton method Gk is the exact Hessian 2F(mk). In quasi-Newton methods, Gk is an approximation to the Hessian that is updated at every iteration. Methods that use the Newton direction have a fast rate of local convergence. The main drawback of the Newton direction is the need for the Hessian. For large-scale FWI, the computation cost of the Hessian and its inverse is beyond current computational capability. So the Newton method is seldom applied in FWI. The quasi-Newton methods do not require computation of the Hessian and yet still attain a superlinear rate of convergence [Citation45]. In this paper, a quasi-Newton method named limited-memory BFGS (L-BFGS) method [Citation45] is applied for its good behaviour in the time-domain FWI. Recently, the truncated Newton method has been applied to FWI (e.g. see [Citation10,Citation12]). The truncated Newton method was initially developed by Dembo and Steihaug [Citation46] in 1983. It solves the Newton equation by the conjugate gradient method iteratively. Thus it has much computational cost to obtain Hessian than the L-BFGS method. The L-BFGS method consists in approximating the inverse Hessian by several previous values of the gradient.

We remark that all optimization-based approaches mentioned above are converged locally and suffer from the local-minima trapping problem. So some techniques such as the successive inversion strategy is necessary to improve the robustness and accuracy of the inversion. The inversion is implemented from low frequency to high frequency successively. The inversion at the stage of using low frequency date has more probability to escape the local-minima trap. We note that a so-called convexification method initially proposed by Klibnanov [Citation47] is a globally convergent method which can overcome the local-minima trapping problem. The application of this method is beyond the scope of this paper. For the details, we refer to the series of works of Klibanov with coauthors [Citation48,Citation49] and the references therein.

As FWI is an ill-posed problem, a regularization term is necessary in the objective function to stable the solution. So (Equation49) is revised as (52) F(m)=12xsxr0T[u(xr,t;xs)uobs(xr,t;xs)]2dt+αΩ(m),(52) where α is the regularization parameter which is estimated based on the amplitude of the objective function in this paper, and Ω(m) is the regularization function with two typical approaches. One is the Tikhonov regularization (53) Ω1(m)=12m22=12i=1Nxj=1Nz|mi,j|2.(53) The other is the TV regularization (54) Ω2(m)=mTV=i=1Nxj=1Nz|mi,j|.(54) Generally, the TV regularization improves inversion accuracy at discontinuous positions of model parameters whereas the Tikhonov regularization smoothes the inversion solutions.

Note that the gradient of the objective function is required in FWI. The gradient of Ω(m) with respect to model parameters can be computed by the standard finite difference method directly. For example, for the Tikhonov regularization (Equation53), the result is (55) Ω1(m)mi,j=1hx2(mi+1,j2mi,j+mi1,j)+1hz2(mi,j+12mi,j+mi,j1).(55) As for the TV regularization (Equation54), we have (56) Ω2(m)mi,j=[(mi,jmi1,jhx)2+(mi1,j+1mi1,jhz)2+ϵ]12(mi,jmi1,j)hx2+[(mi+1,jmi,jhx)2+(mi,j+1mi,jhz)2+ϵ]12×[(mi,jmi+1,j)hx2+(mi,jmi,j+1)hz2]+[(mi+1,j1mi,j1hx)2+(mi,jmi,j1hz)2+ϵ]12(mi,jmi,j1)hz2,(56) where ϵ>0 is a small parameter to prevent the singularity. In the following, we will focus on the gradient of F(m) or F(v,ρ) with respect to the model parameters v and ρ, which is required in the L-BFGS method.

3.1. Computational schemes for the gradient

In this subsection, we will derive the numerical schemes for the gradient of the objective function F(m) with respect to the model parameters v and ρ. Let the discrete points number in x and z directions are Nx and Nz respectively. Then the difference scheme for (Equation1) with the second-order accuracy is (57) 1ρi,jvi,j21Δt2(ui,jn+12ui,jn+ui,jn1)=1hx2(12(1ρi+1,j+1ρi,j)(ui+1,jnui,jn)12(1ρi,j+1ρi1,j)(ui,jnui1,jn))+1hz2(12(1ρi,j+1+1ρi,j)(ui,j+1nui,jn)12(1ρi,j+1ρi,j1)(ui,jnui,j1n))+fi,jn,i=0,,Nx;j=0,,Nz;n=0,,Nt1,(57) where 1ρi+12,j=12(1ρi,j+1ρi+1,j),1ρi,j+12=12(1ρi,j+1ρi,j+1). Arranging the spatial indexes in x direction first and then in z direction, we rewrite (Equation57) as the following matrix form: (58) A(u¯n+12u¯n+u¯n1)=Ku¯n+f¯n,n=0,,Nt1,(58) where (59) u¯n=(u0,0n,,u0,Nzn,,uNx,0n,,uNx,Nzn)T,f¯n=(f0,0n,,f0,Nzn,,fNx,0n,,fNx,Nzn)T,A=1Δt2(1ρv0,020001ρv0,120001ρvNx,Nz2),(59) (60) K=(K0,0K1,00K0,1K1,1K2,100KNx,Nx1KNx,Nx),(60) with (61) Ki+1,i=(12(1ρi+1,0+1ρi,0)1hx200012(1ρi+1,1+1ρi,1)1hx200012(1ρi+1,Nz+1ρi,Nz)1hx2),i=0,1,,Nx1,Ki1,i=(12(1ρi1,0+1ρi,0)1hx200012(1ρi1,1+1ρi,1)1hx200012(1ρi1,Nz+1ρi,Nz)1hx2),i=1,2,,Nx,Ki,i=(k0,0k0,10k1,0k1,1k1,200kNz,Nz1kNz,Nz).(61) The nonzero elements of Ki,i in (Equation61) are the following kj,j=12(1ρi+1,j+2ρi,j+1ρi1,j)1hx212(1ρi,j+1+2ρi,j+1ρi,j1)1hz2,j=0,1,,Nz,kj,j+1=12(1ρi,j+1+1ρi,j)1hz2,j=0,1,,Nz1,kj,j1=12(1ρi,j1+1ρi,j)1hz2,j=1,2,,Nz. Note that Ki+1,i,Ki1,i are the diagonal matrices and Ki+1,i=Ki,i+1. We know Ki,i is symmetric since kj,j+1=kj+1,j. Thus KT=K.

Furthermore, the system (Equation58) can be rewritten as the following matrix form (62) Mu=f,(62) where (63) u=(u¯0,u¯1,,u¯Nt)T,f=(0,f¯0,,f¯Nt1)T,M=(A0002AKA00A2AKA000A2AKA).(63) Note that A and K are all symmetric matrices.

Now making derivatives of the objection with respect to vi,j and ρi,j, we get (64) F(v,ρ)vi,j=uTvi,jd,F(v,ρ)ρi,j=uTρi,jd,(64) where d¯n=(d0,0n,,dNx,Nzn)T,d=(d¯0,,d¯Nt)T, and di,jn={ui,jn(uobs)i,jn,(i,j)=xr,0,else. And making derivatives of (Equation62) with respect to vi,j and ρi,j, we have (65) uvi,j=M1Mvi,ju,uρi,j=M1Mρi,ju.(65) Inserting (Equation65) into (Equation64) yields (66) F(v,ρ)vi,j=(Mvi,ju)TMT(d),F(v,ρ)ρi,j=(Mρi,ju)TMT(d).(66) By (Equation63) we have (67) Mvi,j=(Avi,j0002Avi,jAvi,j00Avi,j2Avi,jAvi,j000Avi,j2Avi,jAvi,j),(67) where the elements Avi,j are given in Appendix 2. Then for a given vector u¯n: (68) u¯n=(u0,0n,,u0,Nzn,,uNx,0n,,uNx,Nzn)T,(68) we have (69) Mvi,ju=(w¯0w¯1w¯Nt1w¯Nt),w¯0=(0000),w¯n+1=(02ρvi,j31Δt2(ui,jn+12ui,jn+ui,jn1)0),n=0,1,,Nt1.(69) We now consider to compute Mρi,ju. First by (Equation63), we have (70) Mρi,j=(Aρi,j0002Aρi,jKρi,jAρi,j00Aρi,j2Aρi,jKρi,jAρi,j000Aρi,j2Aρi,jKρi,jAρi,j),(70) where the elements Aρi,j and Kρi,j are also given in Appendix 2. Thus (71) Mρi,ju=(ψ¯0ψ¯1ψ¯Nt1ψ¯Nt)+(φ¯0φ¯1φ¯Nt1φ¯Nt),n=0,1,,Nt1,(71) where ψ¯0=0, and (n=0,1,,Nt1) ψ¯n+1=(0,,1(ρvi,j)21Δt2(ui,jn+12ui,jn+ui,jn1),,0)T,φ¯n+1=(φ0,0n+1,,φ0,Nzn+1,,φNx,0n+1,,φNx,Nzn+1)T=Kρi,ju¯n,φi,jn+1=12ρi,j2(1hx2(ui+1,jn2ui,jn+ui1,jn)+1hz2(ui,j+1n2ui,jn+ui,j1n)),φi±1,jn+1=12ρi,j21hx2(ui,jnui±1,jn),φi,j±1n+1=12ρi,j21hz2(ui,jnui,j±1n),φp,qn+1=0,(p,q)(i,j),(i±1,j),(i,j±1). Since A and K are symmetric matrices, we have the following lemma.

Lemma 3.1

Suppose ϕ=(ϕ¯0,ϕ¯1,,ϕ¯Nt)T is solution of MT(d), then ϕ~=(ϕ¯Nt,ϕ¯Nt1,,ϕ¯0)T is the solution of M1(d).

Proof.

By the definition we rewrite (d)=MTϕ for n=Nt1,,1 as (72) Aϕ¯Nt=d¯Nt,Aϕ¯Nt12Aϕ¯Nt=Kϕ¯Ntd¯Nt1,Aϕ¯n12Aϕ¯n+Aϕ¯n+1=Kϕ¯nd¯n1.(72) Similarly, we rewrite (d)=Mϕ~ for n=Nt1,,1 as (73) Aϕ¯Nt=d¯Nt,Aϕ¯Nt12Aϕ¯Nt=Kϕ¯Ntd¯Nt1,Aϕ¯n12Aϕ¯n+Aϕ¯n+1=Kϕ¯nd¯n1.(73) By (Equation72) and (Equation73) we know the conclusion of this lemma is true. The proof is complete.

From Lemma 3.1, we know that ϕ~ is the numerical solution to the backward problem corresponding to (Equation1) with the source term replaced by the residuals.

Therefore, by (Equation66) we obtain the computational schemes for the gradient of the objection: (74) F(v,ρ)vi,j=n=0Nt1(w¯n)Tϕ¯n=n=1Nt12ρvi,j31Δt2(ui,jn+12ui,jn+ui,jn1)ϕi,jn+1,(74)

and (75) F(v,ρ)ρi,j=n=0Nt1(ψ¯n)Tϕ¯n+(φ¯n)Tϕ¯n=n=1Nt11(ρvi,j)21Δt2(ui,jn+12ui,jn+ui,jn1)ϕi,jn+1+Hn,(75) where Hn=12ρi,j2(1hx2(ui+1,jnui,jn)(ϕi+1,jn+1ϕi,jn+1)+1hx2(ui,jnui1,jn)(ϕi,jn+1ϕi1,jn+1)+1hz2(ui,j+1nui,jn)(ϕi,j+1n+1ϕi,jn+1)+1hz2(ui,jnui,j1n)(ϕi,jn+1ϕi,j1n+1)).

4. Numerical computations

In this section we first consider the numerical computations of forward problem. Then we consider the inversion for a complicated benchmark model named Marmousi model.

4.1. Forward computations

We now present two examples to show the numerical results of the forward problem. The first example is a homogeneous triangular model with constant velocity 3000m/s and constant density 1000kg/m3. The physical domain is (x,z)=[0,6km]×[0,3km]. In computations, the spatial step is hx=hz=12m and the time step is Δt=0.001s. The source is located at (3km,1.5km), which is the Ricker wavelet with the time history (76) f(t)=(12(πf0t)2)e(πf0t)2,(76) where f0=15Hz is the central frequency. Figure  is the snapshot of wavefield at propagation time 1.1s. Figure (a) is the result by the staggered-grid method without absorbing boundary conditions. In Figure (a), we can see the serious reflections from the top and bottom boundaries. Figure (b) is the result by the wavelet method with the PML boundary conditions. The PML is around the computational model. In Figure (b) we can see the boundary reflections are eliminated obviously.

Figure 1. The snapshot of wavefield at propagation time 1.1s by the wavelet method (a) without absorbing boundary conditions and (b) with PML absorbing boundary conditions.

Figure 1. The snapshot of wavefield at propagation time 1.1s by the wavelet method (a) without absorbing boundary conditions and (b) with PML absorbing boundary conditions.

The second example is the Marmousi model [Citation50] with complex structures. The exact velocity is shown in Figure  and it will be used in the inversion computations. The computational domain is (x,z)=[0,6km]×[0,3km]. The spatial step is hx=hz=12m and the time step is Δt=0.001s. The thickness of PML is 420m. The shots and receivers are arranged under the surface 24m. The sketch map of the data acquisition system is shown in Figure . This data observation geometry is analogous to the acquisition system of reflection seismology in geophysical exploration. In Figure , the blue points denote the shots and the red crosses denote the receivers. Figure (a) is a shot gather with the shot located at the left side of the model. Figure (b) is another shot gather with the shot located at the middle of the model. In both Figure (a,b), we can see the boundary reflections are eliminated obviously. For comparison with Figure , the corresponding shot gather by the staggered-grid method is shown in Figure . Comparing Figure  with Figure , we can clearly see that the waveform in Figure  by the wavelet method has much less dispersion.

Figure 2. The sketch map of data acquisition system. The blue points denote the shots and the red crosses denote the receivers. The shots and receivers are arranged under the surface 24m. The thickness of PML is 420m.

Figure 2. The sketch map of data acquisition system. The blue points denote the shots and the red crosses denote the receivers. The shots and receivers are arranged under the surface 24m. The thickness of PML is 420m.

Figure 3. The shot gather for the Marmousi model computed by the wavelet method. The shot located at two different positions near the surface, i.e. (a) the left side of the model, x = 0; (b) the middle of the model, x = 3 km. Each shot has 200 receivers. The horizontal axis is the receiver points. The vertical axis is the time points.

Figure 3. The shot gather for the Marmousi model computed by the wavelet method. The shot located at two different positions near the surface, i.e. (a) the left side of the model, x = 0; (b) the middle of the model, x = 3 km. Each shot has 200 receivers. The horizontal axis is the receiver points. The vertical axis is the time points.

Figure 4. The shot gather for the Marmousi model computed by the staggered-grid method. The shot located at two different positions near the surface, i.e. (a) the left side of the model, x = 0; (b) the middle of the model, x=3km. Each shot has 200 receivers. The horizontal axis is the receiver points. The vertical axis is the time points.

Figure 4. The shot gather for the Marmousi model computed by the staggered-grid method. The shot located at two different positions near the surface, i.e. (a) the left side of the model, x = 0; (b) the middle of the model, x=3km. Each shot has 200 receivers. The horizontal axis is the receiver points. The vertical axis is the time points.

Figure 5. The Marmousi exact model. (a) velocity, (b) density.

Figure 5. The Marmousi exact model. (a) velocity, (b) density.

4.2. Inversion computations

We now consider the FWI for the Marmousi model. This model is a benchmark model which is usually applied to test the ability of an inversion method. The exact model of velocity and density for the Marmousi model is shown in Figure . The density shown in Figure (b) varies from 1.5g/cm3 to 5.5g/cm3. The density structure is similar with the velocity because high velocity corresponds to large density physically. The data acquisition system is shown in Figure . The number of sampling points in space is Nx=493 and Nz=249 with the step hx=hz=12m. The number of time points is Nt=3501 with the step Δt=0.001s. There are 80 shots and each shot 40 receivers totally. The space of receivers is 24m and the space of shots is 48m. The initial model for FWI is shown in Figure , which is built by a linear increasing function from the surface to the bottom. Figure (a) is the initial velocity model and Figure (b) is the initial density model. As we can see, the initial model is quite different from the exact model and we can not see the useful information of complex structures such as the faults in the exact model Figure . The frequency multiscale strategy is applied in FWI. Particularly, we implement FWI from low frequency to high frequency step by step. And the inversion result at current frequency band is served as the initial model for the next frequency band. In order to obtain the data in a certain frequency band, we apply the following Blackman-Harris window to filter the data: w(n)=c1+c2cos(2πnNL)+c3cos(4πnNL)+c4cos(6πnNL), where NL=500 is the length of the filter and c1=0.35875,c2=0.48829,c3=0.14128,c4=0.01168. In computations, we set four different frequency bands. Moreover, the data in the current frequency band is contained the data in the next frequency band so the FWI is more robust. Figure  is the inversion result of velocity and density with the data from frequency 0 to 5 Hz. Figure  is the inversion result with the data from frequency 0 to 15 Hz. Figure  is the inversion result with the 0–25 Hz data. The iteration number is fifty. From Figures , we can see the inversion accuracy is improved gradually. Figure  is the final inversion result with the whole frequency band data. Comparing Figure  with Figure , we can see most of the structures of the exact model are inverted accurately.

Figure 6. The initial model for FWI. (a) velocity, (b) density.

Figure 6. The initial model for FWI. (a) velocity, (b) density.

Figure 7. The inversion result with the 0–5 Hz data. (a) velocity, (b) density.

Figure 7. The inversion result with the 0–5 Hz data. (a) velocity, (b) density.

Figure 8. The inversion result with the 0–15 Hz data. (a) velocity, (b) density.

Figure 8. The inversion result with the 0–15 Hz data. (a) velocity, (b) density.

Figure 9. The inversion result with the 0–25 Hz data. (a) velocity, (b) density.

Figure 9. The inversion result with the 0–25 Hz data. (a) velocity, (b) density.

Figure 10. The inversion result with the whole frequency band data. (a) velocity, (b) density.

Figure 10. The inversion result with the whole frequency band data. (a) velocity, (b) density.

FWI is a typical large-scale computational problem. We implement the parallel computations based on the message passing interface (MPI). The physical domain is separated into different subdomains. And each subdomain is assigned to a different processer. The data exchanges only occur at the boundary of subdomains. In the L-BFGS algorithm, the computations for searching direction only involve vector inner product in a matrix-free fashion and the computations do not repeat in the overlapping area. The number of discretized parameters in inversion is 245,514. The CPU time for the whole FWI is about 14 h with 128 processes. The processor is the 3.6 GHz Intel. The stoping criteria for the inversion is when the F(m) is less than a small quantity while the iteration times are not beyond a fixed number.

We remark that the multi-parameter FWI including the density is harder than the single parameter FWI because of the coupling influence between the density and velocity. The single parameter inversion has better accuracy than the multi-parameter inversion. Figure  shows the results of the single parameter inversion for velocity only by the wavelet method with the data in four different frequency bands, i.e. 0–2.5 Hz, 0–5 Hz, 0–15 Hz and all frequencies. From Figure (a,d), we can clearly see that the inversion accuracy improves gradually. Comparing Figure (a) with Figure (a), we also see that the final single parameter inversion result is better than the multi-parameter inversion, which is as we expected. In the computations, the observed data has been added the 5% Gaussian noises.

Figure 11. The single parameter inversion for velocity with the data in four different frequency bands. (a) 0–2.5 Hz, (b) 0–5 Hz, (c) 0–15 Hz, (d) all frequencies.

Figure 11. The single parameter inversion for velocity with the data in four different frequency bands. (a) 0–2.5 Hz, (b) 0–5 Hz, (c) 0–15 Hz, (d) all frequencies.

5. Conclusions

The FWI is an attractive tool to obtain high resolution subsurface parameters in complex geological structures. We have investigated the wavelet-based FWI for determining the density and velocity coefficients in the acoustic wave equation. The numerical methods and schemes are established. The method solves the forward problem by applying Daubechies-4 wavelet to approximate the wavefield on staggered grids. The discrete schemes for forward modelling and the corresponding stability condition are derived in detail. The inverse problem is solved iteratively by minimizing the waveform misfit between the synthetic data and the observed wafefield. The discrete schemes for the gradient are derived based on the matrix technique. The frequency multiscale method implements FWI from low frequency to high frequency successively. Moreover, the inversion result of current frequency band is served as the initial guesses of the next frequency band, which improves robustness and accuracy of FWI. The multi-parameter FWI with density has lower inversion accuracy than the single parameter inversion. In FWI computations, the initial model is far from the exact model, which shows the method is less dependent on the initial model. Numerical computations for a benchmark model show the effectiveness and robustness of the method in this paper. The method can be extended to elastic model FWI.

Acknowledgements

I appreciate J. Jiang for his valuable helps in this research. Thanks also give to the reviewers and the editor for their helps.

Disclosure statement

No potential conflict of interest was reported by the author(s).

Additional information

Funding

This research is supported by the National Natural Science Foundation of China under the grant numbers 11471328 and 51739007.

References

  • Lailly P. The seismic inverse problem as a sequence of before stack migrations. Conference on Inverse Scattering, Theory and Applications. Philadelphia (PA): SIAM; 1983. p. 206–220.
  • Tarantola A. Inversion of seismic reflection data in the acoustic approximation. Geophysics. 1984;49(8):1259–1266.
  • Mora P. Nonlinear two-dimensional elastic inversion of multioffset seismic data. Geophysics. 1987;52(9):1211–1228.
  • Tarantola A. A strategy for nonlinear elastic inversion of seismic reflection data. Geophysics. 1986;51(10):1893–1903.
  • Pratt RG, Worthington MH. Inverse theory applied to multi-source cross-hole tomography, part 1: acoustic wave equation method. Geophys Prospect. 1990;38(3):287–310.
  • Pratt RG. Inverse theory applied to multi-source cross-hole tomography, part 2: elastic wave equation method. Geophys Prospect. 1990;38(3):311–329.
  • Virieux J, Operto S. An overview of full-waveform inversion in exploration geophysics. Geophysics. 2009;74(6):WCC1–WCC26.
  • Shin C, Cha YH. Waveform inversion in the Laplace-Fourier domain. Geophys J Int. 2009;177(3):1067–1079.
  • Shin C, Cha YH. Waveform inversion in the Laplace domain. Geophys J Int. 2008;173(3):922–931.
  • Yang P, Brossier R, Métivier L, et al. A time-domain preconditioned truncated Newton approach to viso-acoostic multiparameter full waveform inversion. SIAM J Sci Comput. 2018;40(4):B1101–B1130.
  • Aghamiry HS, Gholami A, Operto S. ADMM-based multi-parameter wavefield reconstruction inversion in VTI acoustic media with TV regularization. Geophys J Int. 2019;219(2):1316–1333.
  • Métivier L, Brossier R, Operto S, et al. Full waveform inversion and the truncated Newton method. SIAM Rev. 2017;59(1):153–195.
  • Plessix RE. A review of the adjoint-state method for computing the gradient of a functional with geophysical applications. Geophys J Int. 2006;167(2):495–503.
  • Pratt RG, Shin C, Hicks GJ. Gauss-Newton and full Newton methods in frequency-space seismic waveform inversion. Geophys J Internat. 1998;133(2):341–362.
  • Epanomeritakis I, Akelik V, Ghattas O, et al. A Newton-CG method for large-scale three-dimensional elastic full waveform seismic inversion. Inverse Problems. 2008;24(3):1–26.
  • Engl H, Hanke M, Neubauer A. Regularization of inverse problems. Dordrecht: Kluwer Academic Publishers Group; 1996.
  • Guitton A. Blocky regularization schemes for full-waveform inversion. Geophys Prospect. 2012;60(5):870–884.
  • Lin Y, Huang L. Acoustic- and elastic-waveform inversion using a modified total-variation regularization scheme. Geophys J Int. 2015;200(1):489–502.
  • Bunks C, Saleck F, Zaleski S, et al. Multiscale seismic waveform inversion. Geophysics. 1995;60(5):1457–1473.
  • Engquist E, Froese BD. Application of the Wasserstein metric to seismic signals. Commun Math Sci. 2014;12(5):979–988.
  • Métivier L, Brossier R, Mérigot Q, et al. Measuring the misfit between seismograms using an optimal transport distance: application to full waveform inversion. Geophys J Int. 2016;205(1):345–377.
  • Virieux J. P-SV wave propagation in heterogeneous media: velocity-stress finite-difference method. Geophysics. 1986;51(4):889–901.
  • Zhang W, Tong L, Chung ET. A new high accuracy locally one-dimensional scheme for the wave equation. J Comput Appl Math. 2011;236(6):1343–1353.
  • Fornberg B. A practical guide to pseudospectral methods. Cambridge: Cambridge University Press; 1996.
  • Zhang W. Stability conditions for wave simulation in 3-D anisotropic media with the pseudospectral method. Commun Comput Phys. 2012;12(3):703–720.
  • Zhang W, Zhuang Y, Zhang L. A new high-order finite volume method for 3D elastic wave simulation on unstructured meshes. J Comput Phys. 2017;340:534–555.
  • Cohen G. Higher-order numerical methods for transient wave equations. Berlin: Springer-Verlag; 2002.
  • Zhang W, Chung ET, Wang C. Stability for imposing absorbing boundary conditions in the finite element simulation of acoustic wave propagation. J Comput Math. 2014;32(1):1–20.
  • Zhang W. Elastic full waveform inversion on unstructured meshes by the finite element method. Phys Scr. 2019;94: 115002.
  • Beylkin G, Keiser JM. On the adaptive numerical solution of nonlinear partial differential equations in wavelet bases. J Comput Phys. 1997;132(2):233–259.
  • Dahmen W. Wavelet and multiscale methods for operator equations. Acta Numer. 1997;6:55–228.
  • Fröhlich J, Schneider K. An adaptive wavelet-vaguelette algorithm for the solution of PDEs. J Comput Phys. 1997;130(2):174–190.
  • Hong TK, Kennett BLN. On a wavelet-based method for the numerical simulation of wave propagation. J Comput Phys. 2002;183(2):577–622.
  • Qian S, Weiss J. Wavelets and the numerical solution of partial differential equations. J Comput Phys. 1993;106(1):155–175.
  • Lions LJ, Magenes E. Non-homogeneous boundary value problems and application. Vol. 1. New York (NY): Springer-Verlag; 1972.
  • Chui C. Wavelets: a tutorial in theory and applications. San Diego (CA): Academic Press; 1992.
  • Daubechies I. Orthonormal bases of compactly supported wavelets. Commun Pure Appl Math. 1988;41:901–906.
  • Daubechies I. Ten lectures on wavelet. Philadelphia (PA): Society for Industrial and Applied Mathematics; 1992.
  • Mallat S. Multiresolution approximations and wavelet orthogonal bases of L2(R). Trans Amer Math Soc. 1989;315:69–88.
  • Clayton R, Engquist B. Absorbing boundary conditions for acoustic and elastic wave equations. Bull Seismol Soc Am. 1977;67(6):1529–1540.
  • Grote MJ, Keller JB. Exact nonreflecting boundary condition for elastic waves. SIAM J Appl Math. 2000;60(3):803–819.
  • Zhang W, Tong L, Chung ET. Exact nonreflecting boundary conditions for three dimensional poroelastic wave equations. Commun Math Sci. 2014;12(1):61–98.
  • Berenger JP. A perfectly matched layer for the absorption of electromagnetic waves. J Comput Phys. 1994;114(2):185–200.
  • Thomas JW. Numerical partial differential equations: finite difference methods. New York (NY): Springer Science Business Media; 1995.
  • Nocedal J, Wright ST. Numerical optimization. New York (NY): Springer Science Business Media; 1990.
  • Dembo RS, Steihaug T. Truncated Newton algorithms for large-scale unconstrained optimization. Math Program. 1983;26(2):190–212.
  • Klibanov MV. Global convexity in a three-dimensional inverse acoustic problem. SIAM J Math Anal. 1997;28(6):1371–1388.
  • Khoa VA, Klibanov MV, Nguyen LH. Convexification for a three-dimensional inverse scattering problem with the moving point source. SIAM J Imaging Sci. 2020;13(2):871–904.
  • Klibanov MV, Kolesov AE, Nguyen LH. Convexification method for an inverse scattering problem and its performance for experimental backscatter data fir buried targets. SIAM J Imaging Sci. 2019;12(1):576–603.
  • Martin GS, Wiley R, Marfurt KJ. Marmousi2: an elastic upgrade for Marmousi. Leading Edge. 2006;25:156–166.
  • Beylkin G. On the representation of operators in bases of compactly supported wavelet. SIAM J Numer Anal. 1992;29(6):1716–1740.

Appendices

Appendix 1. The computations for coefficients rl+12,i in (40).

By the definition of (Equation26), we know (A1) rl+12,i1=+ϕ(xi)ϕ(xl12)xdx.(A1) For brevity, we set r^il12:=rl+12,i1. Then we can rewrite (EquationA1) as (A2) r^il12=+ϕ(xi+l+12)ϕ(x)xdx,(A2) and by (Equation11) we have (A3) r^il12=4k=0L1m=0L1hkhm+ϕ(2x2i+2l+1k)ϕ(2xm)dx=2k=0L1m=0L1hkhmr^2i+k2l1m.(A3) Substituting m = kn, we rewrite (EquationA3) as (A4) r^il12=2k=0L1n=kkL+1hkhknr^2i+n2l1=2{n=1L1k=0L1+n+n=0L1k=nL1}hkhknr^2i+n2l1=2n=1L1k=0L1nhkhk+nr^2in2l1+2n=0L1k=0L1nhkhk+nr^2i+n2l1=2n=1L1k=0L1nhkhk+n(r^2in2l1+r^2i+n2l1)+2k=0L1hk2r^2i2l1.(A4) Using the fact k=0L1hk2=1, we obtain (A5) r^il12=2r^2i2l1+n=1L1an(r^2in2l1+r^2i+n2l1),(A5) where an are the autocorrelation coefficients of hk (k=0,,L1): (A6) an=2k=0L1nhkhk+n,n=1,,L1.(A6) In fact, for Daubechies' wavelets with M vanishing moments, an can be expressed as [Citation51] a2m1=(1)m1CM(Mm)!(M+m1)!(2m1),m=1,,M, where CM=[(2M1)!(M1)!4M1]2. Note that coefficients an with even indices are zero. We remark r^i on integer grids iZ can be computed by solving a linear system. For example, for the Daubechies wavelet with M = 4, we have r^1=7.9300952E01,r^2=1.9199897E01,r^3=3.3580207E02,r^4=2.2240497E03,r^5=1.7220619E04,r^6=8.4085053E07. So by (EquationA5) and setting i=l+1,,l+7 we can obtain the results on staggered grids in (Equation40).

Appendix 2. The elements of matrix Mvi,j in (67) and the elements of matrix Mρi,j in (70).

The elements of matrix Mvi,j are Avi,j. By the expression of A in (Equation59), we have (A7) Avi,j=1Δt2(0000000002ρvi,j3000000000).(A7) Note that Kvi,j=0.

The elements of matrix Mρi,j in (Equation70) are Aρi,j and Kρi,j. By the expression of A in (Equation59), we have (A8) Aρi,j=1Δt2(0000000001(ρvi,j)2000000000).(A8) And by the expression of K in (Equation60), we have (A9) Kρi,j=(K0,0ρi,jK1,0ρi,j00K0,1ρi,jK1,1ρi,jK2,1ρi,j0000KNx2,Nx1ρi,jKNx1,Nx1ρi,jKNx,Nx1ρi,j00KNx1,Nxρi,jKNx,Nxρi,j),(A9) where Ki+1,iρi,j=Ki,i1ρi,j=Ki,i+1ρi,j=Ki1,iρi,j=(00000000012ρi,j21hx2000000000),Ks+1,sρi,j=0,Ks,s+1ρi,j=0,si1,i,Ki,iρi,j=(000000000000012ρi,j21hz212ρi,j21hz200012ρi,j21hz21ρi,j2(1hz2+1hx2)12ρi,j21hz200012ρi,j21hz212ρi,j21hz20000000000000),Ki±1,i±1ρi,j=(00000000012ρi,j21hx2000000000),Ks,sρi,j=0,si,i±1.

Reprints and Corporate Permissions

Please note: Selecting permissions does not provide access to the full text of the article, please see our help page How do I view content?

To request a reprint or corporate permissions for this article, please click on the relevant link below:

Academic Permissions

Please note: Selecting permissions does not provide access to the full text of the article, please see our help page How do I view content?

Obtain permissions instantly via Rightslink by clicking on the button below:

If you are unable to obtain permissions via Rightslink, please complete and submit this Permissions form. For more information, please visit our Permissions help page.