Journal of Applied Mathematics and Physics
Vol.07 No.08(2019), Article ID:94418,20 pages
10.4236/jamp.2019.78120

Stability of High-Order Staggered-Grid Schemes for 3D Elastic Wave Equation in Heterogeneous Media

Atish Kumar Joardar1,2,3, Wensheng Zhang1,2*

1Academy of Mathematics and Systems Science, Chinese Academy of Sciences, Beijing, China

2School of Mathematical Sciences, University of Chinese Academy of Sciences, Chinese Academy of Sciences, Beijing, China

3Department of Mathematics, Islamic University, Kushtia, Bangladesh

Copyright © 2019 by author(s) and Scientific Research Publishing Inc.

This work is licensed under the Creative Commons Attribution International License (CC BY 4.0).

http://creativecommons.org/licenses/by/4.0/

Received: July 4, 2019; Accepted: August 16, 2019; Published: August 19, 2019

ABSTRACT

In this paper, we firstly derive the stability conditions of high-order staggered-grid schemes for the three-dimensional (3D) elastic wave equation in heterogeneous media based on the energy method. Moreover, the plane wave analysis yields a sufficient and necessary stability condition by the von Neumann criterion in homogeneous case. Numerical computations for 3D wave simulation with point source excitation are given.

Keywords:

3D, Elastic Wave, Inhomogeneous Media, Staggered-Grid Scheme, High-Order, Stability, Energy Estimate

1. Introduction

Numerical simulation of wave propagation has important applications in many scientific fields such as geophysics and seismic inversion. There are several types of numerical methods to solve the wave equations, for example, the finite difference method, the finite element method [1] [2] [3] [4] , the spectral element method [5] , the discontinuous Galerkin method [6] [7] and the finite volume method [8] [9] . Each of the above numerical methods has its own advantages and disadvantages. In this paper, we consider the finite difference method.

The finite difference method is a very popular method because of high computational efficiency. In fact, it has been applied to wave simulation for several decades [10] [11] [12] [13] . Since perfect numerical simulation depends on both stability and the order of accuracy, the high-order schemes and the corresponding stability are an important research topic of this field. In particularly, we may list a few here. In [14] , Cohen and Joly construct and analyses a family of fourth-order schemes for the acoustic wave equation in nonhomogeneous media. In [15] , Sei analysis the stability of high-order difference schemes for the 2D elastic wave equation in heterogeneous media. The stable difference approximation for the 3D elastic wave equation in the second-order formulation in heterogeneous media has been investigated in [16] . In [17] , a new family of locally one-dimensional schemes with fourth-order accuracy both in space and time for the 3D elastic wave equation is constructed and the stability is derived. The constructed new schemes in [17] only involve a three-point stencil in each spatial direction to achieve fourth-order accuracy. In this paper, based on the energy method, we study the stability analysis for the high-order staggered-grid schemes of the 3D elastic wave equation in heterogeneous media. To our knowledge, there is no work in this respect and our result is new.

The reminder of the paper is organized as follows. In Section 2, we present the governing equation and the high-order difference schemes in heterogeneous on staggered-grid grids. In Section 3, the stability analysis for the high-order difference schemes in heterogeneous is presented. In Section 4, the plane wave analysis in homogeneous case is investigated. In Section 5, we present numerical comparisons for 3D elastic wave simulation. Finally the conclusion and discussions are given in Section 6.

2. High-Order Spatial Discretization

We consider the following three-dimensional (3D) elastic wave equations in isotropic heterogeneous media

{ ρ 2 u t 2 x ( ( λ + 2 μ ) u x + λ v y + λ w z ) y ( μ v x + μ u y ) z ( μ u z + μ w x ) = f 1 , ρ 2 v t 2 x ( μ v x + μ u y ) y ( ( λ + 2 μ ) v y + λ u x + λ w z ) z ( μ v z + μ w y ) = f 2 , ρ 2 w t 2 x ( μ u z + μ w x ) y ( μ v z + μ w y ) z ( ( λ + 2 μ ) w z + λ u x + λ v y ) = f 3 , (1)

where ( u , v , w ) ( x , t ) are the displacement vector at location x = ( x , y , z ) and time t, ρ ( x ) is the density, λ ( x ) > 0 and μ ( x ) 0 are the Lamé parameters, f = ( f 1 , f 2 , f 3 ) is the external force.

Using the stress tensor, we can formulate the above system (1) as a first order in the following ways

{ ρ 2 u t 2 ( τ x x x + τ x y y + τ x z z ) = 0 , ρ 2 v t 2 ( τ x y x + τ y y y + τ y z z ) = 0 , ρ 2 w t 2 ( τ x z x + τ y z y + τ z z z ) = 0 , (2)

where

{ τ x x = ( λ + 2 μ ) u x + λ v y + λ w z , τ y y = ( λ + 2 μ ) v y + λ u x + λ w z , τ z z = ( λ + 2 μ ) w z + λ u x + λ v y , τ x y = μ v x + μ u y , τ x z = μ u z + μ w x , τ y z = μ v z + μ w y . (3)

Let Δ x , Δ y and Δ z be the spatial steps of x , y , z directions respectively. Now discretization of (2) with the second-order accuracy in space gives

ρ 2 u t 2 ( i,j,k ) τ i+ 1 2 ,j,k xx τ i 1 2 ,j,k xx Δx τ i,j+ 1 2 ,k xy τ i,j 1 2 ,k xy Δy τ i,j,k+ 1 2 xz τ i,j,k 1 2 xz Δz =0, (4)

ρ 2 v t 2 ( i,j,k ) τ i+ 1 2 ,j,k xy τ i 1 2 ,j,k xy Δx τ i,j+ 1 2 ,k yy τ i,j 1 2 ,k yy Δy τ i,j,k+ 1 2 yz τ i,j,k 1 2 yz Δz =0, (5)

ρ 2 w t 2 ( i,j,k ) τ i+ 1 2 ,j,k xz τ i 1 2 ,j,k xz Δx τ i,j+ 1 2 ,k yz τ i,j 1 2 ,k yz Δy τ i,j,k+ 1 2 zz τ i,j,k 1 2 zz Δz =0. (6)

For computing this, we need the values of u, v, and w at the grid ( i + 1 2 , j + 1 2 , k + 1 2 ) . One convenient way is to choose averaging the corresponding vales. For example,

u i + 1 2 , j + 1 2 , k + 1 2 = 1 3 ( u i + 1 , j , k + u i , j , k 2 + u i , j + 1 , k + u i , j , k 2 + u i , j , k + 1 + u i , j , k 2 ) .

However, such choices have no physical meaning. Another way is to compute u , v , w directly on staggered grids. In particular, we replace Equations (4)-(6) with Equations (7)-(9):

ρ 2 u t 2 ( i,j,k ) τ i+ 1 2 ,j,k xx τ i 1 2 ,j,k xx Δx τ i,j+ 1 2 ,k xy τ i,j 1 2 ,k xy Δy τ i,j,k+ 1 2 xz τ i,j,k 1 2 xz Δz =0, (7)

ρ 2 v t 2 ( i + 1 2 , j + 1 2 , k ) τ i + 1 , j + 1 2 , k x y τ i , j + 1 2 , k x y Δ x τ i + 1 2 , j + 1 , k y y τ i + 1 2 , j , k y y Δ y τ i + 1 2 , j + 1 2 , k + 1 2 y z τ i + 1 2 , j + 1 2 , k 1 2 y z Δ z = 0 , (8)

ρ 2 w t 2 ( i + 1 2 , j , k + 1 2 ) τ i + 1 , j , k + 1 2 x z τ i , j , k + 1 2 x z Δ x τ i + 1 2 , j + 1 2 , k + 1 2 y z τ i + 1 2 , j 1 2 , k + 1 2 y z Δ y τ i + 1 2 , j , k + 1 z z τ i + 1 2 , j , k z z Δ z = 0. (9)

Obviously, the schemes (7)-(9) are the second-order accuracy in space. In order to construct high-order accuracy scheme in space, we first define the following functional spaces. Now we introduce the differentiation operator D x on half integer grids with O ( Δ x 2 L ) order as follows:

( u x ) i , j , k D x u i , j , k = l = 1 L β l Δ x [ u i + l 1 2 , j , k u i l + 1 2 , j , k ] , (10)

or

( u x ) i + 1 2 , j , k D x u i + 1 2 , j , k = l = 1 L β l Δ x [ u i + l , j , k u i l + 1 , j , k ] , (11)

where β l is difference coefficients on the staggered grids, which can be calculated by a fast algorithm [18] [19] [20] by Matlab tool. Obviously, the approximation (10) or (11) has O ( Δ x 2 L ) order accuracy. For example, when β 1 = 1 for L = 1 it has the second-order accuracy O ( Δ x 2 ) . And when β 1 = 9 8 and β 2 = 1 24 for L = 2 it has the fourth-order accuracy O ( Δ x 4 ) . The general analytical expression of β l is given in Appendix. Similarly, we can define the operators D y and D z . Here, the subscript of the operator refers to the direction of differentiation.

Now, we can construct the semi-discrete schemes of system (1)

( ρ 2 u t 2 + D x ( ( λ + 2 μ ) D x u + λ D y v + λ D z w ) + D y ( μ D x v + μ D y u ) + D z ( μ D z u + μ D x w ) ) ( i , j , k ) = 0 , (12)

( ρ 2 v t 2 + D x ( μ D x v + μ D y u ) + D y ( ( λ + 2 μ ) D y v + λ D x u + λ D z w ) + D z ( μ D z v + μ D y w ) ) ( i + 1 2 , j + 1 2 , k ) = 0 , (13)

( ρ 2 w t 2 + D x ( μ D z u + μ D x w ) + D y ( μ D z v + μ D y w ) + D z ( ( λ + 2 μ ) D z w + λ D x u + λ D y v ) ) ( i + 1 2 , j , k + 1 2 ) = 0. (14)

Applying the central difference approximation for time with the second-order accuracy, we obtain the full-discrete schemes of system (1), we obtain

ρ i , j , k ( u n + 1 2 u n + u n 1 ) i , j , k + Δ t 2 { D x ( ( λ + 2 μ ) D x u + λ D y v + λ D z w ) + D y ( μ D x v + μ D y u ) + D z ( μ D z u + μ D x w ) ) } i , j , k n = 0, (15)

l ρ i+ 1 2 ,j+ 1 2 ,k ( v n+1 2 v n + v n1 ) i+ 1 2 ,j+ 1 2 ,k +Δ t 2 { D x ( μ D x v+μ D y 0 u ) + D y ( ( λ+2μ ) D y v+λ D x u+λ D z w )+ D z ( μ D z v+μ D y w ) } i+ 1 2 ,j+ 1 2 ,k n =0, (16)

ρ i+ 1 2 ,j,k+ 1 2 ( w n+1 2 w n + w n1 ) i+ 1 2 ,j,k+ 1 2 +Δ t 2 { D x ( μ D z u+μ D x w ) + D y ( μ D z v+μ D y w )+ D z ( ( λ+2μ ) D z w+λ D x u+λ D y v ) } i+ 1 2 ,j,k+ 1 2 n =0, (17)

where n denotes the time index and Δ t the time step.

3. Stability Analysis

We now turn to the study of the numerical stability of the schemes (15)-(17). We are going to proceed by the energy method in analogy with continuous energy given by:

E = E c + E p , (18)

with

E c = 1 2 R 3 ρ [ ( u t ) 2 + ( v t ) 2 + ( w t ) 2 ] d x d y d z ,

E p = 1 2 R 3 λ ( u x + u y + u z ) 2 + 2 μ [ ( u x ) 2 + ( v y ) 2 + ( w z ) 2 ] + μ [ ( u y + v x ) 2 + ( u z + w x ) 2 + ( v z + w y ) 2 ] d x d y d z .

In a source-free infinite medium, the energy is conservative, i.e., d E d t = 0 . The discrete energy at time ( n + 1 2 ) Δ t is E n + 1 2 = E c n + 1 2 + E p n + 1 2 . In order to compute E c n + 1 2 and E p n + 1 2 and analyze the stability, we define the following functional spaces

L 000 3 = { φ L 3 ( R 3 ) | φ = i , j , k = φ i , j , k × I [ ( i 1 2 ) Δ x , ( i + 1 2 ) Δ x ] × [ ( j 1 2 ) Δ y , ( j + 1 2 ) Δ y ] × [ ( k 1 2 ) Δ z , ( k + 1 2 ) Δ z ] ( x , y , z ) } ,

L 3 = { φ L 3 ( R 3 ) | φ = i , j , k = φ i + 1 2 , j + 1 2 , k + 1 2 × I [ i Δ x , ( i + 1 ) Δ x ] × [ j Δ y , ( j + 1 ) Δ y ] × [ k Δ z , ( k + 1 ) Δ z ] ( x , y , z ) } ,

L 0 3 = { φ L 3 ( R 3 ) | φ = i , j , k = φ i , j + 1 2 , k + 1 2 × I [ ( i 1 2 ) Δ x , ( i + 1 2 ) Δ x ] × [ j Δ y , ( j + 1 ) Δ y ] × [ k Δ z , ( k + 1 ) Δ z ] ( x , y , z ) } ,

where

I [ a , b ] × [ c , d ] × [ e , f ] ( x , y , z ) = ( 1 , ( x , y , z ) [ a , b ] × [ c , d ] × [ e , f ] , 0 , ( x , y , z ) [ a , b ] × [ c , d ] × [ e , f ] ,

where 0 represents the integer grid ( i , j , k ) and the half integer grid i + 1 2 or j + 1 2 or k + 1 2 . The other functional spaces L 00 3 , L 0 3 , L 00 3 L *00 3 , L 0 3 , L 0 3 can be defined similarly. For saving space, we omit their definitions. Let the scalar inner product be defined in L 000 3 by

( f , g , h ) 000 = i , j , k = f i , j , k g i , j , k h i , j , k Δ x Δ y Δ z .

Other inner products such as ( f , g , h ) , ( f , g , h ) 0 and so on have similar meaning. In the following, we compute E c n + 1 2 and E p n + 1 2 respectively.

E c n + 1 2 = 1 2 { ( ρ u n + 1 u n Δ t , u n + 1 u n Δ t ) 000 + ( ρ v n + 1 v n Δ t , v n + 1 v n Δ t ) 0 + ( ρ w n + 1 w n Δ t , w n + 1 w n Δ t ) 0 0 Δ t 2 4 [ ( λ D x u n + 1 u n Δ t + λ D y v n + 1 v n Δ t + λ D z w n + 1 w n Δ t , D x u n + 1 u n Δ t + D y v n + 1 v n Δ t + D z w n + 1 w n Δ t ) 00 + ( μ D x v n + 1 v n Δ t + μ D y u n + 1 u n Δ t , D x v n + 1 v n Δ t + D y u n + 1 u n Δ t ) 0 0 + ( μ D z u n + 1 u n Δ t

+ μ D x w n + 1 w n Δ t , D z u n + 1 u n Δ t + D x w n + 1 w n Δ t ) 00 + ( μ D y w n + 1 w n Δ t + μ D z v n + 1 v n Δ t , μ D y w n + 1 w n Δ t + μ D z v n + 1 v n Δ t ) + ( 2 μ D x u n + 1 u n Δ t , D x u n + 1 u n Δ t ) 00 + ( 2 μ D y v n + 1 v n Δ t , D y v n + 1 v n Δ t ) 00 + ( 2 μ D z w n + 1 w n Δ t , D z w n + 1 w n Δ t ) 00 ] } ,

E p n + 1 2 = 1 2 { ( λ D x u n + 1 + u n 2 + λ D y v n + 1 + v n 2 + λ D z w n + 1 + w n 2 , D x u n + 1 + u n 2 + D y v n + 1 + v n 2 + D z w n + 1 + w n 2 ) 00

+ ( 2 μ D x u n + 1 + u n 2 , D x u n + 1 + u n 2 ) 00 + ( 2 μ D y v n + 1 + v n 2 , D y v n + 1 + v n 2 ) 0 * 0 + ( 2 μ D z w n + 1 + w n 2 , D z w n + 1 + w n 2 ) 00

+ ( μ D y u n + 1 + u n 2 + μ D x v n + 1 + v n 2 , D y u n + 1 + u n 2 + D x v n + 1 + v n 2 ) 0 0 + ( μ D z u n + 1 + u n 2 + μ D x w n + 1 + w n 2 , D z u n + 1 + u n 2 + D x w n + 1 + w n 2 ) 00 + ( μ D z v n + 1 + v n 2 + μ D y w n + 1 + w n 2 , D z v n + 1 + v n 2 + D y w n + 1 + w n 2 ) } .

We have conservation of the discrete energy, that is: E n + 1 2 E n 1 2 Δ t = 0 . The stability of the scheme will be proven if the potential energy E p n + 1 2 and the kinetic energy E c n + 1 2 are positive. Since E p n + 1 2 is obviously positive, we need to find out under what conditions E c n + 1 2 is positive.

The problem can be reformulated as: u L 000 3 , v L 0 3 and w L 0 3 with

I = ( λ D x u + λ D y v + λ D z w , D x u + D y v + D z w ) 00 + ( μ D x v + μ D y u , D x v + D y u ) 0 0 + ( μ D z u + μ D x w , D z u + D x w ) 00 + ( μ D y w + μ D z v , D y w + D z v ) + ( 2 μ D x u , D x u ) 00 + ( 2 μ D y v , D y v ) 00 + ( 2 μ D z w , D z w ) 00

we look for the corresponding conditions. Since

Δ t 2 4 I ( ρ u , u ) 000 + ( ρ v , v ) 0 + ( ρ w , w ) 0 , (19)

we can bound I as follows:

I 2 [ ( λ D x u , D x u ) 00 + ( λ D y v , D y v ) 00 + ( λ D z w , D z w ) 00 + ( μ D x v , D x v ) 0 0 + ( μ D y u , D y u ) 0 0 + ( μ D x w , D x w ) 00 + ( μ D z u , D z 0 u ) 00 + ( μ D z v , D z v ) + ( μ D y w , D y w ) + ( μ D x u , D x u ) 00 + ( μ D y v , D y * v ) 00 + ( μ D z w , D z w ) 00 ] ,

or

I 2 [ ( ( λ + μ ) D x u , D x u ) 00 + ( μ D y u , D y u ) 0 0 + ( μ D z u , D z u ) 00 I 1 + ( ( λ + μ ) D y v , D y v ) 00 + ( μ D x v , D x v ) 0 0 + ( μ D z v , D z v ) I 2

+ ( ( λ + μ ) D z w , D z w ) 00 + ( μ D x w , D x w ) 00 + ( μ D y w , D y w ) I 3 ] .

Obviously, I 2 ( I 1 + I 2 + I 3 ) . In the following we estimate I 1 , I 2 and I 3 respectively. Since

I 1 = i , j , k ( λ + μ ) i + 1 2 , j , k [ l = 1 L β l Δ x ( u i + l , j , k u i l + 1 , j , k ) ] 2 Δ x Δ y Δ z + i , j , k μ i , j + 1 2 , k [ l = 1 L β l Δ y ( u i , j + l , k u i , j l + 1 , k ) ] 2 Δ x Δ y Δ z + i , j , k μ i , j , k + 1 2 [ l = 1 L β l Δ z ( u i , j , k + l u i , j , k l + 1 ) ] 2 Δ x Δ y Δ z ,

we have the following estimates for I 1 :

I 1 2 ( l = 1 L | β l Δ x | ) i , j , k l = 1 L | β l Δ x | ( λ + μ ) i + 1 2 , j , k ( u i + l , j , k 2 + u i l + 1 , j , k 2 ) Δ x Δ y Δ z + 2 ( l = 1 L | β l Δ y | ) i , j , k l = 1 L | β l Δ y | μ i , j , k + 1 2 ( u i , j , k + l 2 + u i , j , k l + 1 2 ) Δ x Δ y Δ z + 2 ( l = 1 L | β l Δ z | ) i , j , k l = 1 L | β l Δ z | μ i , j + 1 2 , k ( u i , j + l , k 2 + u i , j l + 1 , k 2 ) Δ x Δ y Δ z ,

or

I 1 4 ( l = 1 L | β l Δ x | ) i , j , k l = 1 L | β l Δ x | [ ( λ + μ ) i + l 1 2 , j , k 2 ρ i , j , k + ( λ + μ ) i l + 1 2 , j , k 2 ρ i , j , k ] ρ i , j , k u i , j , k 2 Δ x Δ y Δ z + 4 ( l = 1 L | β l Δ z | ) i , j , k l = 1 L | β l Δ z | [ μ i , j , k + l 1 2 2 ρ i , j , k + μ i , j , k l + 1 2 2 ρ i , j , k ] ρ i , j , k u i , j , k 2 Δ x Δ y Δ z + 4 ( l = 1 L | β l Δ y | ) i , j , k l = 1 L | β l Δ y | [ μ i , j + l 1 2 , k 2 ρ i , j , k + μ i , j l + 1 2 , k 2 ρ i , j , k ] ρ i , j , k u i , j , k 2 Δ x Δ y Δ z ,

or

I 1 4 Δ x 2 ( l = 1 L | β l | ) i , j , k l = 1 L | β l | [ ( λ + μ ) i + l 1 2 , j , k 2 ρ i , j , k + ( λ + μ ) i l + 1 2 , j , k 2 ρ i , j , k ] ( ρ u , u ) 000 + 4 Δ z 2 ( l = 1 L | β l | ) i , j , k l = 1 L | β l | [ μ i , j , k + l 1 2 2 ρ i , j , k + μ i , j , k l + 1 2 2 ρ i , j , k ] ( ρ u , u ) 000 + 4 Δ y 2 ( l = 1 L | β l | ) i , j , k l = 1 L | β l | [ μ i , j + l 1 2 , k 2 ρ i , j , k + μ i , j l + 1 2 , k 2 ρ i , j , k ] ( ρ u , u ) 000 .

Thus we obtain

I 1 ( 4 Δ x 2 + 4 Δ y 2 + 4 Δ z 2 ) ( l = 1 L | β l | ) max i , j , k l = 1 L | β l | × [ ( λ + μ ) i + l 1 2 , j , k 2 ρ i , j , k + ( λ + μ ) i l + 1 2 , j , k 2 ρ i , j , k + μ i , j , k + l 1 2 2 ρ i , j , k + μ i , j , k l + 1 2 2 ρ i , j , k + μ i , j + l 1 2 , k 2 ρ i , j , k + μ i , j l + 1 2 , k 2 ρ i , j , k ] ( ρ u , u ) 000 .

Set

c 1 2 = ( l = 1 L | β l | ) 1 max i , j , k l = 1 L | β l | [ ( λ + μ ) i + l 1 2 , j , k 2 ρ i , j , k + ( λ + μ ) i l + 1 2 , j , k 2 ρ i , j , k + μ i , j , k + l 1 2 2 ρ i , j , k + μ i , j , k l + 1 2 2 ρ i , j , k + μ i , j + l 1 2 , k 2 ρ i , j , k + μ i , j l + 1 2 , k 2 ρ i , j , k ] . (20)

Then for u L 000 3 , we have

I 1 ( 4 Δ x 2 + 4 Δ y 2 + 4 Δ z 2 ) ( l = 1 L | β l | ) 2 c 1 2 ( ρ u , u ) 000 , u L 000 3 . (21)

Similarly, we have

I 2 ( 4 Δ x 2 + 4 Δ y 2 + 4 Δ z 2 ) ( l = 1 L | β l | ) 2 c 2 2 ( ρ v , v ) 0 , v L 0 3 , (22)

where

c 2 2 = ( l = 1 L | β l | ) 1 max i , j , k l = 1 L | β l | [ ( λ + μ ) i + 1 2 , j + l , k 2 ρ i + 1 2 , j + 1 2 , k + ( λ + μ ) i + 1 2 , j l , k 2 ρ i + 1 2 , j + 1 2 , k + μ i + l , j + 1 2 , k 2 ρ i + 1 2 , j + 1 2 , k + μ i l , j + 1 2 , k 2 ρ i + 1 2 , j + 1 2 , k + μ i + 1 2 , j + 1 2 , k + l 1 2 2 ρ i + 1 2 , j + 1 2 , k + μ i + 1 2 , j + 1 2 , k l + 1 2 2 ρ i + 1 2 , j + 1 2 , k ] . (23)

And

I 3 ( 4 Δ x 2 + 4 Δ y 2 + 4 Δ z 2 ) ( l = 1 L | β l | ) 2 c 3 2 ( ρ w , w ) 0 , w L 0 3 , (24)

where

c 3 2 = ( l = 1 L | β l | ) 1 max i , j , k l = 1 L | β l | [ ( λ + μ ) i + 1 2 , j , k + l 2 ρ i + 1 2 , j , k + 1 2 + ( λ + μ ) i + 1 2 , j , k l + 1 2 ρ i + 1 2 , j , k + 1 2 + μ i + l , j , k + 1 2 2 ρ i + 1 2 , j , k + 1 2 + μ i l + 1 , j + 1 2 , k + 1 2 2 ρ i + 1 2 , j , k + 1 2 + μ i + 1 2 , j + l 1 2 , k + 1 2 2 ρ i + 1 2 , j , k + 1 2 + μ i + 1 2 , j l + 1 2 , k + 1 2 2 ρ i + 1 2 , j , k + 1 2 ] . (25)

Substituting (21), (22) and (24) into (19), we have

c 2 Δ t 2 ( 1 Δ x 2 + 1 Δ y 2 + 1 Δ z 2 ) ( l = 1 L | β l | ) 2 1 2 . (26)

where c = max { c 1 , c 2 , c 3 } . Thus we obtain the sufficient stability condition for the numerical scheme (15)-(17). If the grid is uniform, i.e. Δ x = Δ y = Δ z h , then (26) gives

c Δ t 6 6 h ( l = 1 L | β l | ) 1 .

Therefore we summarize the conclusion above into the following theorem.

Theorem 1. A sufficient stability condition for the numerical schemes (15)-(17) is

c Δ t 1 Δ x 2 + 1 Δ y 2 + 1 Δ z 2 2 2 ( l = 1 L | β l | ) 1 , (27)

If Δ x = Δ y = Δ z h , then it reduces to

c Δ t 6 6 h ( l = 1 L | β l | ) 1 , (28)

where c = max { c 1 , c 2 , c 3 } , and c 1 , c 2 and c 3 are given by (20), (23) and (25) respectively.

4. Plane Wave Analysis

We turn to Fourier analysis [21] and we will derive the dispersion relation and by the von Neumann criterion we will get a necessary and sufficient stability condition. In homogeneous case for (12)-(14), the full-discrete schemes can be written as

ρ ( u n + 1 2 u n + u n 1 ) i , j , k + Δ t 2 { ( λ + 2 μ ) D x 2 u n + λ D x D y v n + λ D x D z w n + μ D y D x v n + μ D y 2 u n + μ D z 2 u n + μ D z D x w n } ( i , j , k ) = 0 , (29)

ρ ( v n + 1 2 v n + v n 1 ) i + 1 2 , j + 1 2 , k + Δ t 2 { μ D x 2 v n + μ D x D y u n + ( λ + 2 μ ) D y 2 v n + λ D y D x u n + λ D y D z w n + μ D z 2 v n + μ D z D y w n } ( i + 1 2 , j + 1 2 , k ) = 0, (30)

ρ ( w n+1 2 w n + w n1 ) i+ 1 2 ,j,k+ 1 2 +Δ t 2 { μ D x D z u n +μ D x 2 w n +μ D y D z v n +μ D y 2 w n +( λ+2μ ) D z 2 w n +λ D z D x u n + λ D z D y v n }( i+ 1 2 ,j,k+ 1 2 )=0. (31)

We assume that u = d e i ( ω t k x ) is a solution of Equation (29)-(31), where i = 1 , ω is the angular frequency, d = ( d 1 , d 2 , d 3 ) amplitude, and

k = ( k 1 , k 2 , k 3 ) | k | ( cos θ sin ϕ , sin θ sin ϕ , cos ϕ )

is the wave vector. Here θ is the propagation angle and ϕ the propagation azimuth. The two angles determine the movement direction of the plane wave in the 3D space.

Substituting the plane wave solution into Equations (29)-(31), we obtain the following relations:

d 1 sin 2 ( ω Δ t 2 ) = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 } d 1 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) } d 2 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } d 3 , (32)

d 2 sin 2 ( ω Δ t 2 ) = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 1 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 } d 2 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) } d 3 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } d 1 , (33)

d 3 sin 2 ( ω Δ t 2 ) = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) ) 2 } d 3 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } d 1 + Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } d 2 . (34)

By introducing the matrix B with elements ( b i j ) defined by

b 11 = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 } ,

b 12 = b 21 = Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) } ,

b 22 = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 } ,

b 13 = b 31 = Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } ,

b 23 = b 32 = Δ t 2 h 2 { λ + μ ρ l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) } ,

b 33 = Δ t 2 h 2 { λ + 2 μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 3 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 2 h 2 ) ) 2 + μ ρ ( l = 1 L β l sin ( ( 2 l 1 ) k 1 h 2 ) ) 2 } ,

we can write the relations (32)-(34) as the following matrix form

B d = sin 2 ( ω Δ t 2 ) d . (35)

The eigenvalues of B then express ω as a function of k , which is the dispersion relation. There are three eigenvalues for matrix B. One eigenvalue is corresponding to the longitudinal or compressional wave, the double eigenvalues are corresponding to the transverse or shear wave. Thus we have the following two different relations

{ sin ( ω Δ t 2 ) = C p Δ t h A 2 ( k 1 ) + A 2 ( k 2 ) + A 2 ( k 3 ) , sin ( ω Δ t 2 ) = C s Δ t h A 2 ( k 1 ) + A 2 ( k 2 ) + A 2 ( k 3 ) , (36)

where

A ( k ) = l = 1 L β l sin ( ( 2 l 1 ) k h 2 ) , C p = λ + 2 μ ρ , C s = μ ρ .

here C p and C s are the velocities of compressional and shear waves. Note that C p is always larger than C s . With the dispersion relations (36), we can apply the von Neumann stability criterion. A necessary stability is that the eigenvalues of B must be lower than 1. Thus we have

C p Δ t h A 2 ( k 1 ) + A 2 ( k 2 ) + A 2 ( k 3 ) 1. (37)

It is easy to verify that

max k 1 , k 2 , k 3 A 2 ( k 1 ) + A 2 ( k 2 ) + A 2 ( k 3 ) = A 2 ( π h ) + A 2 ( π h ) + A 2 ( π h ) = 3 ( l = 1 L | β l | ) . (38)

Therefore we obtain the following theorem.

Theorem 2. In the homogeneous case, a sufficient and necessary stability condition for the numerical schemes (29)-(31) is given by

Δ t 3 3 ( l = 1 L | β l | ) 1 . (39)

Proof Combining Equations (37) and (38), we obtain (39). Moreover, the matrix B is symmetric in homogeneous case. So the condition (39) is a sufficient and necessary condition. The proof is complete.

We now define the normalized phase error E ϕ as follow:

E ϕ = C ϕ C C v , C ϕ = ω ( k ) k , (40)

which is a function of H | k | h 2 π , where C v indicates C p or C s which is related to different kinds of compressional wave and shear wave.

The stability condition P C Δ t / h is defined by Courant-Friedrichs-Lewy (CFL) condition which bounds the interval for stability. We plot some dispersion curves based on Equation (40). Without loss of generality, we present dispersion curves for some special propagation angle and azimuth. Figure 1 is the normalized phase error for fixed θ = 45 and ϕ = 45 with different values of CFL condition and it shows that the phase error drops as increasing the order of accuracy. Figure 2 shows the normalized phase error for θ = 30 and different values of ϕ for different order or L. The figures for other propagation angle θ and azimuth ϕ are similar we omit them for saving space.

5. Numerical Computations

Wave simulation ignited by a point source is usually adopted in geophysical applications. For convenience, we simulate 3D elastic wave propagation in a homogeneous cubic model. The computational domain is [ 0,2000 m ] 3 . The source is located in the center of the model and its time function is given by

s ( t ) = sin ( 300 t ) e ( 300 t ) 3 , (41)

which is loaded on the u component. The compressional velocity is 4000 m/s and the shear velocity 2500 m/s. The time step is Δ t = 0.001 s and the space step is h = 10 m . Figure 3 shows the 3D snapshot of u component at propagation time 0.2 s. For brevity, we present some 2D slices of the 3D snapshots of u, v, and w components. The xz sections of 3D snapshots of u, v, and w components at propagation time 0.2 s are shown in Figures 4-6 respectively. We omit other sections for space. In our computations the scheme with fourth-order accuracy in space is applied. We remark that the comparisons between the numerical solution and the exact solution can be found in [17] . From Figures 4-6, we can clearly see the two types of waves, i.e. the compressional wave and the shear wave, which is consistent with the physical phenomenon.

Figure 1. The normalized phase error for different CFL number at the stability limit P max = C Δ t / h . The propagation angles θ = 45 and ϕ = 45 are fixed.

Figure 2. The normalized phase error for different CFL number at different propagation angle ϕ . The propagation angle θ = 30 is fixed.

Figure 3. The 3D snapshot of u component at propagation time 0.2 s.

Figure 4. The xz-section of 3D snapshot of u component at propagation time 0.2 s.

Figure 5. The xz-section of 3D snapshot of v component at propagation time 0.2 s.

Figure 6. The xz-section of 3D snapshot of w component at propagation time 0.2 s.

6. Conclusion

The staggered-grid difference method is a very important technique to solve wave equations numerically because of its high efficiency and the character of energy preservation. It has been well applied to seismic wave propagation for more than two decades. Based on the energy estimate method, we implement the stability analysis for the high-order staggered-grid schemes of the inhomogeneous 3D elastic wave equation. The stability result is controlled by the space varying parameters and the difference coefficients. The plane wave analysis in homogeneous media is completed and by the von Neumann criterion a necessary and sufficient stability condition is obtained. The analysis is helpful to design the computational parameters such as the time step and the space steps. Numerical computations are given to verify the effectiveness of the schemes. The key point of this paper is the theoretical analysis. In the future, we will consider more numerical computations for inhomogeneous media.

Acknowledgements

This work is supported by National Natural Science Foundation of China under grant numbers 11471328 and 51739007. It is also partially supported by National Center for Mathematics and Interdisciplinary Sciences, Chinese Academy of Sciences.

Conflicts of Interest

The authors declare no conflicts of interest regarding the publication of this paper.

Cite this paper

Joardar, A.K. and Zhang, W.S. (2019) Stability of High-Order Staggered-Grid Schemes for 3D Elastic Wave Equation in Heterogeneous Media. Journal of Applied Mathematics and Physics, 7, 1755-1774. https://doi.org/10.4236/jamp.2019.78120

References

  1. 1. De Basabe, J.D. and Sen, M.K. (2010) Stability of the High-Order Finite Elements for Acoustic or Elastic Wave Propagation with High-Order Time Stepping. Geophysical Journal International, 181, 577-590. https://doi.org/10.1111/j.1365-246X.2010.04536.x

  2. 2. Bécache, E., Joly, P. and Tsogka, C. (2002) A New Family of Mixed Finite Elements for the Linear Elastodynamic Problem. SIAM Journal on Numerical Analysis, 39, 2109-2132. https://doi.org/10.1137/S0036142999359189

  3. 3. Cohen, G.C. (2002) Higher-Order Numerical Methods for Transient Wave Equations. Springer, New York. https://doi.org/10.1007/978-3-662-04823-8

  4. 4. Zhang, W., Chung, E.T. and Wang, C. (2014) Stability for Imposing Absorbing Boundary Conditions in the Finite Element Simulation of Acoustic Wave Propagation. Journal of Computational Mathematics, 32, 1-20. https://doi.org/10.4208/jcm.1310-m3942

  5. 5. Komatitsch, D., Martin, R., Tromp, J., Taylor, M.A. and Wingate, B.A. (2001) Wave Propagation in 2-D Elastic Media Using a Spectral Element Method with Triangles and Quadrangles. Journal of Computational Acoustics, 9, 703-718. https://doi.org/10.1142/S0218396X01000796

  6. 6. Chung, E.T. and Engquist, B. (2006) Optimal Discontinuous Galerkin Methods for Wave Propagation. SIAM Journal on Numerical Analysis, 44, 2131-2158. https://doi.org/10.1137/050641193

  7. 7. Dumbser, M., Käser, M. and Toto, E.F. (2007) An Arbitrary High-Order Discontinuous Galerkin Method for Elastic Waves on Unstructured Meshes-V. Local Time Stepping and p-Adaptivity. Geophysical Journal International, 171, 695-717. https://doi.org/10.1111/j.1365-246X.2007.03427.x

  8. 8. Dumbser, M., Käser, M. and de la Puente, J. (2007) Arbitrary High-Order Finite Volume Schemes for Seismic Wave Propagation on Unstructured Meshes in 2D and 3D. Geophysical Journal International, 171, 665-694. https://doi.org/10.1111/j.1365-246X.2007.03421.x

  9. 9. Zhang, W., Zhuang, Y. and Chung, E.T. (2007) A New Spectral Finite Volume Method for Elastic Wave Modelling on Unstructured Meshes. Geophysical Journal International, 206, 292-307. https://doi.org/10.1093/gji/ggw148

  10. 10. Alford, R.M., Kelly, K.R. and Boore, D.M. (1974) Accuracy of Finite-Difference Modeling of the Acoustic Wave Equation. Geophysics, 39, 834-842. https://doi.org/10.1190/1.1440470

  11. 11. Bayliss, A., Jordan, K.E., Lemesurier, B. and Turkel, E. (1986) A Fourth Accurate Finite Difference Scheme for the Computation of Elastic Waves. Bulletin of the Seismological Society of America, 76, 1115-1132.

  12. 12. Virieux, J. (1986) P-SV Wave Propagation in Heterogeneous Media: Velocity Stress Formulation Finite Difference Method. Geophysics, 51, 889-901. https://doi.org/10.1190/1.1441605

  13. 13. Zingg, D.W., Lomax, H. and Jurgens, H. (1996) High-Accuracy Finite-Difference Schemes for Linear Wave Propagation. SIAM Journal on Scientific Computing, 17, 328-346. https://doi.org/10.1137/S1064827599350320

  14. 14. Cohen, G. and Joly, P. (1996) Construction and Analysis of Fourth-Order Finite Difference Schemes for the Acoustic Wave Equation in Nonhomogeneous Media. SIAM Journal on Numerical Analysis, 33, 1266-1302. https://doi.org/10.1137/S0036142993246445

  15. 15. Sei, A. (1995) A Family of Numerical Schemes for the Computation of Elastic Waves. SIAM Journal on Scientific Computing, 16, 898-916. https://doi.org/10.1137/0916052

  16. 16. Nilsson, S., Petersson, N.A., Sjögreen, B. and Kreiss, H.-O. (2007) Stable Difference Approximations for the Elastic Wave Equation in Second Order Formulation. SIAM Journal on Numerical Analysis, 45, 1902-1936. https://doi.org/10.1137/060663520

  17. 17. Zhang, W. (2019) A New Family of Fourth-Order Locally One-Dimensional Schemes for the 3D Elastic Wave Equation. Journal of Computational and Applied Mathematics, 348, 246-260. https://doi.org/10.1016/j.cam.2018.08.056

  18. 18. Fornberg, B. (1988) Generation of Finite Difference Formulas on Arbitrarily Spaced Grids. Mathematics of Computation, 51, 699-706. https://doi.org/10.1090/S0025-5718-1988-0935077-0

  19. 19. Fornberg, B. (1990) High-Order Finite Differences and the Pseudospectral Method on Staggered Grids. SIAM Journal on Numerical Analysis, 27, 904-918. https://doi.org/10.1137/0727052

  20. 20. Fornberg, B. and Ghrist, M. (1999) Spatial Finite Difference Approximations for Wave-Type Equations. SIAM Journal on Numerical Analysis, 37, 105-130. https://doi.org/10.1137/S0036142998335881

  21. 21. Thomas, J.W. (1995) Numerical Partial Differential Equations: Finite Difference Methods. Springer-Verlag, New York. https://doi.org/10.1007/978-1-4899-7278-1

Appendix: Expression of the Coefficient β l

The calculation of difference coefficients on both regular and staggered-grid grids has been investigated by several authors [15] [18] [19] [20] . In this appendix we present the analytical expression of the difference coefficient β l in (10) or (11). In order to calculate the coefficient β l , we consider an explicit staggered-grid difference expression for a function f ( x ) :

f x 1 h l = 1 L β l [ f ( x + l h 1 2 h ) f ( x l h + 1 2 h ) ] ,

where h is the step size, L is a positive number and β l are the difference coefficients. Now consider f = f 0 e i k x and α = k h / 2 , where k is the wave number, i = 1 and f 0 is a constant then we have

α l = 1 L β l sin ( ( 2 l 1 ) α ) .

Then Taylor’s series expansion gives

α m = 1 [ ( 1 ) m 1 ( 2 m 1 ) ! l = 1 L ( 2 l 1 ) 2 m 1 β l α 2 m 1 ] .

Now equating the coefficient of α both sides we get

( 1 ) m 1 ( 2 m 1 ) ! l = 1 L [ ( 2 l 1 ) 2 m 1 ] β l = ( 1 , m = 1 , 0 , m = 2 , 3 , , L .

We can rewrite this equation in the following form

[ 1 0 3 0 ( 2 L 1 ) 0 1 2 3 2 ( 2 L 1 ) 2 1 2 L 1 3 2 L 2 ( 2 L 1 ) 2 L 2 ] [ 1 β 1 3 β 2 ( 2 L 1 ) β L ] = [ 1 0 0 ] .

Now solving the above system, we get the following solutions

β l = ( 1 ) l + 1 2 l 1 1 m L , m l | ( 2 m 1 ) 2 ( 2 l 1 ) 2 ( 2 m 1 ) 2 | , l = 1 , , L .