SlideShare a Scribd company logo
Center for Uncertainty
Quantification
Salinization of coastal aquifers under uncertainties
Alexander Litvinenko1
, Dmitry Logashenko2
, Raul Tempone1,2
, Ekaterina Vasilyeva2
, Gabriel Wittum2
1
RWTH Aachen, Germany, 2
KAUST, Saudi Arabia
litvinenko@uq.rwth-aachen.de
Center for Uncertainty
Quantification
Center for Uncertainty
Quantification
Abstract
Problem: Henry saltwater intrusion (nonlinear and time-dependent, describes a two-phase
subsurface flow)
Input uncertainty: porosity, permeability, and recharge (model by random fields)
Solution: the salt mass fraction (uncertain and time-dependent)
Method: Multi Level Monte Carlo (MLMC) method
Deterministic solver: parallel multigrid solver ug4
Questions:
1. How long can wells be used?
2. Where is the largest uncertainty?
3. Freshwater exceed. probabil.?
4. What is the mean scenario and its
variations?
5. What are the extreme scenarios?
6. How do the uncertainties change
over time?
Figure 1: Henry problem, taken from https://www.mdpi.com/2073-4441/10/2/230
1. Henry problem settings
The mass conservation laws for the entire liquid phase and salt yield the following equations
∂t(ϕρ) + ∇ · (ρq) = 0,
∂t(ϕρc) + ∇ · (ρcq − ρD∇c) = 0,
where ϕ(x, ξ) is porosity, x ∈ D, is determined by a set of RVs ξ = (ξ1, . . . , ξM, ...).
c(t, x) mass fraction of the salt, ρ = ρ(c) density of the liquid phase, and D(t, x) molecular
diffusion tensor.
For q(t, x) velocity, we assume Darcy’s law:
q = −
K
µ
(∇p − ρg),
where p = p(t, x) is the hydrostatic pressure, K permeability, µ = µ(c) viscosity of the liquid
phase, and g gravity. To compute: c and p.
Comput. domain: D × [0, T]. We set ρ(c) = ρ0 + (ρ1 − ρ0)c, and D = ϕDI,
I.C.: c|t=0 = 0, B.C.: c|x=2 = 1, p|x=2 = −ρ1gy. c|x=0 = 0, ρq · ex|x=0 = q̂in.
We model the uncertain ϕ using a random field and assume: K = KI, K = K(ϕ).
Methods: Newton method, BiCGStab, preconditioned with the geometric multigrid method
(V-cycle), ILUβ-smoothers and Gaussian elimination.
2. Solution of the Henry problem
q̂in = 6.6 · 10−2
kg/s
c = 0 c = 1
p = −ρ1gy
0
−1 m
2 m
y
x
D := [0, 2] × [−1, 0]; a realization of c(t, x); ϕ(ξ∗
) ∈ [0.18, 0.59]; E [c] ∈ [0, 0.35]; Var[c] ∈ [0.0, 0.04]
QoIs: c in the whole domain, c at a point, or integral values (the freshwater/saltwater integrals):
QFW (t, ω) :=
R
x∈D I(c(t, x, ω) ≤ 0.012178)dx, Qs(t, ω) :=
R
x∈D c(t, x, ω)ρ(t, x, ω)dx
2.1 Multi Level Monte Carlo (MLMC) method
Spatial and temporal grid hierarchies D0, D1, . . . , DL, and T0, T1, . . . , TL; n0 = 512, nℓ ≈ n0 · 16ℓ
,
τℓ+1 = 1
4τℓ, rℓ+1 = 4rℓ and rℓ = r04ℓ
. Computation complexity is
sℓ = O(nℓrℓ) = O(43ℓγ
n0 · r0)
MLMC approximates E [gL] ≈ E [g] using the following telescopic sum:
E [gL] ≈ m−1
0
m0
X
i=1
g
(0,i)
0 +
L
X
ℓ=1
m−1
ℓ
mℓ
X
i=1
(g
(ℓ,i)
ℓ − g
(ℓ,i)
ℓ−1 )
!
.
Minimize F(m0, . . . , mL) :=
PL
ℓ=0 mℓsℓ + µ2 Vℓ
mℓ
, obtain mℓ = ε−2
q
Vℓ
sℓ
PL
i=0
√
Visi.
100 realizations of QFW (t); Evolution of the pdf of c(t, x), t = {3τ, . . . , 48τ}; pdf of the earliest
time point when c(t, x) < 0.9, x = (1.85, −0.95); mean values E [c(t, x9, y9)]; variances
Var[c](t, x9, y9) on levels 0,1,2,3.
E [gℓ − gℓ−1] (t, x9, y9); V [gℓ − gℓ−1] (t, x9, y9), ℓ = 1, 2, 3, QoI is the integral value over D9 ; 100 realisations of g1 − g0, g2 − g1, g3 − g2, QoI gℓ is the integral value
Qs(t, ω) computed over a subdomain around 9th point, t ∈ [τ, 48τ].
Level ℓ nℓ, ( nℓ
nℓ−1
) rℓ, ( rℓ
rℓ−1
) τℓ = 6016/rℓ
Computing times (sℓ), ( sℓ
sℓ−1
)
average min. max.
0 153 94 64 0.6 0.5 0.7
1 2145 (14) 376 (4) 16 7.1 (14) 6.9 8.7
2 33153 (15.5) 1504 (4) 4 252.9 (36) 246.2 266.2
3 525825 (15.9) 6016 (4) 1 11109.8 (44) 9858.4 15506.9
#ndofs nℓ, number of time steps rℓ, time step τℓ; average, minimal, and maximal computing times on each level ℓ.
ε2
0.1
total cost of MC, SMC 9.5e + 6
total cost of MLMC, S 4.25e + 4
{m0, m1, m2, m3} {7927, 946, 57, 2}
Comparison of MC and MLMC
ε2
m0 m1 m2 m3
1 73 8 1 0
0.5 290 32 3 0
0.1 7258 811 68 1
0.05 29031 3245 274 5
MLMC: number of samples on level ℓ
(1)Weak (α = −2) and (2)strong (β = −3.4) convergences, ℓ = 0, 1, 2, 3. QoI=local integral of c
over (x, y)9 = (1.65, −0.75)-subdomain; (3) decay of absolute and (4) relative errors between
the mean values computed on a fine mesh via MC and via MLMC at (t, x, y) = (12, 1.60, −0.95).
Acknowledgements: KAUST HPC and the Alexander von Humboldt foundation.
1. A. Litvinenko, D. Logashenko, R. Tempone, E. Vasilyeva, G. Wittum, Uncertainty quantification in coastal aquifers using the multilevel Monte Carlo method,
arXiv:2302.07804, 2023
2. A. Litvinenko, D. Logashenko, R. Tempone, G. Wittum, D. Keyes, Solution of the 3D density-driven groundwater flow problem with uncertain porosity and
permeability, GEM-International Journal on Geomathematics 11, 1-29, 2020
3. A. Litvinenko, A.C. Yucel, H. Bagci, J. Oppelstrup, E. Michielssen, R. Tempone, Computation of electromagnetic fields scattered from objects with uncertain
shapes using multilevel Monte Carlo method, IEEE Journal on Multiscale and Multiphysics Computational Techniques 4, 37-50, 2019
4. A. Litvinenko, D. Logashenko, R. Tempone, G. Wittum, D. Keyes, Propagation of Uncertainties in Density-Driven Flow, In: Bungartz, HJ., Garcke, J., Pflüger,
D. (eds) Sparse Grids and Applications - Munich 2018. LNCSE, vol. 144, pp 121-126, Springer, 2018

More Related Content

Similar to Litvinenko_Poster_Henry_22May.pdf

Talk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in HoustonTalk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in Houston
Alexander Litvinenko
 
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
The Statistical and Applied Mathematical Sciences Institute
 
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Alexander Litvinenko
 
SIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithmsSIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithms
Jagadeeswaran Rathinavel
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
Christian Robert
 
Joint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband rangingJoint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband ranging
Tarik Kazaz
 
Talk litvinenko gamm19
Talk litvinenko gamm19Talk litvinenko gamm19
Talk litvinenko gamm19
Alexander Litvinenko
 
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
The Statistical and Applied Mathematical Sciences Institute
 
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
Alexander Litvinenko
 
Litvinenko low-rank kriging +FFT poster
Litvinenko low-rank kriging +FFT  posterLitvinenko low-rank kriging +FFT  poster
Litvinenko low-rank kriging +FFT poster
Alexander Litvinenko
 
Probabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
Probabilistic Control of Uncertain Linear Systems Using Stochastic ReachabilityProbabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
Probabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
Leo Asselborn
 
Hierarchical matrix approximation of large covariance matrices
Hierarchical matrix approximation of large covariance matricesHierarchical matrix approximation of large covariance matrices
Hierarchical matrix approximation of large covariance matrices
Alexander Litvinenko
 
Identification of the Mathematical Models of Complex Relaxation Processes in ...
Identification of the Mathematical Models of Complex Relaxation Processes in ...Identification of the Mathematical Models of Complex Relaxation Processes in ...
Identification of the Mathematical Models of Complex Relaxation Processes in ...
Vladimir Bakhrushin
 
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
The Statistical and Applied Mathematical Sciences Institute
 
Thesis defense improved
Thesis defense improvedThesis defense improved
Thesis defense improved
Zheng Mengdi
 
MVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priorsMVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priors
Elvis DOHMATOB
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)
Alexander Litvinenko
 
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
 
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
 
Mit2 092 f09_lec20
Mit2 092 f09_lec20Mit2 092 f09_lec20
Mit2 092 f09_lec20
Rahman Hakim
 

Similar to Litvinenko_Poster_Henry_22May.pdf (20)

Talk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in HoustonTalk Alexander Litvinenko on SIAM GS Conference in Houston
Talk Alexander Litvinenko on SIAM GS Conference in Houston
 
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
QMC: Transition Workshop - Applying Quasi-Monte Carlo Methods to a Stochastic...
 
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
Efficient Simulations for Contamination of Groundwater Aquifers under Uncerta...
 
SIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithmsSIAM - Minisymposium on Guaranteed numerical algorithms
SIAM - Minisymposium on Guaranteed numerical algorithms
 
Adaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte CarloAdaptive Restore algorithm & importance Monte Carlo
Adaptive Restore algorithm & importance Monte Carlo
 
Joint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband rangingJoint blind calibration and time-delay estimation for multiband ranging
Joint blind calibration and time-delay estimation for multiband ranging
 
Talk litvinenko gamm19
Talk litvinenko gamm19Talk litvinenko gamm19
Talk litvinenko gamm19
 
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
MUMS Undergraduate Workshop - Introduction to Bayesian Inference & Uncertaint...
 
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
Possible applications of low-rank tensors in statistics and UQ (my talk in Bo...
 
Litvinenko low-rank kriging +FFT poster
Litvinenko low-rank kriging +FFT  posterLitvinenko low-rank kriging +FFT  poster
Litvinenko low-rank kriging +FFT poster
 
Probabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
Probabilistic Control of Uncertain Linear Systems Using Stochastic ReachabilityProbabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
Probabilistic Control of Uncertain Linear Systems Using Stochastic Reachability
 
Hierarchical matrix approximation of large covariance matrices
Hierarchical matrix approximation of large covariance matricesHierarchical matrix approximation of large covariance matrices
Hierarchical matrix approximation of large covariance matrices
 
Identification of the Mathematical Models of Complex Relaxation Processes in ...
Identification of the Mathematical Models of Complex Relaxation Processes in ...Identification of the Mathematical Models of Complex Relaxation Processes in ...
Identification of the Mathematical Models of Complex Relaxation Processes in ...
 
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
2018 MUMS Fall Course - Mathematical surrogate and reduced-order models - Ral...
 
Thesis defense improved
Thesis defense improvedThesis defense improved
Thesis defense improved
 
MVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priorsMVPA with SpaceNet: sparse structured priors
MVPA with SpaceNet: sparse structured priors
 
Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)Low-rank tensor approximation (Introduction)
Low-rank tensor approximation (Introduction)
 
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...
 
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...
 
Mit2 092 f09_lec20
Mit2 092 f09_lec20Mit2 092 f09_lec20
Mit2 092 f09_lec20
 

More from Alexander Litvinenko

Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdf
Alexander Litvinenko
 
Litv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdfLitv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdf
Alexander Litvinenko
 
Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...
Alexander Litvinenko
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Alexander Litvinenko
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...
Alexander Litvinenko
 
Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...
Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
Alexander Litvinenko
 
Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...
Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
Alexander Litvinenko
 
Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...
Alexander Litvinenko
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
Alexander Litvinenko
 
Simulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flowSimulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flow
Alexander Litvinenko
 
Approximation of large covariance matrices in statistics
Approximation of large covariance matrices in statisticsApproximation of large covariance matrices in statistics
Approximation of large covariance matrices in statistics
Alexander Litvinenko
 
Semi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster EnsembleSemi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster Ensemble
Alexander Litvinenko
 
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
Alexander Litvinenko
 
Overview of sparse and low-rank matrix / tensor techniques
Overview of sparse and low-rank matrix / tensor techniques Overview of sparse and low-rank matrix / tensor techniques
Overview of sparse and low-rank matrix / tensor techniques
Alexander Litvinenko
 
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
Alexander Litvinenko
 
Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics
Alexander Litvinenko
 

More from Alexander Litvinenko (18)

Litvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdfLitvinenko_RWTH_UQ_Seminar_talk.pdf
Litvinenko_RWTH_UQ_Seminar_talk.pdf
 
Litv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdfLitv_Denmark_Weak_Supervised_Learning.pdf
Litv_Denmark_Weak_Supervised_Learning.pdf
 
Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...Computing f-Divergences and Distances of High-Dimensional Probability Density...
Computing f-Divergences and Distances of High-Dimensional Probability Density...
 
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
Computing f-Divergences and Distances of\\ High-Dimensional Probability Densi...
 
Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...Low rank tensor approximation of probability density and characteristic funct...
Low rank tensor approximation of probability density and characteristic funct...
 
Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...Identification of unknown parameters and prediction of missing values. Compar...
Identification of unknown parameters and prediction of missing values. Compar...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...Identification of unknown parameters and prediction with hierarchical matrice...
Identification of unknown parameters and prediction with hierarchical matrice...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...Application of parallel hierarchical matrices for parameter inference and pre...
Application of parallel hierarchical matrices for parameter inference and pre...
 
Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...Computation of electromagnetic fields scattered from dielectric objects of un...
Computation of electromagnetic fields scattered from dielectric objects of un...
 
Simulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flowSimulation of propagation of uncertainties in density-driven groundwater flow
Simulation of propagation of uncertainties in density-driven groundwater flow
 
Approximation of large covariance matrices in statistics
Approximation of large covariance matrices in statisticsApproximation of large covariance matrices in statistics
Approximation of large covariance matrices in statistics
 
Semi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster EnsembleSemi-Supervised Regression using Cluster Ensemble
Semi-Supervised Regression using Cluster Ensemble
 
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
Computation of electromagnetic_fields_scattered_from_dielectric_objects_of_un...
 
Overview of sparse and low-rank matrix / tensor techniques
Overview of sparse and low-rank matrix / tensor techniques Overview of sparse and low-rank matrix / tensor techniques
Overview of sparse and low-rank matrix / tensor techniques
 
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
Application of Parallel Hierarchical Matrices in Spatial Statistics and Param...
 
Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics Tucker tensor analysis of Matern functions in spatial statistics
Tucker tensor analysis of Matern functions in spatial statistics
 

Recently uploaded

ppt on beauty of the nature by Palak.pptx
ppt on  beauty of the nature by Palak.pptxppt on  beauty of the nature by Palak.pptx
ppt on beauty of the nature by Palak.pptx
RaniJaiswal16
 
Celebrating World-environment-day-2024.pdf
Celebrating  World-environment-day-2024.pdfCelebrating  World-environment-day-2024.pdf
Celebrating World-environment-day-2024.pdf
rohankumarsinghrore1
 
Navigating the complex landscape of AI governance
Navigating the complex landscape of AI governanceNavigating the complex landscape of AI governance
Navigating the complex landscape of AI governance
Piermenotti Mauro
 
Natural farming @ Dr. Siddhartha S. Jena.pptx
Natural farming @ Dr. Siddhartha S. Jena.pptxNatural farming @ Dr. Siddhartha S. Jena.pptx
Natural farming @ Dr. Siddhartha S. Jena.pptx
sidjena70
 
Prevalence, biochemical and hematological study of diabetic patients
Prevalence, biochemical and hematological study of diabetic patientsPrevalence, biochemical and hematological study of diabetic patients
Prevalence, biochemical and hematological study of diabetic patients
Open Access Research Paper
 
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
ipcc-media
 
Daan Park Hydrangea flower season I like it
Daan Park Hydrangea flower season I like itDaan Park Hydrangea flower season I like it
Daan Park Hydrangea flower season I like it
a0966109726
 
Alert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
Alert-driven Community-based Forest monitoring: A case of the Peruvian AmazonAlert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
Alert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
CIFOR-ICRAF
 
Artificial Reefs by Kuddle Life Foundation - May 2024
Artificial Reefs by Kuddle Life Foundation - May 2024Artificial Reefs by Kuddle Life Foundation - May 2024
Artificial Reefs by Kuddle Life Foundation - May 2024
punit537210
 
UNDERSTANDING WHAT GREEN WASHING IS!.pdf
UNDERSTANDING WHAT GREEN WASHING IS!.pdfUNDERSTANDING WHAT GREEN WASHING IS!.pdf
UNDERSTANDING WHAT GREEN WASHING IS!.pdf
JulietMogola
 
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdfPresentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
Innovation and Technology for Development Centre
 
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business VenturesWillie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
greendigital
 
Environmental Science Book By Dr. Y.K. Singh
Environmental Science Book By Dr. Y.K. SinghEnvironmental Science Book By Dr. Y.K. Singh
Environmental Science Book By Dr. Y.K. Singh
AhmadKhan917612
 
NRW Board Paper - DRAFT NRW Recreation Strategy
NRW Board Paper - DRAFT NRW Recreation StrategyNRW Board Paper - DRAFT NRW Recreation Strategy
NRW Board Paper - DRAFT NRW Recreation Strategy
Robin Grant
 
International+e-Commerce+Platform-www.cfye-commerce.shop
International+e-Commerce+Platform-www.cfye-commerce.shopInternational+e-Commerce+Platform-www.cfye-commerce.shop
International+e-Commerce+Platform-www.cfye-commerce.shop
laozhuseo02
 
growbilliontrees.com-Trees for Granddaughter (1).pdf
growbilliontrees.com-Trees for Granddaughter (1).pdfgrowbilliontrees.com-Trees for Granddaughter (1).pdf
growbilliontrees.com-Trees for Granddaughter (1).pdf
yadavakashagra
 
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
Open Access Research Paper
 
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for..."Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
MMariSelvam4
 
Q&A with the Experts: The Food Service Playbook
Q&A with the Experts: The Food Service PlaybookQ&A with the Experts: The Food Service Playbook
Q&A with the Experts: The Food Service Playbook
World Resources Institute (WRI)
 
Characterization and the Kinetics of drying at the drying oven and with micro...
Characterization and the Kinetics of drying at the drying oven and with micro...Characterization and the Kinetics of drying at the drying oven and with micro...
Characterization and the Kinetics of drying at the drying oven and with micro...
Open Access Research Paper
 

Recently uploaded (20)

ppt on beauty of the nature by Palak.pptx
ppt on  beauty of the nature by Palak.pptxppt on  beauty of the nature by Palak.pptx
ppt on beauty of the nature by Palak.pptx
 
Celebrating World-environment-day-2024.pdf
Celebrating  World-environment-day-2024.pdfCelebrating  World-environment-day-2024.pdf
Celebrating World-environment-day-2024.pdf
 
Navigating the complex landscape of AI governance
Navigating the complex landscape of AI governanceNavigating the complex landscape of AI governance
Navigating the complex landscape of AI governance
 
Natural farming @ Dr. Siddhartha S. Jena.pptx
Natural farming @ Dr. Siddhartha S. Jena.pptxNatural farming @ Dr. Siddhartha S. Jena.pptx
Natural farming @ Dr. Siddhartha S. Jena.pptx
 
Prevalence, biochemical and hematological study of diabetic patients
Prevalence, biochemical and hematological study of diabetic patientsPrevalence, biochemical and hematological study of diabetic patients
Prevalence, biochemical and hematological study of diabetic patients
 
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
IPCC Vice Chair Ladislaus Change Central Asia Climate Change Conference 27 Ma...
 
Daan Park Hydrangea flower season I like it
Daan Park Hydrangea flower season I like itDaan Park Hydrangea flower season I like it
Daan Park Hydrangea flower season I like it
 
Alert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
Alert-driven Community-based Forest monitoring: A case of the Peruvian AmazonAlert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
Alert-driven Community-based Forest monitoring: A case of the Peruvian Amazon
 
Artificial Reefs by Kuddle Life Foundation - May 2024
Artificial Reefs by Kuddle Life Foundation - May 2024Artificial Reefs by Kuddle Life Foundation - May 2024
Artificial Reefs by Kuddle Life Foundation - May 2024
 
UNDERSTANDING WHAT GREEN WASHING IS!.pdf
UNDERSTANDING WHAT GREEN WASHING IS!.pdfUNDERSTANDING WHAT GREEN WASHING IS!.pdf
UNDERSTANDING WHAT GREEN WASHING IS!.pdf
 
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdfPresentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
Presentación Giulio Quaggiotto-Diálogo improbable .pptx.pdf
 
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business VenturesWillie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
Willie Nelson Net Worth: A Journey Through Music, Movies, and Business Ventures
 
Environmental Science Book By Dr. Y.K. Singh
Environmental Science Book By Dr. Y.K. SinghEnvironmental Science Book By Dr. Y.K. Singh
Environmental Science Book By Dr. Y.K. Singh
 
NRW Board Paper - DRAFT NRW Recreation Strategy
NRW Board Paper - DRAFT NRW Recreation StrategyNRW Board Paper - DRAFT NRW Recreation Strategy
NRW Board Paper - DRAFT NRW Recreation Strategy
 
International+e-Commerce+Platform-www.cfye-commerce.shop
International+e-Commerce+Platform-www.cfye-commerce.shopInternational+e-Commerce+Platform-www.cfye-commerce.shop
International+e-Commerce+Platform-www.cfye-commerce.shop
 
growbilliontrees.com-Trees for Granddaughter (1).pdf
growbilliontrees.com-Trees for Granddaughter (1).pdfgrowbilliontrees.com-Trees for Granddaughter (1).pdf
growbilliontrees.com-Trees for Granddaughter (1).pdf
 
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
Micro RNA genes and their likely influence in rice (Oryza sativa L.) dynamic ...
 
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for..."Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
"Understanding the Carbon Cycle: Processes, Human Impacts, and Strategies for...
 
Q&A with the Experts: The Food Service Playbook
Q&A with the Experts: The Food Service PlaybookQ&A with the Experts: The Food Service Playbook
Q&A with the Experts: The Food Service Playbook
 
Characterization and the Kinetics of drying at the drying oven and with micro...
Characterization and the Kinetics of drying at the drying oven and with micro...Characterization and the Kinetics of drying at the drying oven and with micro...
Characterization and the Kinetics of drying at the drying oven and with micro...
 

Litvinenko_Poster_Henry_22May.pdf

  • 1. Center for Uncertainty Quantification Salinization of coastal aquifers under uncertainties Alexander Litvinenko1 , Dmitry Logashenko2 , Raul Tempone1,2 , Ekaterina Vasilyeva2 , Gabriel Wittum2 1 RWTH Aachen, Germany, 2 KAUST, Saudi Arabia litvinenko@uq.rwth-aachen.de Center for Uncertainty Quantification Center for Uncertainty Quantification Abstract Problem: Henry saltwater intrusion (nonlinear and time-dependent, describes a two-phase subsurface flow) Input uncertainty: porosity, permeability, and recharge (model by random fields) Solution: the salt mass fraction (uncertain and time-dependent) Method: Multi Level Monte Carlo (MLMC) method Deterministic solver: parallel multigrid solver ug4 Questions: 1. How long can wells be used? 2. Where is the largest uncertainty? 3. Freshwater exceed. probabil.? 4. What is the mean scenario and its variations? 5. What are the extreme scenarios? 6. How do the uncertainties change over time? Figure 1: Henry problem, taken from https://www.mdpi.com/2073-4441/10/2/230 1. Henry problem settings The mass conservation laws for the entire liquid phase and salt yield the following equations ∂t(ϕρ) + ∇ · (ρq) = 0, ∂t(ϕρc) + ∇ · (ρcq − ρD∇c) = 0, where ϕ(x, ξ) is porosity, x ∈ D, is determined by a set of RVs ξ = (ξ1, . . . , ξM, ...). c(t, x) mass fraction of the salt, ρ = ρ(c) density of the liquid phase, and D(t, x) molecular diffusion tensor. For q(t, x) velocity, we assume Darcy’s law: q = − K µ (∇p − ρg), where p = p(t, x) is the hydrostatic pressure, K permeability, µ = µ(c) viscosity of the liquid phase, and g gravity. To compute: c and p. Comput. domain: D × [0, T]. We set ρ(c) = ρ0 + (ρ1 − ρ0)c, and D = ϕDI, I.C.: c|t=0 = 0, B.C.: c|x=2 = 1, p|x=2 = −ρ1gy. c|x=0 = 0, ρq · ex|x=0 = q̂in. We model the uncertain ϕ using a random field and assume: K = KI, K = K(ϕ). Methods: Newton method, BiCGStab, preconditioned with the geometric multigrid method (V-cycle), ILUβ-smoothers and Gaussian elimination. 2. Solution of the Henry problem q̂in = 6.6 · 10−2 kg/s c = 0 c = 1 p = −ρ1gy 0 −1 m 2 m y x D := [0, 2] × [−1, 0]; a realization of c(t, x); ϕ(ξ∗ ) ∈ [0.18, 0.59]; E [c] ∈ [0, 0.35]; Var[c] ∈ [0.0, 0.04] QoIs: c in the whole domain, c at a point, or integral values (the freshwater/saltwater integrals): QFW (t, ω) := R x∈D I(c(t, x, ω) ≤ 0.012178)dx, Qs(t, ω) := R x∈D c(t, x, ω)ρ(t, x, ω)dx 2.1 Multi Level Monte Carlo (MLMC) method Spatial and temporal grid hierarchies D0, D1, . . . , DL, and T0, T1, . . . , TL; n0 = 512, nℓ ≈ n0 · 16ℓ , τℓ+1 = 1 4τℓ, rℓ+1 = 4rℓ and rℓ = r04ℓ . Computation complexity is sℓ = O(nℓrℓ) = O(43ℓγ n0 · r0) MLMC approximates E [gL] ≈ E [g] using the following telescopic sum: E [gL] ≈ m−1 0 m0 X i=1 g (0,i) 0 + L X ℓ=1 m−1 ℓ mℓ X i=1 (g (ℓ,i) ℓ − g (ℓ,i) ℓ−1 ) ! . Minimize F(m0, . . . , mL) := PL ℓ=0 mℓsℓ + µ2 Vℓ mℓ , obtain mℓ = ε−2 q Vℓ sℓ PL i=0 √ Visi. 100 realizations of QFW (t); Evolution of the pdf of c(t, x), t = {3τ, . . . , 48τ}; pdf of the earliest time point when c(t, x) < 0.9, x = (1.85, −0.95); mean values E [c(t, x9, y9)]; variances Var[c](t, x9, y9) on levels 0,1,2,3. E [gℓ − gℓ−1] (t, x9, y9); V [gℓ − gℓ−1] (t, x9, y9), ℓ = 1, 2, 3, QoI is the integral value over D9 ; 100 realisations of g1 − g0, g2 − g1, g3 − g2, QoI gℓ is the integral value Qs(t, ω) computed over a subdomain around 9th point, t ∈ [τ, 48τ]. Level ℓ nℓ, ( nℓ nℓ−1 ) rℓ, ( rℓ rℓ−1 ) τℓ = 6016/rℓ Computing times (sℓ), ( sℓ sℓ−1 ) average min. max. 0 153 94 64 0.6 0.5 0.7 1 2145 (14) 376 (4) 16 7.1 (14) 6.9 8.7 2 33153 (15.5) 1504 (4) 4 252.9 (36) 246.2 266.2 3 525825 (15.9) 6016 (4) 1 11109.8 (44) 9858.4 15506.9 #ndofs nℓ, number of time steps rℓ, time step τℓ; average, minimal, and maximal computing times on each level ℓ. ε2 0.1 total cost of MC, SMC 9.5e + 6 total cost of MLMC, S 4.25e + 4 {m0, m1, m2, m3} {7927, 946, 57, 2} Comparison of MC and MLMC ε2 m0 m1 m2 m3 1 73 8 1 0 0.5 290 32 3 0 0.1 7258 811 68 1 0.05 29031 3245 274 5 MLMC: number of samples on level ℓ (1)Weak (α = −2) and (2)strong (β = −3.4) convergences, ℓ = 0, 1, 2, 3. QoI=local integral of c over (x, y)9 = (1.65, −0.75)-subdomain; (3) decay of absolute and (4) relative errors between the mean values computed on a fine mesh via MC and via MLMC at (t, x, y) = (12, 1.60, −0.95). Acknowledgements: KAUST HPC and the Alexander von Humboldt foundation. 1. A. Litvinenko, D. Logashenko, R. Tempone, E. Vasilyeva, G. Wittum, Uncertainty quantification in coastal aquifers using the multilevel Monte Carlo method, arXiv:2302.07804, 2023 2. A. Litvinenko, D. Logashenko, R. Tempone, G. Wittum, D. Keyes, Solution of the 3D density-driven groundwater flow problem with uncertain porosity and permeability, GEM-International Journal on Geomathematics 11, 1-29, 2020 3. A. Litvinenko, A.C. Yucel, H. Bagci, J. Oppelstrup, E. Michielssen, R. Tempone, Computation of electromagnetic fields scattered from objects with uncertain shapes using multilevel Monte Carlo method, IEEE Journal on Multiscale and Multiphysics Computational Techniques 4, 37-50, 2019 4. A. Litvinenko, D. Logashenko, R. Tempone, G. Wittum, D. Keyes, Propagation of Uncertainties in Density-Driven Flow, In: Bungartz, HJ., Garcke, J., Pflüger, D. (eds) Sparse Grids and Applications - Munich 2018. LNCSE, vol. 144, pp 121-126, Springer, 2018