SlideShare a Scribd company logo
Implicit schemes for wave models
Mathieu Dutour Sikiri´c
Rudjer Bo˘skovi´c Institute, Croatia
and Universit¨at Rostock
November 24, 2017
I. Wave models
Stochastic wave modelling
Oceanic models are using grids (structured or unstructured) of
size 1km ≤ d ≤ 10km to simulate the ocean
But oceanic waves have a typical wavelength 2m ≤ L ≤
100m. So, we cannot resolve waves in the ocean.
But if one uses phase averaged models and uses stochastic
assumptions then it is possible to model waves by a spectral
wave action density N(x, k)
This density satisfies a Wave Action Equation (WAE) which
represents advection, refraction, frequency shifting and source
terms:
∂N
∂t
+ x ((cg + uA)N) + k( ˙kN) + θ( ˙θN) = Stot
with
Stot = Sin + Snl3 + Snl4 + Sbot + Sds + Sbreak + Sbf
The WWM model
The Wind Wave Model (WWM) is a unstructured grid
spectral wave model.
It is comparable to WaveWatch III, SWAN, WAM or SWAVE.
It incorporates most existing source term formulation for wind
input and dissipation (Cycle III, Cycle IV, Ardhuin, Makin, ...)
It has been coupled to SELFE, SHYFEM, TIMOR and ROMS.
It uses Residual Distribution schemes for the horizontal
advection.
It integrates the WAE by using the Operator Splitting Method
in explicit or implicit mode.
Operator Splitting Method
A standard technique for integrating partial differential
equations is the operator splitting method.
Over the interval [t0, t1] we successively solve the equations



∂N1
∂t + θ( ˙θN1) = 0 with N1(t0) = N(t0)
∂N2
∂t + k( ˙kN2) = 0 with N2(t0) = N1(t1)
∂N3
∂t + x ((cg + uA)N3) = 0 with N3(t0) = N2(t1)
∂N4
∂t = S(t) with N4(t0) = N3(t1)
and we set N(t1) = N4(t1).
No matter what the order of the successive integration
schemes is the final order will be 1.
It it is possible to have higher order by more complex
integration procedures (Strang splitting, iterative splitting,
etc.)
The CFL criterion
If the discretization has characteristic length l and the
physical speed is c then we have the condition
c∆t
l
≤ 1
For the integration of the frequency and directional equations
we can subdivide the integration time step if necessary
because everything is decoupled.
This is not possible for the geographical advection:
The dependency in direction/frequency is small or negligible
The problem is that the group speed is
√
gh and so the CFL
number varies with the depth and the resolution.
So, we will present an implicit scheme for integrating N1, i.e.
in order to avoid the CFL limitation for advection.
Remark: the advection scheme used in implicit mode in
WWM is the residual distribution scheme PSI.
II. MPI
parallelization
MPI parallelization I
The parallelization of geophysical models is usually done by
using the Mesage Passing Interface MPI formalism.
The set of computational nodes of the model is thus split into
a number of different subdomains.
in MPI the exchanges are explicit. The explicit way of doing it
is via:
CALL MPI_SEND(ArrSend,len,dest,tag,comm,ierr)
CALL MPI_RECV(ArrRecv,len,orig,tag,comm,istat,ierr)
Those operations are blocking, i.e. the program waits until all
sends and recvs have been processed.
This means that all exchanges are processed by the order in
which they are stated.
It is generally better to decrease the total number of
exchanges in order to get better performance.
MPI parallelization II
In order to avoid strictly ordained exchanges, the strategy is
to do asynchrone exchanges.
The procedure is done in the following way
DO iorig=1,nproc
CALL MPI_IRECV(U,1,type(iorig), iorig-1, tag,
comm, rqst(iorig), ierr)
END DO
CALL MPI_WAITALL(nproc,rqst, stat, ierr)
and similarly for send operations.
The idea is the following: the array type(iorig) contains
the list of positions at which the received data needs to be
put. Commands for creating such types are for example
mpi create indexed block.
By using the above the order of the exchanges is no longer
determined by the MPI program which makes it faster but
harder to debug.
II. Iterative solution
methods
Iterative solution methods
In order to resolve linear system Ax = b for typical geophysical
situation we have matrices of size N × N with N about 100000
We cannot use direct methods like Gauss elimination or LU
and so we need to use iterative methods.
For a matrix A and a vector b the Krylov space Kn(A, b) is
Kn(A, b) = Vect b, Ab, . . . , An−1
b
The Generalized Minimal Residual Method (GMRES) takes
the best solution in Kn(A, b) of Ax = b.
It is stable but it requires the storing of n vectors, which is
memory intensive.
So, in order to have a good solution strategy we need a
method with minimal storage requirement.
The conjugate gradient method
If the matrix A is positive definite, then the conjugate
gradient method can be used:
« J.W. Shewchuk, An Introduction to the Conjugate Gradient
Method Without the Agonizing Pain Edition 11
4
If the system is N dimensional then N iteration suffices.
After i iterations, the residual error ei satisfies
ei ≤ 2
√
κ − 1
√
κ + 1
i
e 0 with κ =
λmax
λmin
Operations depends on computing Ax for some vectors x.
For non-symmetric problems, the technique is to use the
biconjugate gradient stabilized (BCGS) which works similarly.
Preconditioners
The convergence of the conjugate gradient depends on κ that
is on how far A is from the identity matrix.
If κ is large, i.e. A is ill conditioned then the number of
iterations will be very large.
We may accept that but then the whole solution strategy
becomes very similar to an explicit scheme.
The idea is to find a matrix K for which we can compute the
inverse easily.
K must similar to A, i.e. share the same property as A.
In order to apply the BCGS we need to compute Ax and
K−1x for some vectors x.
Example: Jacobi preconditioning is to take the diagonal
entries of A.
Preconditioners for advection
The essential aspect of advection is that it moves things so
Jacobi preconditioner will not work.
Instead partial factorization techniques have to be used
We write A = D + E + F with D diagonal E lower triangular
and F upper triangular.
The Successive Over Relaxation (SOR) preconditioner is to say
A = (I + ED−1
)(D + F) + R with R = −ED−1
F
The incomplete LU factorization (ILU0) is to say
Aij = (LU)ij for Aij = 0
with L and U having the same sparsity as A.
Both methods are efficient because they both are of the form
K = LU.
So, when solving Kx = b we do
x = L−1
b and x = U−1
x ,
i.e. the solution propagates.
II. Parallelizing
solvers
Parallelizing solvers
Suppose we have to solve Lx = b and let us assume the
diagonal is 1.



x1 = b1
l2,1x1 + x2 = b2
...
...
...
lN,1x1 + · · · + lN,N−1xN−1 + xN = bN
So, we first determine x1 then x2 and finally xN.
Parallelization is impossible if all Lij are non-zeros because
data from one processor
What save us is sparsity because the matrices are of the
following type:
f (x)v =
v ∼v
Cv,v xv
with v ∼ v mean that v and v are adjacent nodes.
Ordering nodes
All incomplete factorizations depend on the ordering of the
nodes.
We are free to choose the ordering that suits us best and by
doing so we change the preconditioner LU.
Since the iterative solution algorithms return approximate
solutions this means that the approximate solutions depend on
the partitioning and also on the number of processors.
The situation is the following:
Colored domains The L matrix
Coloring theory
A graph G is formed by a set V of vertices and a set E of
pairs of vertices named edges.
A coloring with N colors is a function f : V → {1, . . . , N}
such that for any edge e = (a, b) we have f (a) = f (b).
The chromatic number χ(G) is the minimum number of
colors needed to color.
It is known that χ(G) ≤ 4 for G a planar graph (Appel,
Haken, 1976).
Unfortunately, the subdomains given by parmetis are not
necessarily connected and so the graph is not necessarily
planar.
But in practice we can expect that the chromatic number is
rarely above 5.
Using colorings to solve Kx = b
Suppose that we managed to color with c colors
1. The indexing is done
1.1 First index the nodes in domains of color 1 by 1, 2, . . . , n1
1.2 Then the nodes of color 2 by n1 + 1, n1 + 2, . . . , n1 + n2.
1.3 .... until color c.
2. The solution of Lx = b is then done by
2.1 Solving Lx = b on the nodes of color 1.
2.2 Nodes of color 1 send data to nodes of higher color.
2.3 Solve Lx = b on the nodes of color 2.
2.4 Continue ...
3. The solution of Uy = x is then done in reverse.
Efficiency of preconditioners
There is no general theory on the efficiency of preconditioners.
The bad news is that the ordering of the nodes has an effect
on the performance of the preconditioner.
The worst ordering for κ is the red-back ordering in finite
difference schemes. The best is the linear ordering.
1 2
3 4
5 6
7 8
9 10
11 12
Red Black
1 7
11
3 9
4 10
2 8
6 12
5
Linear Ordering
So, the best ordering for the quality of the preconditioner is
the one that is hardest to parallelize.
The ordering that we used is somewhat intermediate. It is like
red-black globally, but over individual subdomains it is linear.
II. Solution
for wave models
Organizing the computation
1. The penalty of parallelizing come in two ways:
1.1 The preconditioner quality that decreases.
1.2 The cost of waiting for data is c.
2. If we have Nfreq frequencies and Ndir directions then this
makes Ntot = Nfreq × Ndir independent linear systems to solve.
3. The strategy is then to split Ntot into b blocks B1, . . . , Bb
3.1 After domains of color 1 have finished block B1 data is sent
and block B2 is solved.
3.2 So domains of color 2 can start working before the ones of
color 1 are finished.
4. So, by using say b = 5 we can essentially remove the second
cost.
Further work
1. The work done so far is for the SOR preconditioner.
2. We need to test the ILU0 preconditioner, it is harder to
compute but the same strategy can be applied.
3. Another possibility is to integrate implicitly the advection in
geographical, frequency and direction.
This requires an ordering of the Nnode × Nfreq × Ndir matrix
entries but by doing so we can diminish the splitting error.
4. And overall improve the speed.
THANK YOU
Ad

More Related Content

What's hot (20)

Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Taiji Suzuki
 
Matlab Assignment Help
Matlab Assignment HelpMatlab Assignment Help
Matlab Assignment Help
Matlab Assignment Experts
 
Neural Networks - How do they work?
Neural Networks - How do they work?Neural Networks - How do they work?
Neural Networks - How do they work?
Accubits Technologies
 
Jere Koskela slides
Jere Koskela slidesJere Koskela slides
Jere Koskela slides
Christian Robert
 
Csr2011 june14 15_45_musatov
Csr2011 june14 15_45_musatovCsr2011 june14 15_45_musatov
Csr2011 june14 15_45_musatov
CSR2011
 
QMC: Transition Workshop - Density Estimation by Randomized Quasi-Monte Carlo...
QMC: Transition Workshop - Density Estimation by Randomized Quasi-Monte Carlo...QMC: Transition Workshop - Density Estimation by Randomized Quasi-Monte Carlo...
QMC: Transition Workshop - Density Estimation by Randomized Quasi-Monte Carlo...
The Statistical and Applied Mathematical Sciences Institute
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
ENBIS 2018 presentation on Deep k-Means
ENBIS 2018 presentation on Deep k-MeansENBIS 2018 presentation on Deep k-Means
ENBIS 2018 presentation on Deep k-Means
tthonet
 
Fdtd
FdtdFdtd
Fdtd
Gopi Saiteja
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
Diffusion Homework Help
Diffusion Homework HelpDiffusion Homework Help
Diffusion Homework Help
Statistics Assignment Help
 
Fdtd ppt for mine
Fdtd ppt   for mineFdtd ppt   for mine
Fdtd ppt for mine
AnimikhGoswami
 
Pydata Katya Vasilaky
Pydata Katya VasilakyPydata Katya Vasilaky
Pydata Katya Vasilaky
knv4
 
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithmno U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
Christian Robert
 
Chris Sherlock's slides
Chris Sherlock's slidesChris Sherlock's slides
Chris Sherlock's slides
Christian Robert
 
Digital Signal Processing[ECEG-3171]-Ch1_L02
Digital Signal Processing[ECEG-3171]-Ch1_L02Digital Signal Processing[ECEG-3171]-Ch1_L02
Digital Signal Processing[ECEG-3171]-Ch1_L02
Rediet Moges
 
Macrocanonical models for texture synthesis
Macrocanonical models for texture synthesisMacrocanonical models for texture synthesis
Macrocanonical models for texture synthesis
Valentin De Bortoli
 
Richard Everitt's slides
Richard Everitt's slidesRichard Everitt's slides
Richard Everitt's slides
Christian Robert
 
Digital Signal Processing[ECEG-3171]-Ch1_L03
Digital Signal Processing[ECEG-3171]-Ch1_L03Digital Signal Processing[ECEG-3171]-Ch1_L03
Digital Signal Processing[ECEG-3171]-Ch1_L03
Rediet Moges
 
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
Program on Quasi-Monte Carlo and High-Dimensional Sampling Methods for Applie...
The Statistical and Applied Mathematical Sciences Institute
 
Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Minimax optimal alternating minimization \\ for kernel nonparametric tensor l...
Taiji Suzuki
 
Csr2011 june14 15_45_musatov
Csr2011 june14 15_45_musatovCsr2011 june14 15_45_musatov
Csr2011 june14 15_45_musatov
CSR2011
 
ENBIS 2018 presentation on Deep k-Means
ENBIS 2018 presentation on Deep k-MeansENBIS 2018 presentation on Deep k-Means
ENBIS 2018 presentation on Deep k-Means
tthonet
 
Pydata Katya Vasilaky
Pydata Katya VasilakyPydata Katya Vasilaky
Pydata Katya Vasilaky
knv4
 
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithmno U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
no U-turn sampler, a discussion of Hoffman & Gelman NUTS algorithm
Christian Robert
 
Digital Signal Processing[ECEG-3171]-Ch1_L02
Digital Signal Processing[ECEG-3171]-Ch1_L02Digital Signal Processing[ECEG-3171]-Ch1_L02
Digital Signal Processing[ECEG-3171]-Ch1_L02
Rediet Moges
 
Macrocanonical models for texture synthesis
Macrocanonical models for texture synthesisMacrocanonical models for texture synthesis
Macrocanonical models for texture synthesis
Valentin De Bortoli
 
Digital Signal Processing[ECEG-3171]-Ch1_L03
Digital Signal Processing[ECEG-3171]-Ch1_L03Digital Signal Processing[ECEG-3171]-Ch1_L03
Digital Signal Processing[ECEG-3171]-Ch1_L03
Rediet Moges
 

Similar to Implicit schemes for wave models (20)

Conjugate Gradient Methods
Conjugate Gradient MethodsConjugate Gradient Methods
Conjugate Gradient Methods
MTiti1
 
project final
project finalproject final
project final
Rian Rustvold
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
Alexander Litvinenko
 
Three Different Algorithms for GeneratingUniformly Distribut.docx
Three Different Algorithms for GeneratingUniformly Distribut.docxThree Different Algorithms for GeneratingUniformly Distribut.docx
Three Different Algorithms for GeneratingUniformly Distribut.docx
herthalearmont
 
Networking Assignment Help
Networking Assignment HelpNetworking Assignment Help
Networking Assignment Help
Computer Network Assignment Help
 
Advanced Modularity Optimization Assignment Help
Advanced Modularity Optimization Assignment HelpAdvanced Modularity Optimization Assignment Help
Advanced Modularity Optimization Assignment Help
Computer Network Assignment Help
 
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUEDYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
ssusered62011
 
Stochastic Processes Assignment Help
Stochastic Processes Assignment HelpStochastic Processes Assignment Help
Stochastic Processes Assignment Help
Statistics Assignment Help
 
Modeling the dynamics of molecular concentration during the diffusion procedure
Modeling the dynamics of molecular concentration during the  diffusion procedureModeling the dynamics of molecular concentration during the  diffusion procedure
Modeling the dynamics of molecular concentration during the diffusion procedure
International Journal of Engineering Inventions www.ijeijournal.com
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
Maths Assignment Help
 
kcde
kcdekcde
kcde
CNP Slagle
 
This is related to numberical method, in engineering college
This is related to numberical method, in engineering collegeThis is related to numberical method, in engineering college
This is related to numberical method, in engineering college
AbhishekNishad31
 
introduction to numerical analysis .ppt
introduction to numerical analysis  .pptintroduction to numerical analysis  .ppt
introduction to numerical analysis .ppt
ahmedhussein561
 
numerical.ppt
numerical.pptnumerical.ppt
numerical.ppt
SuyashPatil72
 
Cdc18 dg lee
Cdc18 dg leeCdc18 dg lee
Cdc18 dg lee
whatthehellisit
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
Math Homework Solver
 
Visualization of general defined space data
Visualization of general defined space dataVisualization of general defined space data
Visualization of general defined space data
ijcga
 
Network Design Assignment Help
Network Design Assignment HelpNetwork Design Assignment Help
Network Design Assignment Help
Computer Network Assignment Help
 
머피의 머신러닝: 17장 Markov Chain and HMM
머피의 머신러닝: 17장  Markov Chain and HMM머피의 머신러닝: 17장  Markov Chain and HMM
머피의 머신러닝: 17장 Markov Chain and HMM
Jungkyu Lee
 
machinelearning project
machinelearning projectmachinelearning project
machinelearning project
Lianli Liu
 
Conjugate Gradient Methods
Conjugate Gradient MethodsConjugate Gradient Methods
Conjugate Gradient Methods
MTiti1
 
Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...Hierarchical matrices for approximating large covariance matries and computin...
Hierarchical matrices for approximating large covariance matries and computin...
Alexander Litvinenko
 
Three Different Algorithms for GeneratingUniformly Distribut.docx
Three Different Algorithms for GeneratingUniformly Distribut.docxThree Different Algorithms for GeneratingUniformly Distribut.docx
Three Different Algorithms for GeneratingUniformly Distribut.docx
herthalearmont
 
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUEDYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
DYNAMIC PROGRAMMING AND GREEDY TECHNIQUE
ssusered62011
 
This is related to numberical method, in engineering college
This is related to numberical method, in engineering collegeThis is related to numberical method, in engineering college
This is related to numberical method, in engineering college
AbhishekNishad31
 
introduction to numerical analysis .ppt
introduction to numerical analysis  .pptintroduction to numerical analysis  .ppt
introduction to numerical analysis .ppt
ahmedhussein561
 
Numerical Analysis Assignment Help
Numerical Analysis Assignment HelpNumerical Analysis Assignment Help
Numerical Analysis Assignment Help
Math Homework Solver
 
Visualization of general defined space data
Visualization of general defined space dataVisualization of general defined space data
Visualization of general defined space data
ijcga
 
머피의 머신러닝: 17장 Markov Chain and HMM
머피의 머신러닝: 17장  Markov Chain and HMM머피의 머신러닝: 17장  Markov Chain and HMM
머피의 머신러닝: 17장 Markov Chain and HMM
Jungkyu Lee
 
machinelearning project
machinelearning projectmachinelearning project
machinelearning project
Lianli Liu
 
Ad

More from Mathieu Dutour Sikiric (13)

Practical computation of Hecke operators
Practical computation of Hecke operatorsPractical computation of Hecke operators
Practical computation of Hecke operators
Mathieu Dutour Sikiric
 
Crystallographic groups
Crystallographic groupsCrystallographic groups
Crystallographic groups
Mathieu Dutour Sikiric
 
Face-regular two-maps
Face-regular two-mapsFace-regular two-maps
Face-regular two-maps
Mathieu Dutour Sikiric
 
Spheric analogs of fullerenes
Spheric analogs of fullerenesSpheric analogs of fullerenes
Spheric analogs of fullerenes
Mathieu Dutour Sikiric
 
Polycycles and their elementary decompositions
Polycycles and their elementary decompositionsPolycycles and their elementary decompositions
Polycycles and their elementary decompositions
Mathieu Dutour Sikiric
 
Wythoff construction and l1-embedding
Wythoff construction and l1-embeddingWythoff construction and l1-embedding
Wythoff construction and l1-embedding
Mathieu Dutour Sikiric
 
Space fullerenes: A computer search of new Frank-Kasper structures
Space fullerenes: A computer search of new Frank-Kasper structuresSpace fullerenes: A computer search of new Frank-Kasper structures
Space fullerenes: A computer search of new Frank-Kasper structures
Mathieu Dutour Sikiric
 
Lego like spheres and tori, enumeration and drawings
Lego like spheres and tori, enumeration and drawingsLego like spheres and tori, enumeration and drawings
Lego like spheres and tori, enumeration and drawings
Mathieu Dutour Sikiric
 
Bathymetry smoothing in ROMS: A new approach
Bathymetry smoothing in ROMS: A new approachBathymetry smoothing in ROMS: A new approach
Bathymetry smoothing in ROMS: A new approach
Mathieu Dutour Sikiric
 
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane mapsGoldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Mathieu Dutour Sikiric
 
Fullerenes: applications and generalizations
Fullerenes: applications and generalizationsFullerenes: applications and generalizations
Fullerenes: applications and generalizations
Mathieu Dutour Sikiric
 
Exhaustive Combinatorial Enumeration
Exhaustive Combinatorial EnumerationExhaustive Combinatorial Enumeration
Exhaustive Combinatorial Enumeration
Mathieu Dutour Sikiric
 
Lattice coverings
Lattice coveringsLattice coverings
Lattice coverings
Mathieu Dutour Sikiric
 
Practical computation of Hecke operators
Practical computation of Hecke operatorsPractical computation of Hecke operators
Practical computation of Hecke operators
Mathieu Dutour Sikiric
 
Polycycles and their elementary decompositions
Polycycles and their elementary decompositionsPolycycles and their elementary decompositions
Polycycles and their elementary decompositions
Mathieu Dutour Sikiric
 
Space fullerenes: A computer search of new Frank-Kasper structures
Space fullerenes: A computer search of new Frank-Kasper structuresSpace fullerenes: A computer search of new Frank-Kasper structures
Space fullerenes: A computer search of new Frank-Kasper structures
Mathieu Dutour Sikiric
 
Lego like spheres and tori, enumeration and drawings
Lego like spheres and tori, enumeration and drawingsLego like spheres and tori, enumeration and drawings
Lego like spheres and tori, enumeration and drawings
Mathieu Dutour Sikiric
 
Bathymetry smoothing in ROMS: A new approach
Bathymetry smoothing in ROMS: A new approachBathymetry smoothing in ROMS: A new approach
Bathymetry smoothing in ROMS: A new approach
Mathieu Dutour Sikiric
 
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane mapsGoldberg-Coxeter construction for 3- or 4-valent plane maps
Goldberg-Coxeter construction for 3- or 4-valent plane maps
Mathieu Dutour Sikiric
 
Fullerenes: applications and generalizations
Fullerenes: applications and generalizationsFullerenes: applications and generalizations
Fullerenes: applications and generalizations
Mathieu Dutour Sikiric
 
Ad

Recently uploaded (20)

Carboxylic-Acid-Derivatives.lecture.presentation
Carboxylic-Acid-Derivatives.lecture.presentationCarboxylic-Acid-Derivatives.lecture.presentation
Carboxylic-Acid-Derivatives.lecture.presentation
GLAEXISAJULGA
 
Water Pollution control using microorganisms
Water Pollution control using microorganismsWater Pollution control using microorganisms
Water Pollution control using microorganisms
gerefam247
 
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Professional Content Writing's
 
Funakoshi_ZymoResearch_2024-2025_catalog
Funakoshi_ZymoResearch_2024-2025_catalogFunakoshi_ZymoResearch_2024-2025_catalog
Funakoshi_ZymoResearch_2024-2025_catalog
fu7koshi
 
Mycology:Characteristics of Ascomycetes Fungi
Mycology:Characteristics of Ascomycetes FungiMycology:Characteristics of Ascomycetes Fungi
Mycology:Characteristics of Ascomycetes Fungi
SAYANTANMALLICK5
 
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptxSiver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
PriyaAntil3
 
Reticular formation_groups_organization_
Reticular formation_groups_organization_Reticular formation_groups_organization_
Reticular formation_groups_organization_
klynct
 
Preclinical Advances in Nuclear Neurology.pptx
Preclinical Advances in Nuclear Neurology.pptxPreclinical Advances in Nuclear Neurology.pptx
Preclinical Advances in Nuclear Neurology.pptx
MahitaLaveti
 
Introduction to Black Hole and how its formed
Introduction to Black Hole and how its formedIntroduction to Black Hole and how its formed
Introduction to Black Hole and how its formed
MSafiullahALawi
 
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptxCleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
zainab98aug
 
Hypothalamus_structure_nuclei_ functions.pptx
Hypothalamus_structure_nuclei_ functions.pptxHypothalamus_structure_nuclei_ functions.pptx
Hypothalamus_structure_nuclei_ functions.pptx
klynct
 
Proprioceptors_ receptors of muscle_tendon
Proprioceptors_ receptors of muscle_tendonProprioceptors_ receptors of muscle_tendon
Proprioceptors_ receptors of muscle_tendon
klynct
 
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Professional Content Writing's
 
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.pptSULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
HRUTUJA WAGH
 
Somato_Sensory _ somatomotor_Nervous_System.pptx
Somato_Sensory _ somatomotor_Nervous_System.pptxSomato_Sensory _ somatomotor_Nervous_System.pptx
Somato_Sensory _ somatomotor_Nervous_System.pptx
klynct
 
ICAI OpenGov Lab: A Quick Introduction | AI for Open Government
ICAI OpenGov Lab: A Quick Introduction | AI for Open GovernmentICAI OpenGov Lab: A Quick Introduction | AI for Open Government
ICAI OpenGov Lab: A Quick Introduction | AI for Open Government
David Graus
 
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
Sérgio Sacani
 
Applications of Radioisotopes in Cancer Research.pptx
Applications of Radioisotopes in Cancer Research.pptxApplications of Radioisotopes in Cancer Research.pptx
Applications of Radioisotopes in Cancer Research.pptx
MahitaLaveti
 
Animal Models for Biological and Clinical Research ppt 2.pptx
Animal Models for Biological and Clinical Research ppt 2.pptxAnimal Models for Biological and Clinical Research ppt 2.pptx
Animal Models for Biological and Clinical Research ppt 2.pptx
MahitaLaveti
 
Fatigue and its management in aviation medicine
Fatigue and its management in aviation medicineFatigue and its management in aviation medicine
Fatigue and its management in aviation medicine
ImranJewel2
 
Carboxylic-Acid-Derivatives.lecture.presentation
Carboxylic-Acid-Derivatives.lecture.presentationCarboxylic-Acid-Derivatives.lecture.presentation
Carboxylic-Acid-Derivatives.lecture.presentation
GLAEXISAJULGA
 
Water Pollution control using microorganisms
Water Pollution control using microorganismsWater Pollution control using microorganisms
Water Pollution control using microorganisms
gerefam247
 
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Chemistry of Warfare (Chemical weapons in warfare: An in-depth analysis of cl...
Professional Content Writing's
 
Funakoshi_ZymoResearch_2024-2025_catalog
Funakoshi_ZymoResearch_2024-2025_catalogFunakoshi_ZymoResearch_2024-2025_catalog
Funakoshi_ZymoResearch_2024-2025_catalog
fu7koshi
 
Mycology:Characteristics of Ascomycetes Fungi
Mycology:Characteristics of Ascomycetes FungiMycology:Characteristics of Ascomycetes Fungi
Mycology:Characteristics of Ascomycetes Fungi
SAYANTANMALLICK5
 
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptxSiver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
Siver Nanoparticles syntheisis, mechanism, Antibacterial activity.pptx
PriyaAntil3
 
Reticular formation_groups_organization_
Reticular formation_groups_organization_Reticular formation_groups_organization_
Reticular formation_groups_organization_
klynct
 
Preclinical Advances in Nuclear Neurology.pptx
Preclinical Advances in Nuclear Neurology.pptxPreclinical Advances in Nuclear Neurology.pptx
Preclinical Advances in Nuclear Neurology.pptx
MahitaLaveti
 
Introduction to Black Hole and how its formed
Introduction to Black Hole and how its formedIntroduction to Black Hole and how its formed
Introduction to Black Hole and how its formed
MSafiullahALawi
 
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptxCleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
Cleaned_Expanded_Metal_Nanoparticles_Presentation.pptx
zainab98aug
 
Hypothalamus_structure_nuclei_ functions.pptx
Hypothalamus_structure_nuclei_ functions.pptxHypothalamus_structure_nuclei_ functions.pptx
Hypothalamus_structure_nuclei_ functions.pptx
klynct
 
Proprioceptors_ receptors of muscle_tendon
Proprioceptors_ receptors of muscle_tendonProprioceptors_ receptors of muscle_tendon
Proprioceptors_ receptors of muscle_tendon
klynct
 
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Discrete choice experiments: Environmental Improvements to Airthrey Loch Lake...
Professional Content Writing's
 
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.pptSULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
SULPHONAMIDES AND SULFONES Medicinal Chemistry III.ppt
HRUTUJA WAGH
 
Somato_Sensory _ somatomotor_Nervous_System.pptx
Somato_Sensory _ somatomotor_Nervous_System.pptxSomato_Sensory _ somatomotor_Nervous_System.pptx
Somato_Sensory _ somatomotor_Nervous_System.pptx
klynct
 
ICAI OpenGov Lab: A Quick Introduction | AI for Open Government
ICAI OpenGov Lab: A Quick Introduction | AI for Open GovernmentICAI OpenGov Lab: A Quick Introduction | AI for Open Government
ICAI OpenGov Lab: A Quick Introduction | AI for Open Government
David Graus
 
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
A Massive Black Hole 0.8kpc from the Host Nucleus Revealed by the Offset Tida...
Sérgio Sacani
 
Applications of Radioisotopes in Cancer Research.pptx
Applications of Radioisotopes in Cancer Research.pptxApplications of Radioisotopes in Cancer Research.pptx
Applications of Radioisotopes in Cancer Research.pptx
MahitaLaveti
 
Animal Models for Biological and Clinical Research ppt 2.pptx
Animal Models for Biological and Clinical Research ppt 2.pptxAnimal Models for Biological and Clinical Research ppt 2.pptx
Animal Models for Biological and Clinical Research ppt 2.pptx
MahitaLaveti
 
Fatigue and its management in aviation medicine
Fatigue and its management in aviation medicineFatigue and its management in aviation medicine
Fatigue and its management in aviation medicine
ImranJewel2
 

Implicit schemes for wave models

  • 1. Implicit schemes for wave models Mathieu Dutour Sikiri´c Rudjer Bo˘skovi´c Institute, Croatia and Universit¨at Rostock November 24, 2017
  • 3. Stochastic wave modelling Oceanic models are using grids (structured or unstructured) of size 1km ≤ d ≤ 10km to simulate the ocean But oceanic waves have a typical wavelength 2m ≤ L ≤ 100m. So, we cannot resolve waves in the ocean. But if one uses phase averaged models and uses stochastic assumptions then it is possible to model waves by a spectral wave action density N(x, k) This density satisfies a Wave Action Equation (WAE) which represents advection, refraction, frequency shifting and source terms: ∂N ∂t + x ((cg + uA)N) + k( ˙kN) + θ( ˙θN) = Stot with Stot = Sin + Snl3 + Snl4 + Sbot + Sds + Sbreak + Sbf
  • 4. The WWM model The Wind Wave Model (WWM) is a unstructured grid spectral wave model. It is comparable to WaveWatch III, SWAN, WAM or SWAVE. It incorporates most existing source term formulation for wind input and dissipation (Cycle III, Cycle IV, Ardhuin, Makin, ...) It has been coupled to SELFE, SHYFEM, TIMOR and ROMS. It uses Residual Distribution schemes for the horizontal advection. It integrates the WAE by using the Operator Splitting Method in explicit or implicit mode.
  • 5. Operator Splitting Method A standard technique for integrating partial differential equations is the operator splitting method. Over the interval [t0, t1] we successively solve the equations    ∂N1 ∂t + θ( ˙θN1) = 0 with N1(t0) = N(t0) ∂N2 ∂t + k( ˙kN2) = 0 with N2(t0) = N1(t1) ∂N3 ∂t + x ((cg + uA)N3) = 0 with N3(t0) = N2(t1) ∂N4 ∂t = S(t) with N4(t0) = N3(t1) and we set N(t1) = N4(t1). No matter what the order of the successive integration schemes is the final order will be 1. It it is possible to have higher order by more complex integration procedures (Strang splitting, iterative splitting, etc.)
  • 6. The CFL criterion If the discretization has characteristic length l and the physical speed is c then we have the condition c∆t l ≤ 1 For the integration of the frequency and directional equations we can subdivide the integration time step if necessary because everything is decoupled. This is not possible for the geographical advection: The dependency in direction/frequency is small or negligible The problem is that the group speed is √ gh and so the CFL number varies with the depth and the resolution. So, we will present an implicit scheme for integrating N1, i.e. in order to avoid the CFL limitation for advection. Remark: the advection scheme used in implicit mode in WWM is the residual distribution scheme PSI.
  • 8. MPI parallelization I The parallelization of geophysical models is usually done by using the Mesage Passing Interface MPI formalism. The set of computational nodes of the model is thus split into a number of different subdomains. in MPI the exchanges are explicit. The explicit way of doing it is via: CALL MPI_SEND(ArrSend,len,dest,tag,comm,ierr) CALL MPI_RECV(ArrRecv,len,orig,tag,comm,istat,ierr) Those operations are blocking, i.e. the program waits until all sends and recvs have been processed. This means that all exchanges are processed by the order in which they are stated. It is generally better to decrease the total number of exchanges in order to get better performance.
  • 9. MPI parallelization II In order to avoid strictly ordained exchanges, the strategy is to do asynchrone exchanges. The procedure is done in the following way DO iorig=1,nproc CALL MPI_IRECV(U,1,type(iorig), iorig-1, tag, comm, rqst(iorig), ierr) END DO CALL MPI_WAITALL(nproc,rqst, stat, ierr) and similarly for send operations. The idea is the following: the array type(iorig) contains the list of positions at which the received data needs to be put. Commands for creating such types are for example mpi create indexed block. By using the above the order of the exchanges is no longer determined by the MPI program which makes it faster but harder to debug.
  • 11. Iterative solution methods In order to resolve linear system Ax = b for typical geophysical situation we have matrices of size N × N with N about 100000 We cannot use direct methods like Gauss elimination or LU and so we need to use iterative methods. For a matrix A and a vector b the Krylov space Kn(A, b) is Kn(A, b) = Vect b, Ab, . . . , An−1 b The Generalized Minimal Residual Method (GMRES) takes the best solution in Kn(A, b) of Ax = b. It is stable but it requires the storing of n vectors, which is memory intensive. So, in order to have a good solution strategy we need a method with minimal storage requirement.
  • 12. The conjugate gradient method If the matrix A is positive definite, then the conjugate gradient method can be used: « J.W. Shewchuk, An Introduction to the Conjugate Gradient Method Without the Agonizing Pain Edition 11 4 If the system is N dimensional then N iteration suffices. After i iterations, the residual error ei satisfies ei ≤ 2 √ κ − 1 √ κ + 1 i e 0 with κ = λmax λmin Operations depends on computing Ax for some vectors x. For non-symmetric problems, the technique is to use the biconjugate gradient stabilized (BCGS) which works similarly.
  • 13. Preconditioners The convergence of the conjugate gradient depends on κ that is on how far A is from the identity matrix. If κ is large, i.e. A is ill conditioned then the number of iterations will be very large. We may accept that but then the whole solution strategy becomes very similar to an explicit scheme. The idea is to find a matrix K for which we can compute the inverse easily. K must similar to A, i.e. share the same property as A. In order to apply the BCGS we need to compute Ax and K−1x for some vectors x. Example: Jacobi preconditioning is to take the diagonal entries of A.
  • 14. Preconditioners for advection The essential aspect of advection is that it moves things so Jacobi preconditioner will not work. Instead partial factorization techniques have to be used We write A = D + E + F with D diagonal E lower triangular and F upper triangular. The Successive Over Relaxation (SOR) preconditioner is to say A = (I + ED−1 )(D + F) + R with R = −ED−1 F The incomplete LU factorization (ILU0) is to say Aij = (LU)ij for Aij = 0 with L and U having the same sparsity as A. Both methods are efficient because they both are of the form K = LU. So, when solving Kx = b we do x = L−1 b and x = U−1 x , i.e. the solution propagates.
  • 16. Parallelizing solvers Suppose we have to solve Lx = b and let us assume the diagonal is 1.    x1 = b1 l2,1x1 + x2 = b2 ... ... ... lN,1x1 + · · · + lN,N−1xN−1 + xN = bN So, we first determine x1 then x2 and finally xN. Parallelization is impossible if all Lij are non-zeros because data from one processor What save us is sparsity because the matrices are of the following type: f (x)v = v ∼v Cv,v xv with v ∼ v mean that v and v are adjacent nodes.
  • 17. Ordering nodes All incomplete factorizations depend on the ordering of the nodes. We are free to choose the ordering that suits us best and by doing so we change the preconditioner LU. Since the iterative solution algorithms return approximate solutions this means that the approximate solutions depend on the partitioning and also on the number of processors. The situation is the following: Colored domains The L matrix
  • 18. Coloring theory A graph G is formed by a set V of vertices and a set E of pairs of vertices named edges. A coloring with N colors is a function f : V → {1, . . . , N} such that for any edge e = (a, b) we have f (a) = f (b). The chromatic number χ(G) is the minimum number of colors needed to color. It is known that χ(G) ≤ 4 for G a planar graph (Appel, Haken, 1976). Unfortunately, the subdomains given by parmetis are not necessarily connected and so the graph is not necessarily planar. But in practice we can expect that the chromatic number is rarely above 5.
  • 19. Using colorings to solve Kx = b Suppose that we managed to color with c colors 1. The indexing is done 1.1 First index the nodes in domains of color 1 by 1, 2, . . . , n1 1.2 Then the nodes of color 2 by n1 + 1, n1 + 2, . . . , n1 + n2. 1.3 .... until color c. 2. The solution of Lx = b is then done by 2.1 Solving Lx = b on the nodes of color 1. 2.2 Nodes of color 1 send data to nodes of higher color. 2.3 Solve Lx = b on the nodes of color 2. 2.4 Continue ... 3. The solution of Uy = x is then done in reverse.
  • 20. Efficiency of preconditioners There is no general theory on the efficiency of preconditioners. The bad news is that the ordering of the nodes has an effect on the performance of the preconditioner. The worst ordering for κ is the red-back ordering in finite difference schemes. The best is the linear ordering. 1 2 3 4 5 6 7 8 9 10 11 12 Red Black 1 7 11 3 9 4 10 2 8 6 12 5 Linear Ordering So, the best ordering for the quality of the preconditioner is the one that is hardest to parallelize. The ordering that we used is somewhat intermediate. It is like red-black globally, but over individual subdomains it is linear.
  • 22. Organizing the computation 1. The penalty of parallelizing come in two ways: 1.1 The preconditioner quality that decreases. 1.2 The cost of waiting for data is c. 2. If we have Nfreq frequencies and Ndir directions then this makes Ntot = Nfreq × Ndir independent linear systems to solve. 3. The strategy is then to split Ntot into b blocks B1, . . . , Bb 3.1 After domains of color 1 have finished block B1 data is sent and block B2 is solved. 3.2 So domains of color 2 can start working before the ones of color 1 are finished. 4. So, by using say b = 5 we can essentially remove the second cost.
  • 23. Further work 1. The work done so far is for the SOR preconditioner. 2. We need to test the ILU0 preconditioner, it is harder to compute but the same strategy can be applied. 3. Another possibility is to integrate implicitly the advection in geographical, frequency and direction. This requires an ordering of the Nnode × Nfreq × Ndir matrix entries but by doing so we can diminish the splitting error. 4. And overall improve the speed. THANK YOU
  翻译: