KEMBAR78
Numerical Methods for Acoustic Waves | PDF | Finite Element Method | Partial Differential Equation
0% found this document useful (0 votes)
527 views61 pages

Numerical Methods for Acoustic Waves

This document discusses numerical methods for solving partial differential equations (PDEs), specifically focusing on finite difference and Fourier methods. It provides examples of applying finite differences to solve the 1D acoustic wave equation and discusses stability, dispersion, and implementation issues. Fourier methods are also introduced, explaining pseudospectral methods, Fourier derivatives, and the fast Fourier transform (FFT) which makes Fourier methods much more computationally efficient than evaluating the full matrix transformations.
Copyright
© Attribution Non-Commercial (BY-NC)
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PPT, PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
527 views61 pages

Numerical Methods for Acoustic Waves

This document discusses numerical methods for solving partial differential equations (PDEs), specifically focusing on finite difference and Fourier methods. It provides examples of applying finite differences to solve the 1D acoustic wave equation and discusses stability, dispersion, and implementation issues. Fourier methods are also introduced, explaining pseudospectral methods, Fourier derivatives, and the fast Fourier transform (FFT) which makes Fourier methods much more computationally efficient than evaluating the full matrix transformations.
Copyright
© Attribution Non-Commercial (BY-NC)
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PPT, PDF, TXT or read online on Scribd
You are on page 1/ 61

Numerical methods

Specific methods:
Finite differences
Pseudospectral methods
Finite volumes
Specific methods:
Finite differences
Pseudospectral methods
Finite volumes
applied to the acoustic wave equation

Example: seismic wave propagation
Why numerical methods
Generally heterogeneous
medium
Seismometers
explosion
we need numerical
solutions! we need grids!
And big computers
Partial Differential Equations in Geophysics
) (
2 2 2
2 2
z
y x
t
s p c p
+ +
+ The acoustic
wave equation
- seismology
- acoustics
- oceanography
- meteorology
Diffusion, advection,
Reaction
- geodynamics
- oceanography
- meteorology
- geochemistry
- sedimentology
- geophysical fluid dynamics
P pressure
c acoustic wave speed
s sources
P pressure
c acoustic wave speed
s sources
p RC C C k C
t
+ v
C tracer concentration
k diffusivity
v flow velocity
R reactivity
p sources
C tracer concentration
k diffusivity
v flow velocity
R reactivity
p sources
Numerical methods: properties
Finite differences
Finite volumes
- time-dependent PDEs
- seismic wave propagation
- geophysical fluid dynamics
- Maxwells equations
- Ground penetrating radar
-> robust, simple concept, easy to
parallelize, regular grids, explicit method
Finite elements
- static and time-dependent PDEs
- seismic wave propagation
- geophysical fluid dynamics
- all problems
-> implicit approach, matrix inversion, well founded,
irregular grids, more complex algorithms,
engineering problems
- time-dependent PDEs
- seismic wave propagation
- mainly fluid dynamics
-> robust, simple concept, irregular grids, explicit
method
Other Numerical methods:
Particle-based
methods
Pseudospectral
methods
- lattice gas methods
- molecular dynamics
- granular problems
- fluid flow
- earthquake simulations
-> very heterogeneous problems, nonlinear problems
Boundary element
methods
- problems with boundaries (rupture)
- based on analytical solutions
- only discretization of planes
--> good for problems with special boundary conditions
(rupture, cracks, etc)
- orthogonal basis functions, special case of FD
- spectral accuracy of space derivatives
- wave propagation, GPR
-> regular grids, explicit method, problems with
strongly heterogeneous media
What is a finite difference?
Common definitions of the derivative of f(x):
dx
x f dx x f
f
dx
x
) ( ) (
lim
0
+

dx
dx x f x f
f
dx
x
) ( ) (
lim
0

dx
dx x f dx x f
f
dx
x
2
) ( ) (
lim
0
+

These are all correct definitions in the limit dx->0.


But we want dx to remain FINITE
What is a finite difference?
The equivalent approximations of the derivatives are:
dx
x f dx x f
f
x
) ( ) ( +

+
dx
dx x f x f
f
x
) ( ) (


dx
dx x f dx x f
f
x
2
) ( ) ( +

forward difference
backward difference
centered difference
The big question:
How good are the FD approximations?

This leads us to Taylor series....
Our first FD algorithm (ac1d.m) !
) (
2 2 2
2 2
z
y x
t
s p c p
+ +
+
P pressure
c acoustic wave speed
s sources
P pressure
c acoustic wave speed
s sources
Problem: Solve the 1D acoustic wave equation using the finite
Difference method.
Problem: Solve the 1D acoustic wave equation using the finite
Difference method.
Solution:
Solution:
[ ]
2
2
2 2
) ( ) ( 2
) ( ) ( 2 ) ( ) (
sdt dt t p t p
dx x p x p dx x p
dx
dt c
dt t p
+ +
+ + +
Problems: Stability
[ ]
2
2
2 2
) ( ) ( 2
) ( ) ( 2 ) ( ) (
sdt dt t p t p
dx x p x p dx x p
dx
dt c
dt t p
+ +
+ + +
1
dx
dt
c
Stability: Careful analysis using harmonic functions shows that
a stable numerical calculation is subject to special conditions
(conditional stability). This holds for many numerical problems.
Stability: Careful analysis using harmonic functions shows that
a stable numerical calculation is subject to special conditions
(conditional stability). This holds for many numerical problems.
Problems: Dispersion
[ ]
2
2
2 2
) ( ) ( 2
) ( ) ( 2 ) ( ) (
sdt dt t p t p
dx x p x p dx x p
dx
dt c
dt t p
+ +
+ + +
Dispersion: The numerical
approximation has
artificial dispersion,
in other words, the wave
speed becomes frequency
dependent.
You have to find a
frequency bandwidth
where this effect is small.
The solution is to use a
sufficient number of grid
points per wavelength.
Dispersion: The numerical
approximation has
artificial dispersion,
in other words, the wave
speed becomes frequency
dependent.
You have to find a
frequency bandwidth
where this effect is small.
The solution is to use a
sufficient number of grid
points per wavelength.
True velocity
Our first FD code!
[ ]
2
2
2 2
) ( ) ( 2
) ( ) ( 2 ) ( ) (
sdt dt t p t p
dx x p x p dx x p
dx
dt c
dt t p
+ +
+ + +
% Time stepping
for i=1:nt,

% FD

disp(sprintf(' Time step : %i',i));

for j=2:nx-1
d2p(j)=(p(j+1)-2*p(j)+p(j-1))/dx^2; % space derivative
end
pnew=2*p-pold+d2p*dt^2; % time extrapolation
pnew(nx/2)=pnew(nx/2)+src(i)*dt^2; % add source term
pold=p; % time levels
p=pnew;
p(1)=0; % set boundaries pressure free
p(nx)=0;

% Display
plot(x,p,'b-')
title(' FD ')
drawnow
end
Snapshot Example
0 1000 2000 3000 4000 5000 6000
0
500
1000
1500
2000
2500
3000
Distance(km)

T
i
m
e

(
s
)

Velocity5km/s
Seismogram Dispersion
Finite Differences - Summary
Conceptually the most simple of the numerical methods and
can be learned quite quickly

Depending on the physical problem FD methods are


conditionally stable (relation between time and space
increment)
FD methods have difficulties concerning the accurate
implementation of boundary conditions (e.g. free surfaces,
absorbing boundaries)
FD methods are usually explicit and therefore very easy to
implement and efficient on parallel computers
FD methods work best on regular, rectangular grids
Conceptually the most simple of the numerical methods and
can be learned quite quickly

Depending on the physical problem FD methods are


conditionally stable (relation between time and space
increment)

FD methods have difficulties concerning the accurate


implementation of boundary conditions (e.g. free surfaces,
absorbing boundaries)
FD methods are usually explicit and therefore very easy to
implement and efficient on parallel computers
FD methods work best on regular, rectangular grids
Numerical Methods in Geophysics The Fourier Method
The Fourier Method
- What is a pseudo-spectral Method?
- Fourier Derivatives
- The Fast Fourier Transform (FFT)
- The Acoustic Wave Equation with the Fourier Method
- Comparison with the Finite-Difference Method
- Dispersion and Stability of Fourier Solutions
Numerical Methods in Geophysics The Fourier Method
What is a pseudo-spectral Method?
Spectral solutions to time-dependent PDEs are formulated
in the frequency-wavenumber domain and solutions are
obtained in terms of spectra (e.g. seismograms). This
technique is particularly interesting for geometries where
partial solutions in the -k domain can be obtained
analytically (e.g. for layered models).
In the pseudo-spectral approach - in a finite-difference like
manner - the PDEs are solved pointwise in physical space
(x-t). However, the space derivatives are calculated using
orthogonal functions (e.g. Fourier Integrals, Chebyshev
polynomials). They are either evaluated using matrix-
matrix multiplications or the fast Fourier transform (FFT).

Numerical Methods in Geophysics The Fourier Method
Fourier Derivatives

,
`

.
|

dk e k ikF
dk e k F x f
ikx
ikx
x x
) (
) ( ) (
.. let us recall the definition of the derivative using Fourier integrals ...
... we could either ...
1) perform this calculation in the space domain by convolution
2) actually transform the function f(x) in the k-domain and back
Numerical Methods in Geophysics The Fourier Method
The Fast Fourier Transform
... the latter approach became interesting with the introduction of the
Fast Fourier Transform (FFT). Whats so fast about it ?
The FFT originates from a paper by Cooley and Tukey (1965, Math.
Comp. vol 19 297-301) which revolutionised all fields where Fourier
transforms where essential to progress.
The discrete Fourier Transform can be written as
1 ,..., 1 , 0 ,
1 ,..., 1 , 0 ,
1

/ 2
1
0
/ 2
1
0

N k e u u
N k e u
N
u
N ikj
N
j
j k
N ikj
N
j
j k

Numerical Methods in Geophysics The Fourier Method


The Fast Fourier Transform
... this can be written as matrix-vector products ...
for example the inverse transform yields ...
]
]
]
]
]
]
]
]
]
]

]
]
]
]
]
]
]
]
]
]

]
]
]
]
]
]
]
]
]
]

1
2
1
0
1
2
1
0
) 1 ( 1
2 2 6 4 2
1 3 2

1
1
1
1 1 1 1 1
2
N N
N N
N
N
u
u
u
u
u
u
u
u




.. where ...
N i
e
/ 2

Numerical Methods in Geophysics The Fourier Method
The Fast Fourier Transform
... the FAST bit is recognising that the full matrix - vector multiplication
can be written as a few sparse matrix - vector multiplications
(for details see for example Bracewell, the Fourier Transform and its
applications, MacGraw-Hill) with the effect that:
Number of multiplications Number of multiplications
full matrix FFT
N
2
2Nlog
2
N

this has enormous implications for large scale problems.
Note: the factorisation becomes particularly simple and effective
when N is a highly composite number (power of 2).
Numerical Methods in Geophysics The Fourier Method
The Fast Fourier Transform
.. the right column can be regarded as the speedup of an algorithm
when the FFT is used instead of the full system.
Number of multiplications Number of multiplications
Problem full matrix FFT Ratio full/FFT
1D (nx=512) 2.6x10
5
9.2x10
3
28.4
1D (nx=2096) 94.98
1D (nx=8384) 312.6
Numerical Methods in Geophysics The Fourier Method
Acoustic Wave Equation - Fourier Method
let us take the acoustic wave equation with variable density

,
`

.
|
p p
c
x x t

1 1
2
2
the left hand side will be expressed with our
standard centered finite-difference approach
[ ]

,
`

.
|
+ + p dt t p t p dt t p
dt c
x x

1
) ( ) ( 2 ) (
1
2 2
... leading to the extrapolation scheme ...
Numerical Methods in Geophysics The Fourier Method
Acoustic Wave Equation - Fourier Method
where the space derivatives will be calculated using the Fourier Method.
The highlighted term will be calculated as follows:
) ( ) ( 2
1
) (
2 2
dt t p t p p dt c dt t p
x x
+

,
`

.
|
+

n
j x
n n n
j
P P ik P P
1
FFT

FFT

multiply by 1/

,
`

.
|

,
`

.
|

,
`

.
|

n
j x x
n
x
n
x
n
j x
P P ik P P

1
FFT

1
FFT
1
1
... then extrapolate ...
Numerical Methods in Geophysics The Fourier Method
Acoustic Wave Equation - 3D
) ( ) ( 2
1 1 1
) (
2 2
dt t p t p
p p p dt c
dt t p
z z y y x x
+

,
`

.
|

,
`

.
|
+

,
`

.
|
+

,
`

.
|

+

n
j x
n n n
j
P P ik P P
1
FFT

FFT

,
`

.
|

,
`

.
|

,
`

.
|

n
j x x
n
x
n
x
n
j x
P P ik P P

1
FFT

1
FFT
1
1
.. where the following algorithm applies to each space dimension ...
Numerical Methods in Geophysics The Fourier Method
Comparison with finite differences - Algorithm
let us compare the core of the algorithm - the calculation of the
derivative
(Matlab code)
f u n c t i o n d f = f d e r 1 d ( f , d x , n o p )
% f D E R 1 D ( f , d x , n o p ) f i n i t e d i f f e r e n c e
% s e c o n d d e r i v a t i v e
n x = m a x ( s i z e ( f ) ) ;
n 2 = ( n o p - 1 ) / 2 ;
i f n o p = = 3 ; d = [ 1 - 2 1 ] / d x ^ 2 ; e n d
i f n o p = = 5 ; d = [ - 1 / 1 2 4 / 3 - 5 / 2 4 / 3 - 1 / 1 2 ] / d x ^ 2 ; e n d
d f = [ 1 : n x ] * 0 ;
f o r i = 1 : n o p ;
d f = d f + d ( i ) . * c s h i f t 1 d ( f , - n 2 + ( i - 1 ) ) ;
e n d
Numerical Methods in Geophysics The Fourier Method
Comparison with finite differences - Algorithm
... and the first derivative using FFTs ...
f u n c t i o n d f = s d e r 1 d ( f , d x )
% S D E R 1 D ( f , d x ) s p e c t r a l d e r i v a t i v e o f v e c t o r
n x = m a x ( s i z e ( f ) ) ;
% i n i t i a l i z e k
k m a x = p i / d x ;
d k = k m a x / ( n x / 2 ) ;
f o r i = 1 : n x / 2 , k ( i ) = ( i ) * d k ; k ( n x / 2 + i ) = - k m a x + ( i ) * d k ; e n d
k = s q r t ( - 1 ) * k ;
% F F T a n d I F F T
f f = f f t ( f ) ; f f = k . * f f ; d f = r e a l ( i f f t ( f f ) ) ;
.. simple and elegant ...
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Dispersion and Stability
... with the usual Ansatz
) ( dt n kjdx i n
j
e p

we obtain
) ( 2 2 ndt kjdx i n
j x
e k p


) ( 2
2
2
2
sin
4
ndt kjdx i n
j t
e
dt
dt
p



... leading to
2
sin
2 dt
cdt
k

Numerical Methods in Geophysics The Fourier Method


Fourier Method - Dispersion and Stability
What are the consequences?
a) when dt << 1, sin
-1
(kcdt/2) kcdt/2 and w/k=c
-> practically no dispersion
b) the argument of asin must be smaller than one.

2
sin
2 dt
cdt
k

)
2
( sin
2
1
kcdt
dt


636 . 0 / 2 /
1
2
max

dx cdt
cdt k
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 10Hz
Example of acoustic 1D wave simulation.
FD 3 -point operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Sourcetimefunction
0 10 20 30
0
0.5
1
Gaussinspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-0.5
0
0.5
1
Time(sec)
3point - 2order; T=6.6s, Error =50.8352%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 10Hz
Example of acoustic 1D wave simulation.
FD 5 -point operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Source time function
0 10 20 30
0
0.5
1
Gauss inspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-0.5
0
0.5
1
Time (sec)
5 point - 2 order; T=7.8 s, Error =3.9286%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 10Hz
Example of acoustic 1D wave simulation.
Fourier operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Sourcetimefunction
0 10 20 30
0
0.5
1
Gauss inspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-1
-0.5
0
0.5
1
Time(sec)
Fourier - 2order; T=35s, Error =2.72504%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 20Hz
Example of acoustic 1D wave simulation.
FD 3 -point operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Sourcetimefunction
0 10 20 30
0
0.5
1
Gaussinspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-1
-0.5
0
0.5
1
Time(sec)
3point - 2order; T=7.8s, Error =156.038%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 20Hz
Example of acoustic 1D wave simulation.
FD 5 -point operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Sourcetimefunction
0 10 20 30
0
0.5
1
Gaussinspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-0.5
0
0.5
1
Time(sec)
5point - 2order; T=7.8s, Error =45.2487%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - 20Hz
Example of acoustic 1D wave simulation.
Fourier operator
red-analytic; blue-numerical; green-difference

0 200 400 600
-0.5
0
0.5
1
Sourcetimefunction
0 10 20 30
0
0.5
1
Gaussinspace
0.8 0.9 1 1.1 1.2 1.3 1.4 1.5
-1
-0.5
0
0.5
1
Time(sec)
Fourier - 2order; T=34s, Error =18.0134%
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Comparison with FD - Table
0
20
40
60
80
100
120
140
160
5 Hz 10 Hz 20 Hz
3 point
5 point
Fourier
Difference (%) between numerical and analytical solution
as a function of propagating frequency
Simulation time
5.4s
7.8s
33.0s
Numerical Methods in Geophysics The Fourier Method
Numerical solutions and Greens Functions
The concept of Greens Functions (impulse responses) plays an
important role in the solution of partial differential equations. It is also
useful for numerical solutions. Let us recall the acoustic wave equation
p c p
t

2 2
with being the Laplace operator. We now introduce a delta source in
space and time
p c t x p
t
+
2 2
) ( ) (
the formal solution to this equation is
x
c x t
c
t x p
) / (
4
1
) , (
2

(Full proof given in Aki and Richards, Quantitative Seismology, Freeman+Co, 1981, p. 65)
Numerical Methods in Geophysics The Fourier Method
Numerical solutions and Greens Functions
In words this means (in 1D and 3D but not in 2D, why?) , that in
homogeneous media the same source time function which is input at the
source location will be recorded at a distance r, but with amplitude
proportional to 1/r.
An arbitrary source can evidently be constructed by summing up different
delta - solutions. Can we use this property in our numerical simulations?
What happens if we solve our numerical system with delta functions as
sources?
x
c x t
c
t x p
) / (
4
1
) , (
2

Numerical Methods in Geophysics The Fourier Method


Numerical solutions and Greens Functions
0 200 400 600 800 1000
0
0.2
0.4
0.6
0.8
1
0 200 400 600 800 1000
0
0.2
0.4
0.6
0.8
1
0 200 400 600 800 1000
0
0.2
0.4
0.6
0.8
1
3 point operator
5 point operator
Fourier Method
Time steps
Impulse response (analytical)
Impulse response (numerical
Source is a Delta
function in space and
time
500 1000 1500
0
1
2
3
4
5
6
7
8
9
10
500 1000 1500
0
1
2
3
4
5
6
7
8
9
10
500 1000 1500
0
1
2
3
4
5
6
7
8
9
10
Numerical Methods in Geophysics The Fourier Method
Numerical solutions and Greens Functions
3 point operator 5 point operator Fourier Method
F
r
e
q
u
e
n
c
y

i
n
c
r
e
a
s
e
s
I
m
p
u
l
s
e

r
e
s
p
o
n
s
e

(
a
n
a
l
y
t
i
c
a
l
)

c
o
n
c
o
l
v
e
d

w
i
t
h

s
o
u
r
c
e
I
m
p
u
l
s
e

r
e
s
p
o
n
s
e

(
n
u
m
e
r
i
c
a
l

c
o
n
v
o
l
v
e
d

w
i
t
h

s
o
u
r
c
e
Numerical Methods in Geophysics The Fourier Method
Fourier Method - Summary
The Fourier Method can be considered as the limit of the finite-difference
method as the length of the operator tends to the number of points along
a particular dimension.
The space derivatives are calculated in the wavenumber domain by
multiplication of the spectrum with ik. The inverse Fourier transform
results in an exact space derivative up to the Nyquist frequency.
The use of Fourier transform imposes some constraints on the
smoothness of the functions to be differentiated. Discontinuities lead to
Gibbs phenomenon.
As the Fourier transform requires periodicity this technique is particular
useful where the physical problems are periodical (e.g. angular
derivatives in cylindrical problems).

Finite Elements the concept
How to proceed in FEM analysis:
Divide structure into pieces (like LEGO)
Describe behaviour of the physical quantities
in each element
Connect (assemble) the elements at the nodes
to form an approximate system of equations
for the whole structure
Solve the system of equations involving unknown
quantities at the nodes (e.g. displacements)
Calculate desired quantities (e.g. strains and
stresses) at selected elements
Finite Elements Why?
FEM allows discretization of bodies with arbitrary shape.
Originally designed for problems in static elasticity.
FEM is the most widely applied computer simulation method in
engineering.
Today spectral elements is an attractive new method with
applications in seismology and geophysical fluid dynamics
The required grid generation techniques are interfaced with
graphical techniques (CAD).
Today a large number of commercial FEM software is available
(e.g. ANSYS, SMART, MATLAB, ABACUS, etc.)
Finite Elements Examples
Discretization finite elements
As we are aiming to find a numerical solution to our problem it
is clear we have to discretize the problem somehow. In FE
problems similar to FD the functional values are known at a
discrete set of points.
... regular grid ...
... irregular grid ...
Domain D
The key idea in FE analysis is to approximate all
functions in terms of basis functions , so that
i
N
i
i
c u u


1
~
Finite elements basic formulation
Let us start with a simple linear system of equations
| * y
and observe that we can generally multiply both sides of
this equation with y without changing its solution. Note
that x,y and b are vectors and A is a matrix.
b Ax
n
y yb yAx
We first look at Poissons equation (e.g., wave equation
without time dependence)
) ( ) ( x f x u
where u is a scalar field, f is a source term and in 1-D
2
2
2
x


Formulation Poissons equation
fv uv
We now multiply this equation with an arbitrary function
v(x), (dropping the explicit space dependence)
... and integrate this equation over the whole domain. For
reasons of simplicity we define our physical domain D in
the interval [0, 1].


D D
fv uv
dx fv dx uv


1
0
1
0
... why are we doing this? ... be patient ...
Partial Integration
... partially integrate the left-hand-side of our equation ...
dx fv dx uv


1
0
1
0
[ ] dx u v uv dx uv

+
1
0
1
0
1
0
we assume for now that the derivatives of u at the boundaries vanish
so that for our particular problem
dx u v dx uv


1
0
1
0

... so that we arrive at ...
... with u being the unknown function. This is also true for our
approximate numerical system
dx fv dx v u


1
0
1
0
... where ...
i
N
i
i
c u

1
~
was our choice of approximating u using basis functions.
dx fv dx v u


1
0
1
0
~
The basis functions
... otherwise we are
free to choose any
function ...
The simplest choice
are of course linear
functions:
+ grid nodes
blue lines basis
functions
i
1
2
3
4
5
6
7
8
9
1 0
we are looking for functions
i
with the following property

'

i j x x for
x x for
x
j
i
i
, 0
1
) (
The discrete system
The ingredients:
k
v
i
N
i
i
c u

1
~
dx fv dx v u


1
0
1
0
~
dx f dx c
k k
n
i
i i




,
`

.
|

1
0
1
0
1
... leading to ...
The discrete system
dx f dx c
k k i
n
i
i

1
0
1
0
1
... the coefficients c
k
are constants so that for one
particular function
k
this system looks like ...
k ik i
g A b
... probably not to your surprise this can be written in matrix form
k i
T
ik
g b A
The solution
... with the even less surprising solution
( )
k
T
ik i
g A b
1

remember that while the b


i
s are really the coefficients of the
basis functions these are the actual function values at node points
i as well because of our particular choice of basis functions.
Basis functions and element
Linear
Quadratic
T
r
a
n
g
l
e
s
Q
u
a
d
r
a
n
g
l
e
s
The Acoustic Wave Equation 1-D
How do we solve a time-dependent problem such
as the acoustic wave equation?
where v is the wave speed.
using the same ideas as before we multiply this equation with
an arbitrary function and integrate over the whole domain, e.g. [0,1], and
after partial integration
f u v u
t

2 2
dx f dx u v dx u
j j j t


1
0
1
0
2
1
0
2

.. we now introduce an approximation for u using our previous
basis functions...
The Acoustic Wave Equation 1-D
) ( ) (
~
1
x t c u u
i
N
i
i


together we obtain
) ( ) (
~
1
2 2 2
x t c u u
i
N
i
i t t t


note that now our coefficients are time-dependent!
... and ...



]
]
]

+
]
]
]

1
0
1
0
2
1
0
2
j j
i
i i j
i
i i t
f dx c v dx c
which we can write as ...
Time extrapolation



]
]
]

+
]
]
]

1
0
1
0
2
1
0
2
j j
i
i i j
i
i i t
f dx c v dx c
... in Matrix form ...
g c A v c M
T T
+
2

M
A b
... remember the coefficients c correspond to the
actual values of u at the grid points for the right choice
of basis functions ...
How can we solve this time-dependent problem?
stiffness matrix
mass matrix
FD extrapolation
... let us use a finite-difference approximation for
the time derivative ...
g c A v c M
T T
+
2

... leading to the solution at time t
k+1
:
g c A v
dt
c c c
M
k
T
k k
T
+

,
`

.
|
+
+
2
2
1 1
2
[ ]
1
2 2 1
1
2 ) ( ) (

+
+
k k k
T T
k
c c dt c A v g M c
we already know how to calculate the matrix A but
how can we calculate matrix M?
Matrix assembly
% assemble matrix Mij
M=zeros(nx);
for i=2:nx-1,
for j=2:nx-1,
if i==j,
M(i,j)=h(i-1)/3+h(i)/3;
elseif j==i+1
M(i,j)=h(i)/6;
elseif j==i-1
M(i,j)=h(i)/6;
else
M(i,j)=0;
end
end
end
% assemble matrix Aij
A=zeros(nx);
for i=2:nx-1,
for j=2:nx-1,
if i==j,
A(i,j)=1/h(i-1)+1/h(i);
elseif i==j+1
A(i,j)=-1/h(i-1);
elseif i+1==j
A(i,j)=-1/h(i);
else
A(i,j)=0;
end
end
end
M
ij
A
ij
Numerical example regular grid
This is a movie obtained with the sample Matlab program: femfd.m
Finite Elements - Summary

FE solutions are based on the weak form of the partial


differential equations
FE methods lead in general to a linear system of equations
that has to be solved using matrix inversion techniques
(sometimes these matrices can be diagonalized)
FE methods allow rectangular (hexahedral), or triangular
(tetrahedral) elements and are thus more flexible in terms of
grid geometry

The FE method is mathematically and algorithmically more


complex than FD

The FE method is well suited for elasto-static and elasto-


dynamic problems (e.g. crustal deformation)

You might also like