Released to public domain under Creative Commons license type BY.
Copyright (c) 2015 SLIM group @ The University of British Columbia."
This note provides an overview on strategies for modeling and inversion with the anisotropic wave equation. Since linear and non-linear inversion methods like least squares RTM and Full Waveform Inversion depend on matching observed field data with synthetically modeled data, accounting for anisotropy effects is necessary in order to accurately match waveforms at long offsets and propagation times. In this note, the two main strategies for anisotropic modeling by solving either a pseudo-acoustic wave equation or a pure quasi-P-wave equation are discussed and an inversion workflow using the pure quasi-P-wave equation is provided. In particular, we derive the exact adjoint of the anisotropic forward modeling and Jacobian operator and give a detailed description of their implementation. The anisotropic FWI workflow is tested on a synthetic data example.
Seismic imaging and inversion of large scale data sets require an accurate and efficient modeling kernel for numerically solving the wave equation. Especially for seismic field data with large offsets, the acoustic approximation of wave propagation is no longer appropriate to accurately match the waveforms of the observed data, since travel times and amplitudes are influenced by anisotropy effects. In exploration seismology, these effects are mostly related to the fact that a wave that travels through several layers of (isotropic) rocks, at which the layer thickness is much smaller than the dominant wavelength, behaves like a wave propagating through a homogeneous but anisotropic medium. For this reason, anisotropy in sedimentary settings is primarily observed in the vertical direction and can be approximated by vertical transverse isotropic (VTI) or tilted transverse isotropic (TTI) models. Because the effects of anisotropy in sedimentary layers are usually also small (no more than 10-20 percent), a weak anisotropy approximation has been derived at which the effects of anisotropy are described by the Thomsen parameters ϵ and δ (Thomsen, 1986)
Derived from the dispersion relation in terms of the Thomsen parameters, Alkhalifah (2000) introduced a pseudo-acoustic wave equation to describe wave propagation in transverse isotropic media such as VTI and TTI with forth order partial derivatives in space and time. Based on this equation, mainly two different approaches for modeling VTI and TTI wave equations have evolved. The first equation that is commonly used in the literature for seismic imaging (RTM) is a pseudo-acoustic wave equation, expressed as a coupled 2 by 2 system of equations with a pseudo-pressure field P and an auxiliary field Q. This approach is followed for example by Zhang et al. from CGG (2011). The alternative approach is a purely quasi-P wave equation that completely decouples the pressure wavefield from the full elastic wavefield. Modeling and imaging workflows based on this equation have been developed by Chu et al. from Conoco Philips (2011), Xu and Zhou from Statoil (2014), Zhan et al. (2013) and Zhang et al. (2005). The main advantage of the pure P-wave equation is that is is completely free of S-wave artifacts and is computationally less expansive and more memory efficient, since the pseudo-acoustic wave equation requires the computation and (possibly) the storage of two wavefields. Also, the pure P-wave equation is numerically more stable for strongly varying angles in TTI media (Zhan et al., 2013), since the presence of S-wave artifacts decreases the stability of the pseudo-acoustic wave equation. On the other hand, the pseudo-acoustic equation can be solved with both finite difference (FD) as well as pseudo spectral (PS) methods, whereas the pure P-wave equation requires the high accuracy of PS operators, making this approach computationally expensive, as each time step involves a large number of forward and inverse FFTs.
For incorporating anisotropy in the time-domain modeling kernel of the SLIM inversion workflow, we use the pure quasi-P-wave equation in the time-spacenumber domain as derived by Zhang et al. (2005) or Chu et al. (2011). Their discretized TTI wave equation is second order in time and uses the PS method for the Laplacian operator. The main advantage of this formulation is that the anisotropy parameters only appear in the expression for the Laplacian, which allows us to use our functions for forward modeling and back propagation, as well as the application of forward and adjoint Jacobians from our existing workflow by simply replacing the Laplacian operator.
Since the anisotropic modeling and inversion workflow is completely based on our isotropic implementation, we first outline the discretization for the isotropic acoustic wave equation and then derive the anisotropic Laplacian operator based on the TTI equation of Zhang et al (2005). Our existing workflow is then easily extended to anisotropy by swapping out the Laplacian operator.
The isotropic acoustic wave equation in continuous form is given by
m∂2u∂t2−∇2u=q
For calculating an RTM image or gradient updates of the FWI objective function, we furthermore require the action of the (adjoint) Jacobian of the forward modeling operator. Writing Equation 5 as one large system of equations, denoting the modeling matrix as a nonlinear operator A(m) and taking the partial derivative with respect to the model parameter yields
∂∂m(A(m)u=q)⟺∂A(m)∂mu+A(m)∂u∂m=0
For the incorporation of anisotropy we start from the two-dimensional pure P-wave-equation for TTI media with weak anisotropy by Zhan et al. (2005):
m∂2U(kx,kz,t)∂t2=[k2x+k2z+(2δsin2θcos2θ+2ϵcos4θ)k4xk2x+k2z+(2δsin2θcos2θ+2ϵsin4θ)k4zk2x+k2z+(−δsin22θ+3ϵsin22θ+2δcos22θ)k2xk2zk2x+k2z+(δsin4θ−4ϵsin2θcos2θ)k3xkzk2x+k2z+(−δsin4θ−4ϵsin2θsin2θ)kxk3zk2x+k2z]U(kx,kz,t)
We test the anisotropic FWI workflow by inverting the two-dimensional BG velocity model. We generate observed data with anisotropy effects using an epsilon and a delta model, as well as a tilt angle that is derived from the velocity model (Figure 2). We then perform two FWI runs of 30 iterations each, both starting from the same initial model. In the first run, the (anisotropic) data is inverted with the isotropic engine, i.e. the Thomsen parameters are set to zero, whereas in the second run, we invert with the true model for the Thomsen parameters.
The main problems in our current implementation are numerical stability and computational efficiency. Experiments with the modeling kernel show that sharp and large contrasts within the models of the anisotropy parameters cause artifacts in wavefields. More importantly, using pseudo-spectral methods for the spatial derivative requires a forward and inverse Fourier transform of the entire wavefield at each time step, which becomes especially problematic in 3D FWI. For these reasons, we are investigating in alternatives for the derivative matrices, as the Eigen-decomposition Pseudo-Spectral (EPS) method (K. Sandberg and Wojciechowski, 2011) which is based on integral operators with a kernel function K(x,y)
Lf(x)=∫baK(x,y)f(y)dy
Extension of the described method to 3D is straight forward. The isotropic modeling and inversion workflow itself is already implemented for 3D, therefore only the 3D anisotropic Laplacian needs to be added. The operator is constructed in the same manner as before, only that F now is the 3D discrete Fourier transform and the central term diag(kani) is constructed from the 3D pure P-wave equation, which is given in Chu et al. (2011).
The following algorithm shows construction of the anisotropic Laplacian operator (Equation 15). We use the SPOT toolbox (http://www.cs.ubc.ca/labs/scl/spot/) which allows us to represent the Fourier transform as matrix free operators. This means the 2D Fourier operator F is never explicitly formed, but can be used like a matrix, i.e. it can be transposed or applied to a vector. Furthermore, SPOT operators can be combined to perform multiple operations consecutively. This is used for the Laplacian operator, whose application on a vector consists of a forward Fourier transform, multiplication with the diagonal matrix containing the anisotropy parameters (kani) and the inverse Fourier transform. The (matrix-free) operator L can be transposed as well in order to calculate the adjoint wavefields (Equation 8).
% 1D wavenumbers (row vectors)
kz=2πbz−az∗[0:(nz2−1),0,(−nz2+1):−1]
kx=2πbx−ax∗[0:(nx2−1),0,(−nx2+1):−1]
% Construct 2D wavenumber field from 1D vectors
Kz=enx⊗kTz % e denotes an all ones row vector of length nx
Kx=eTnz⊗kx
% Mixed wavenumber fields by entrywise products (⊙), division ( ./ ) and exponantiation
K1=K4x ./ (K2x+K2z)
K2=K4z ./ (K2x+K2z)
K3=K2x⊙K2z ./ (K2x+K2z)
K4=K3x⊙Kz ./ (K2x+K2z)
K5=Kx⊙K3z ./ (K2x+K2z)
% 2D gridded Thomsen parameters in tilted medium
T1=2δ⊙sin2θ⊙cos4θ+2ϵ⊙cos4θ
T2=T1
T3=−δ⊙sin22θ+3ϵ⊙sin22θ+2δ⊙cos22θ
T4=δ⊙sin4θ−4ϵ⊙sin2θ⊙cos2θ
T5=−δ⊙sin4θ−4ϵ⊙sin2θ⊙sin2θ
% Combine all terms and vectorize
kani=vec(−K2x−K2z+T1⊙K1+T2⊙K2+T3⊙K3+T4⊙K4+T5⊙K5)
% 2D Fourier transform
F=(Inx⊗Fz)⋅(Fx⊗Inz) % where Ix is the Identity matrix and Fx is the 1D Fourier matrix of the respective dimension.
% Laplacian operator
L=real(F∗diag(kani)F) % where ∗ is the conjugate transpose
This work was in part financially supported by the Natural Sciences and Engineering Research Council of Canada Discovery Grant (22R81254) and the Collaborative Research and Development Grant DNOISE II (375142-08). This research was carried out as part of the SINBAD II project with support from the following organizations: BG Group, BGP, CGG, Chevron, ConocoPhillips, Petrobras, PGS, WesternGeco, and Woodside.
Alkhalifah, T., 2000, An acoustic wave equation for anisotropic media: Geophysics, 65, 1239–1250.
Beylkin, G., and Sandberg, K., 2005, Wave propagation using bases for band limited functions: Wave Motion, 41, 263–291.
Chu, M., Chunlei, 2011, Approximation of pure acoustic seismic wave propagation in TTI media: Geophysics, 76, WB97–WB107.
Sandberg, K., and Wojciechowski, K. J., 2011, The EPS method: A new method for constructing pseudospectral derivative operators: Journal of Computational Physics, 230, 5836–5863. doi:10.1016/j.jcp.2011.03.058
Thomsen, L., 1986, Weak elastic anisotropy: Geophysics, 51, 1964–1966.
Xu, S., and Zhou, H., 2014, Accurate simulations of pure quasi-P-waves in complex anisotropic media: Geophysics, 79, 341–348.
Zhan, G., Pestana, R. C., and Stoffa, P. L., 2013, An efficient hybrid pdeudospectral/finite-difference scheme for solving the TTI pure P-wave equation: Journal of Geophyics and Engineering, 10.
Zhang, L., Rector III, J. W., and Micheal, H. G., 2005, Finite-difference modelling of wave propagation in acoustic tilted TI media: Geophysical Prospecting, 53, 843–852.
Zhang, Y., Zhang, H., and Zhang, G., 2011, A stable TTI reverse time migration and its implementation: Geophysics, 76, WA3–WA11.