Uncertainty Quantification and related areas - An overview

Size: px
Start display at page:

Download "Uncertainty Quantification and related areas - An overview"

Transcription

1 Uncertainty Quantification and related areas - An overview Alexander Litvinenko, talk given at Department of Mathematical Sciences, Durham University Bayesian Computational Statistics & Modeling, KAUST Stochastic Numerics Group Alexander Litvinenko, talk given at Department of Mathematical Sciences, Uncertainty Durham Quantification University and related areas - An overview

2 The structure of the talk. Part I. Introduction to UQ. Part II. Low-rank tensors for representation of big/high-dimensional data 3. Part III. Inverse Problem via Bayesian Update 4. Part IV. R-INLA and advance numerics for spatio-temporal statistics 5. Part V. High Performance Computing, parallel algorithms

3 Part I. Introduction into UQ 3

4 Motivation to do Uncertainty Quantification (UQ) Motivation: there is an urgent need to quantify and reduce the uncertainty in multiscale-multiphysics applications. Nowadays computational predictions are used in critical engineering decisions. But, how reliable are these predictions? Example: Saudi Aramco currently has a simulator, TeraPOWERS, which runs trillion-cell simulation. How sensitive are these simulations w.r.t. unknown reservoir properties? My goal is development of UQ methods and low-rank algorithms relevant for applications. (pictures are taken from internet) 4

5 Uncertainty Quantification Consider { div(κ(x, ω) u(x, ω)) = f (x, ω) in G Ω, G R d, u = 0 on G, where κ(x, ω) - uncertain diffusion coefficient.. Efficient Analysis of High Dimensional Data in Tensor Formats, Espig, Hackbusch, Litvinenko., Matthies, Zander, 0.. Efficient low-rank approx. of the stoch. Galerkin matrix in tensor formats, Wähnert, Espig, Hackbusch, A.L., Matthies, PCE of random coefficients and the solution of stochastic PDEs in the Tensor Train format, Dolgov, Litvinenko, Khoromskij, Matthies, Application of H-matrices for computing the KL expansion, Khoromskij, Litvinenko, Matthies Computing 4 (-), 49-67, realizations of the solution u, the mean and quantiles Related work by R. Scheichl, Chr. Schwab, A. Teckentrup, F. Nobile, D. Kressner,... 5

6 Discretisation techniques Truncated Karhunen Loève Expansion (KLE): κ(x, ω) κ 0 (x) + L κ j g j (x)ξ j (θ(ω)), j= where θ = θ(ω) = (θ (ω), θ (ω),..., ), ξ j (θ) = κ j G (κ(x, ω) κ 0(x)) g j (x)dx.. S. Dolgov, B.N. Khoromskij, A. Litvinenko, H.G. Matthies, Computation of the Response Surface in the Tensor Train data format, arxiv preprint arxiv:406.6, 04. S. Dolgov, B.N. Khoromskij, A. Litvinenko, H.G. Matthies, Polynomial Chaos Expansion of Random Coefficients and the Solution of Stochastic Partial Differential Equations in the Tensor Train Format, IAM/ASA J. Uncertainty Quantification 3 (), 09-35, 05 6

7 Generalized Polynomial Chaos Expansions (gpce) Decompose ξ j (θ) from above: ξ j (θ) ξ (α) j α J M,p H α (θ), H α (θ) could be multivariate Hermite polynomials, α = (α,..., α M ). And, combining with KLE above, obtain L κ(x, ω) κ 0 (x) + κ j g j (x) j= ξ (α) j α J M,p H α (θ) Need a compact representation of a sum above. TENSORS! Can also apply gpce directly κ(x, ω) κ (α) (x)h α (θ). α J M,p 7

8 Part II. Low-rank tensor approximations of big data Goal: To provide fast and cheap numerical techniques for working with big and high-dimensional data. How?: By reducing linear algebra cost from O(n d ) to O(drn).

9 Curse of dimensionality Assume we have n d data. Our aim is to reduce storage/complexity from O(n d ) to O(dn). For n = 00 and d = 0, then just to store one needs = 0 TB. If we assume that a modern computer compares 0 7 numbers per second, then the total time for comparison 0 0 elements will be 0 3 seconds or years. In some chemical applications we had n = 00 and d = 00. how to compute the mean? how to compute maxima and minima? how to compute level sets, i.e. all elements from an interval [a, b]? how to compute the number of elements in an interval [a, b]? 9

10 Canonical (CP) and Tucker tensor formats Tensor of order d is a multidimensional array over a d-tuple index set I = I I d, A = [a i...i d : i l I l ] R I, I l = {,..., n l }, l =,.., d. Storage: O(n d ) O(dRn) and O(R d + drn). A. Litvinenko, D. Keyes, V. Khoromskaia, B.N. Khoromskij, H.G. Matthies, Tucker Tensor analysis of Matern functions in spatial statistics, preprint arxiv:7.0674, 07 0

11 Discretization of elliptic PDE Ku = f, where L M K := K l lµ, K l R N N, lµ R Rµ Rµ, l= µ= r M u := u j u jµ, u j R N, u jµ R Rµ, j= µ= R M f := f k g kµ, f k R N, g kµ R Rµ. k= µ= Efficient low-rank approximation of the stochastic Galerkin matrix in tensor formats, Wähnert, Espig, Hackbusch, Litvinenko, Matthies, 03. We analyzed tensor ranks (compression properties) of the stochastic Galerkin operator K.

12 Numerical Experiments D L-shape domain, N = 557 dofs. Total stochastic dimension is Mu = Mk + Mf = 0, there are JM,p = 3 PCE coefficients u= 3 X j= uj,0 0 O µ= ujµ R557 0 O R3. µ= Tensor u has entries 6 TB of memory. Instead we store only 3 ( ) entries.4 MB.

13 How to compute the variance in CP format Let u R r and ũ := u u d µ= r+ = n µ j= µ= d ũ jµ R r+, () then the variance var(u) of u can be computed as follows ũ, ũ r+ d r+ d var(u) = d µ= n = d µ µ= n ũ iµ, µ = r+ r+ d i= j= µ= n µ ũiµ, ũ jµ. i= µ= ( Numerical cost is O (r + ) d ) µ= n µ. j= ν= ũ jν

14 Level sets Now we compute level sets {ui : ui > b max u}, i i := (i,..., im+ ) for b {0., 0.4, 0.6, 0.}. The computing time for each b was 0 minutes. Key words: u is tensor, Newton methods, inverse u, sign(u), frequency, characteristic function. 3

15 Computation of level sets and frequency. To compute level sets and frequencies we need characteristic function.. To compute characteristic function we need sign(u) function. 3. To compute sign(u) function we need u. Proposition Let I R, u T, and χ I (u) its characteristic. We have L I (u) = χ I (u) u and rank(l I (u)) rank(χ I (u)) rank(u). The frequency F I (u) N of u respect to I is F I (u) = χ I (u),, where = d µ= µ, µ := (,..., ) T R nµ. 4

16 Part III. Inverse Problem via Bayesian Update 5

17 Developing of cheap Bayesian update surrogate. H.G. Matthies, E. Zander, B.V. Rosic, A. Litvinenko, Parameter estimation via conditional expectation: a Bayesian inversion, Advanced modeling and simulation in engineering sciences 3 (), 4, 06. Inverse Problems in a Bayesian Setting, H.G. Matthies, E. Zander, O. Pajonk, B. Rosic, A. Litvinenko. Computational Methods for Solids and Fluids Multiscale Analysis, ISSN: , 06 Related work by A. Stuart, Chr. Schwab, A. El Sheikh, Y. Marzouk, H. Najm, O. Ernst x f x a x y a y y f 0.9 z f z a z

18 Numerical computation of Bayesian Update surrogate Notation: ŷ measurements from engineers, y(ξ) forecast from the simulator, ε(ω) the Gaussian noise. Look for ϕ such that q(ξ) = ϕ(z(ξ)), z(ξ) = y(ξ) + ε(ω): ϕ ϕ = α J p ϕ α Φ α (z(ξ)) and minimize q(ξ) ϕ(z(ξ)) L, where Φ α are known polynomials (e.g. Hermite). Taking derivatives with respect to ϕ α : ϕ α q(ξ) ϕ(z(ξ)), q(ξ) ϕ(z(ξ)) = 0 α J p 6

19 Numerical computation of NLBU E q (ξ) qϕ β Φ β (z) + ϕ β ϕ γ Φ β (z)φ γ (z) ϕ α β J β,γ J = E qφ α (z) + ϕ β Φ β (z)φ α (z) β J = E [Φ β (z)φ α (z)] ϕ β E [qφ α (z)] = 0 α J. β J

20 Numerical computation of NLBU Now, rewriting the last sum in a matrix form, obtain the linear system of equations (=: A) to compute coefficients ϕ β : E [Φ α (z(ξ))φ β (z(ξ))] where α, β J, A is of size J J.. ϕ β. =. E [q(ξ)φ α (z(ξ))] A. Litvinenko, H.G. Matthies, Inverse problems and uncertainty quantification, arxiv preprint arxiv:3.504, 03.,

21 Numerical computation of NLBU Finally, the assimilated parameter q a will be z(ξ) = y(ξ) + ε(ω), ϕ = β J p ϕ β Φ β (z(ξ)) 6 q a = q f + ϕ(ŷ) ϕ(z), () κ f 4 κ a PDF κ 9

22 Example: D elliptic PDE with uncertain coeffs (κ(x, ξ) u(x, ξ)) = f (x, ξ), x [0, ] + Dirichlet random b.c. g(0, ξ) and g(, ξ). 3 measurements: u(0.3) =, s.d. 0., x(0.5) =, s.d. 0.3, x(0.) =, s.d κ(x, ξ): N = 00 dofs, M = 5, number of KLE terms 35, beta distribution for κ, Gaussian cov κ, cov. length 0., multi-variate Hermite polynomial of order p κ = ; RHS f (x, ξ): M f = 5, number of KLE terms 40, beta distribution for κ, exponential cov f, cov. length 0.03, multi-variate Hermite polynomial of order p f = ; b.c. g(x, ξ): M g =, number of KLE terms, normal distribution for g, Gaussian cov g, cov. length 0, multi-variate Hermite polynomial of order p g = ; p φ = 3 and p u = 3 0

23 Example: Updating of the parameter Figure: Prior and posterior (updated) parameter κ. Collaboration with Y. Marzouk, MIT, and TU Braunschweig. Together with H. Najm, Sandia Lab, we try to compare our technique with his advanced MCMC technique for chemical combustion eqn.

24 Example: updating of the solution u Figure: Original and updated solutions, mean value plus/minus,,3 standard deviations. Number of available measurements {0,,, 3, 5} [graphics are built in the stochastic Galerkin library sglib, written by E. Zander in TU Braunschweig]

25 Minimization of Uncert. in Num. Aerodynamics Involved: 7 German Universities, DLR, Airbus Duration: Quantification of airfoil geometry-induced aerodynamic uncertainties-comparison of approaches, Liu, Litvinenko, Schillings, Schulz, JUQ 07. Numerical Methods for Uncertainty Quantification and Bayesian Update in Aerodynamics Litvinenko, Matthies, chapter in Springer book, Vol, pp 6-5, 03. 3

26 Example: uncertainties in free stream turbulence v u v α α u v Random vectors v (θ) and v (θ) model free stream turbulence 4

27 Example: 3sigma intervals Figure: 3σ interval, σ standard deviation, in each point of RAE airfoil for the pressure (cp) and friction (cf) coefficients. 5

28 Mean and variance of density, tke, xv, zv, pressure mean density, variance of density, mean turbul. kinetic energy, x-velocity, z-velocity, a pressure (failed to compute) 6

29 Part IV. INLA and advance numerics for spatio-temporal statistics 7

30 Sparse matrices in INLA Integrated Nested Laplace Approximations (INLA) approximates Bayesian inference for latent Gaussian models (LGMs). Laplace method approximates high-dimensional integrals with a second order Taylor expansion and computes the integral analytically. A nested version of this idea, combined with sparse data techniques is INLA. My goal: improve sparse matrix techniques in R-INLA project

31 Two ways to find a low-rank tensor approx. of Matérn cov. Low-rank approximation of Matérn covariance 9

32 Part V-a. Parallel algorithms in environmental statistics 30

33 Improving of the moisture model Task: to improve statistical model, which predicts moisture Given: D-Grid with n.5mi locations Soil moisture latitude longitude High-resolution daily soil moisture data at the top layer of the Mississippi basin, U.S.A., Important for agriculture, defense,.... A. Litvinenko, HLIBCov: Parallel Hierarchical Matrix Approximation of Large Covariance Matrices and Likelihoods with Applications in Parameter Identification, preprint arxiv: , 07. A. Litvinenko, Y. Sun, M.G. Genton, D. Keyes, Likelihood Approximation With Hierarchical Matrices For Large Spatial Datasets, preprint arxiv: , 07 3

34 Improving of the moisture model Goal: To improve estimation of unknown statistical parameters in a spatial soil moisture field. Log-likelihood function with Matérn C(θ) and available data Z : L(θ) = n log(π) log C(θ) Z C(θ) Z. To identify: unknown parameters θ := (σ, ν, l). Collaboration with statisticians: M. Genton, Y. Sun, R. Huser, from KAUST. n = 5K, matrix setup 6 sec., compression rate 99.9% (0.4 GB against 006 GB). H-LU is done in 43 sec., error

35 Parameter identification l ν n, samples in thousands n, samples in thousands Synthetic data with known parameters (l, ν, σ ) = (0.5,, 0.5). Boxplots for l and ν for n =, 000 {64, 3,..., 4, }; 00 replicates 33

36 Part V-b. High Performance Computing and UQ 34

37 Parallel algorithms with distributed data Consider density driven groundwater flow with uncertain porosity and permeability (ρq) = 0, (3) t (φc) + (cq D c) = 0. (4) Mean and variance of porosity The mean (left) and the variances (right) of the porosity, [0, 600] [0, 50], φ(x) 0., var(φ(x)) (3. 0 5, ). We compute 00 scenarios in parallel, each scenario on 3 cores in parallel. Total: 00 3 = 5600 cores

38 Mean and variance of concentration The mean and variance of the concentration, computed via QMC. The number of time steps is 500; E(c) (0, ), var(c) (0, 0.06). Two different realizations of concentration: with 5 fingers (left) and 4 fingers (right). 36

39 Conclusion Introduced:. UQ and many examples,. Big data require a compact representation. We suggest low-rank tensor data techniques. 3. Tensor techniques requires to redefine standard statistical algorithms 4. Bayesian update surrogate ϕ (as a linear, quadratic,... approximation) 5. Applications in aerodynamics, geostatistics, reservoirs, environmental statistics 6. HPC applications: parallel algorithms for UQ on a supercomputer 37

40 Literature. A. Litvinenko, Application of Hierarchical matrices for solving multiscale problems, PhD Thesis, Leipzig University, Germany, B.N. Khoromskij, A. Litvinenko, Domain decomposition based H-matrix preconditioners for the skin problem, Domain Decomposition Methods in Science and Engineering XVII, pp 75-, A. Litvinenko, Documentation for the Hierarchical Domain Decomposition (HDD) method, Technical report, Vol 5, pp -33, Max-Planck Institute for applied mathematics in the science in Leipzig, A. Litvinenko, Partial inversion of elliptic operator to speed up computation of likelihood in Bayesian inference, arxiv preprint , W. Nowak, A. Litvinenko, Kriging and spatial design accelerated by orders of magnitude: Combining low-rank covariance approximations with FFT-techniques, Mathematical Geosciences 45 (4), 4-435, 03 3

NON-LINEAR APPROXIMATION OF BAYESIAN UPDATE

NON-LINEAR APPROXIMATION OF BAYESIAN UPDATE tifica NON-LINEAR APPROXIMATION OF BAYESIAN UPDATE Alexander Litvinenko 1, Hermann G. Matthies 2, Elmar Zander 2 http://sri-uq.kaust.edu.sa/ 1 Extreme Computing Research Center, KAUST, 2 Institute of Scientific

More information

Sampling and low-rank tensor approximation of the response surface

Sampling and low-rank tensor approximation of the response surface Sampling and low-rank tensor approximation of the response surface tifica Alexander Litvinenko 1,2 (joint work with Hermann G. Matthies 3 ) 1 Group of Raul Tempone, SRI UQ, and 2 Group of David Keyes,

More information

Lecture 1: Introduction to low-rank tensor representation/approximation. Center for Uncertainty Quantification. Alexander Litvinenko

Lecture 1: Introduction to low-rank tensor representation/approximation. Center for Uncertainty Quantification. Alexander Litvinenko tifica Lecture 1: Introduction to low-rank tensor representation/approximation Alexander Litvinenko http://sri-uq.kaust.edu.sa/ KAUST Figure : KAUST campus, 5 years old, approx. 7000 people (include 1400

More information

Lecture 1: Introduction to low-rank tensor representation/approximation. Center for Uncertainty Quantification. Alexander Litvinenko

Lecture 1: Introduction to low-rank tensor representation/approximation. Center for Uncertainty Quantification. Alexander Litvinenko tifica Lecture 1: Introduction to low-rank tensor representation/approximation Alexander Litvinenko http://sri-uq.kaust.edu.sa/ KAUST Figure : KAUST campus, 5 years old, approx. 7000 people (include 1400

More information

Hierarchical matrix techniques for maximum likelihood covariance estimation

Hierarchical matrix techniques for maximum likelihood covariance estimation Hierarchical matrix techniques for maximum likelihood covariance estimation tifica Alexander Litvinenko, Extreme Computing Research Center and Uncertainty Center, KAUST (joint work with M. Genton, Y. Sun

More information

Lecture 1: Center for Uncertainty Quantification. Alexander Litvinenko. Computation of Karhunen-Loeve Expansion:

Lecture 1: Center for Uncertainty Quantification. Alexander Litvinenko. Computation of Karhunen-Loeve Expansion: tifica Lecture 1: Computation of Karhunen-Loeve Expansion: Alexander Litvinenko http://sri-uq.kaust.edu.sa/ Stochastic PDEs We consider div(κ(x, ω) u) = f (x, ω) in G, u = 0 on G, with stochastic coefficients

More information

Sampling and Low-Rank Tensor Approximations

Sampling and Low-Rank Tensor Approximations Sampling and Low-Rank Tensor Approximations Hermann G. Matthies Alexander Litvinenko, Tarek A. El-Moshely +, Brunswick, Germany + MIT, Cambridge, MA, USA wire@tu-bs.de http://www.wire.tu-bs.de $Id: 2_Sydney-MCQMC.tex,v.3

More information

Hierarchical Parallel Solution of Stochastic Systems

Hierarchical Parallel Solution of Stochastic Systems Hierarchical Parallel Solution of Stochastic Systems Second M.I.T. Conference on Computational Fluid and Solid Mechanics Contents: Simple Model of Stochastic Flow Stochastic Galerkin Scheme Resulting Equations

More information

Numerical Approximation of Stochastic Elliptic Partial Differential Equations

Numerical Approximation of Stochastic Elliptic Partial Differential Equations Numerical Approximation of Stochastic Elliptic Partial Differential Equations Hermann G. Matthies, Andreas Keese Institut für Wissenschaftliches Rechnen Technische Universität Braunschweig wire@tu-bs.de

More information

A Spectral Approach to Linear Bayesian Updating

A Spectral Approach to Linear Bayesian Updating A Spectral Approach to Linear Bayesian Updating Oliver Pajonk 1,2, Bojana V. Rosic 1, Alexander Litvinenko 1, and Hermann G. Matthies 1 1 Institute of Scientific Computing, TU Braunschweig, Germany 2 SPT

More information

Parametric Problems, Stochastics, and Identification

Parametric Problems, Stochastics, and Identification Parametric Problems, Stochastics, and Identification Hermann G. Matthies a B. Rosić ab, O. Pajonk ac, A. Litvinenko a a, b University of Kragujevac c SPT Group, Hamburg wire@tu-bs.de http://www.wire.tu-bs.de

More information

Curriculum Vitae. Alexander Litvenenko

Curriculum Vitae. Alexander Litvenenko Curriculum Vitae Alexander Litvinenko https://ecrc.kaust.edu.sa/pages/litvinenko.aspx http://stochastic_numerics.kaust.edu.sa/pages/litvinenkoalexander.aspx Name: Nationality: Languages: Alexander Litvenenko

More information

Schwarz Preconditioner for the Stochastic Finite Element Method

Schwarz Preconditioner for the Stochastic Finite Element Method Schwarz Preconditioner for the Stochastic Finite Element Method Waad Subber 1 and Sébastien Loisel 2 Preprint submitted to DD22 conference 1 Introduction The intrusive polynomial chaos approach for uncertainty

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Mike Giles Mathematical Institute, University of Oxford Contemporary Numerical Techniques Mike Giles (Oxford) Monte Carlo methods 1 / 23 Lecture outline

More information

At A Glance. UQ16 Mobile App.

At A Glance. UQ16 Mobile App. At A Glance UQ16 Mobile App Scan the QR code with any QR reader and download the TripBuilder EventMobile app to your iphone, ipad, itouch or Android mobile device. To access the app or the HTML 5 version,

More information

Karhunen-Loeve Expansion and Optimal Low-Rank Model for Spatial Processes

Karhunen-Loeve Expansion and Optimal Low-Rank Model for Spatial Processes TTU, October 26, 2012 p. 1/3 Karhunen-Loeve Expansion and Optimal Low-Rank Model for Spatial Processes Hao Zhang Department of Statistics Department of Forestry and Natural Resources Purdue University

More information

Optimisation under Uncertainty with Stochastic PDEs for the History Matching Problem in Reservoir Engineering

Optimisation under Uncertainty with Stochastic PDEs for the History Matching Problem in Reservoir Engineering Optimisation under Uncertainty with Stochastic PDEs for the History Matching Problem in Reservoir Engineering Hermann G. Matthies Technische Universität Braunschweig wire@tu-bs.de http://www.wire.tu-bs.de

More information

Quantifying Uncertainty: Modern Computational Representation of Probability and Applications

Quantifying Uncertainty: Modern Computational Representation of Probability and Applications Quantifying Uncertainty: Modern Computational Representation of Probability and Applications Hermann G. Matthies with Andreas Keese Technische Universität Braunschweig wire@tu-bs.de http://www.wire.tu-bs.de

More information

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Institut für Numerische Mathematik und Optimierung Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Oliver Ernst Computational Methods with Applications Harrachov, CR,

More information

Overview. Bayesian assimilation of experimental data into simulation (for Goland wing flutter) Why not uncertainty quantification?

Overview. Bayesian assimilation of experimental data into simulation (for Goland wing flutter) Why not uncertainty quantification? Delft University of Technology Overview Bayesian assimilation of experimental data into simulation (for Goland wing flutter), Simao Marques 1. Why not uncertainty quantification? 2. Why uncertainty quantification?

More information

Non-Intrusive Solution of Stochastic and Parametric Equations

Non-Intrusive Solution of Stochastic and Parametric Equations Non-Intrusive Solution of Stochastic and Parametric Equations Hermann G. Matthies a Loïc Giraldi b, Alexander Litvinenko c, Dishi Liu d, and Anthony Nouy b a,, Brunswick, Germany b École Centrale de Nantes,

More information

Quasi-optimal and adaptive sparse grids with control variates for PDEs with random diffusion coefficient

Quasi-optimal and adaptive sparse grids with control variates for PDEs with random diffusion coefficient Quasi-optimal and adaptive sparse grids with control variates for PDEs with random diffusion coefficient F. Nobile, L. Tamellini, R. Tempone, F. Tesei CSQI - MATHICSE, EPFL, Switzerland Dipartimento di

More information

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Roman Andreev ETH ZÜRICH / 29 JAN 29 TOC of the Talk Motivation & Set-Up Model Problem Stochastic Galerkin FEM Conclusions & Outlook Motivation

More information

Numerical Analysis of Elliptic PDEs with Random Coefficients

Numerical Analysis of Elliptic PDEs with Random Coefficients Numerical Analysis of Elliptic PDEs with Random Coefficients (Lecture I) Robert Scheichl Department of Mathematical Sciences University of Bath Workshop on PDEs with Random Coefficients Weierstrass Institute,

More information

Sparse polynomial chaos expansions in engineering applications

Sparse polynomial chaos expansions in engineering applications DEPARTMENT OF CIVIL, ENVIRONMENTAL AND GEOMATIC ENGINEERING CHAIR OF RISK, SAFETY & UNCERTAINTY QUANTIFICATION Sparse polynomial chaos expansions in engineering applications B. Sudret G. Blatman (EDF R&D,

More information

Stochastic Spectral Approaches to Bayesian Inference

Stochastic Spectral Approaches to Bayesian Inference Stochastic Spectral Approaches to Bayesian Inference Prof. Nathan L. Gibson Department of Mathematics Applied Mathematics and Computation Seminar March 4, 2011 Prof. Gibson (OSU) Spectral Approaches to

More information

Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling

Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling Probabilistic Collocation Method for Uncertainty Analysis of Soil Infiltration in Flood Modelling Y. Huang 1,2, and X.S. Qin 1,2* 1 School of Civil & Environmental Engineering, Nanyang Technological University,

More information

Quantification of airfoil geometry-induced. aerodynamic uncertainties - comparison of. approaches

Quantification of airfoil geometry-induced. aerodynamic uncertainties - comparison of. approaches Quantification of airfoil geometry-induced aerodynamic uncertainties - comparison of approaches Dishi Liu 1 Lilienthalplatz 7, 3818 Braunschweig, Germany Alexander Litvinenko 2 47 KAUST, M.B. 4436, Thuwal,

More information

Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications

Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications Stochastic Collocation Methods for Polynomial Chaos: Analysis and Applications Dongbin Xiu Department of Mathematics, Purdue University Support: AFOSR FA955-8-1-353 (Computational Math) SF CAREER DMS-64535

More information

Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method

Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method Characterization of heterogeneous hydraulic conductivity field via Karhunen-Loève expansions and a measure-theoretic computational method Jiachuan He University of Texas at Austin April 15, 2016 Jiachuan

More information

Gradient Enhanced Universal Kriging Model for Uncertainty Propagation in Nuclear Engineering

Gradient Enhanced Universal Kriging Model for Uncertainty Propagation in Nuclear Engineering Gradient Enhanced Universal Kriging Model for Uncertainty Propagation in Nuclear Engineering Brian A. Lockwood 1 and Mihai Anitescu 2 1 Department of Mechanical Engineering University of Wyoming 2 Mathematics

More information

Uncertainty analysis of large-scale systems using domain decomposition

Uncertainty analysis of large-scale systems using domain decomposition Center for Turbulence Research Annual Research Briefs 2007 143 Uncertainty analysis of large-scale systems using domain decomposition By D. Ghosh, C. Farhat AND P. Avery 1. Motivation and objectives A

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

More information

Inverse Problems in a Bayesian Setting

Inverse Problems in a Bayesian Setting Inverse Problems in a Bayesian Setting Hermann G. Matthies, Elmar Zander, Bojana V. Rosić, Alexander Litvinenko, Oliver Pajonk arxiv:1511.00524v1 [math.pr] 2 Nov 2015 Institute of Scientific Computing

More information

Experiences with Model Reduction and Interpolation

Experiences with Model Reduction and Interpolation Experiences with Model Reduction and Interpolation Paul Constantine Stanford University, Sandia National Laboratories Qiqi Wang (MIT) David Gleich (Purdue) Emory University March 7, 2012 Joe Ruthruff (SNL)

More information

Scalable Algorithms for Optimal Control of Systems Governed by PDEs Under Uncertainty

Scalable Algorithms for Optimal Control of Systems Governed by PDEs Under Uncertainty Scalable Algorithms for Optimal Control of Systems Governed by PDEs Under Uncertainty Alen Alexanderian 1, Omar Ghattas 2, Noémi Petra 3, Georg Stadler 4 1 Department of Mathematics North Carolina State

More information

Sub-kilometer-scale space-time stochastic rainfall simulation

Sub-kilometer-scale space-time stochastic rainfall simulation Picture: Huw Alexander Ogilvie Sub-kilometer-scale space-time stochastic rainfall simulation Lionel Benoit (University of Lausanne) Gregoire Mariethoz (University of Lausanne) Denis Allard (INRA Avignon)

More information

Polynomial Chaos Expansion of random coefficients and the solution of stochastic partial differential equations in the Tensor Train format

Polynomial Chaos Expansion of random coefficients and the solution of stochastic partial differential equations in the Tensor Train format Polynomial Chaos Expansion of random coefficients and the solution of stochastic partial differential equations in the Tensor Train format arxiv:1503.03210v1 [math.na] 11 Mar 2015 Sergey Dolgov Boris N.

More information

What Should We Do with Radioactive Waste?

What Should We Do with Radioactive Waste? What Should We Do with Radioactive Waste? Andrew Cliffe School of Mathematical Sciences University of Nottingham Simulation of Flow in Porous Media and Applications in Waste Management and CO 2 Sequestration

More information

Algorithms for Uncertainty Quantification

Algorithms for Uncertainty Quantification Algorithms for Uncertainty Quantification Lecture 9: Sensitivity Analysis ST 2018 Tobias Neckel Scientific Computing in Computer Science TUM Repetition of Previous Lecture Sparse grids in Uncertainty Quantification

More information

Intro BCS/Low Rank Model Inference/Comparison Summary References. UQTk. A Flexible Python/C++ Toolkit for Uncertainty Quantification

Intro BCS/Low Rank Model Inference/Comparison Summary References. UQTk. A Flexible Python/C++ Toolkit for Uncertainty Quantification A Flexible Python/C++ Toolkit for Uncertainty Quantification Bert Debusschere, Khachik Sargsyan, Cosmin Safta, Prashant Rai, Kenny Chowdhary bjdebus@sandia.gov Sandia National Laboratories, Livermore,

More information

Frequentist-Bayesian Model Comparisons: A Simple Example

Frequentist-Bayesian Model Comparisons: A Simple Example Frequentist-Bayesian Model Comparisons: A Simple Example Consider data that consist of a signal y with additive noise: Data vector (N elements): D = y + n The additive noise n has zero mean and diagonal

More information

NONLOCALITY AND STOCHASTICITY TWO EMERGENT DIRECTIONS FOR APPLIED MATHEMATICS. Max Gunzburger

NONLOCALITY AND STOCHASTICITY TWO EMERGENT DIRECTIONS FOR APPLIED MATHEMATICS. Max Gunzburger NONLOCALITY AND STOCHASTICITY TWO EMERGENT DIRECTIONS FOR APPLIED MATHEMATICS Max Gunzburger Department of Scientific Computing Florida State University North Carolina State University, March 10, 2011

More information

The Bayesian approach to inverse problems

The Bayesian approach to inverse problems The Bayesian approach to inverse problems Youssef Marzouk Department of Aeronautics and Astronautics Center for Computational Engineering Massachusetts Institute of Technology ymarz@mit.edu, http://uqgroup.mit.edu

More information

Introduction to Uncertainty Quantification in Computational Science Handout #3

Introduction to Uncertainty Quantification in Computational Science Handout #3 Introduction to Uncertainty Quantification in Computational Science Handout #3 Gianluca Iaccarino Department of Mechanical Engineering Stanford University June 29 - July 1, 2009 Scuola di Dottorato di

More information

A regularized least-squares method for sparse low-rank approximation of multivariate functions

A regularized least-squares method for sparse low-rank approximation of multivariate functions Workshop Numerical methods for high-dimensional problems April 18, 2014 A regularized least-squares method for sparse low-rank approximation of multivariate functions Mathilde Chevreuil joint work with

More information

A short introduction to INLA and R-INLA

A short introduction to INLA and R-INLA A short introduction to INLA and R-INLA Integrated Nested Laplace Approximation Thomas Opitz, BioSP, INRA Avignon Workshop: Theory and practice of INLA and SPDE November 7, 2018 2/21 Plan for this talk

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Efficient Solvers for Stochastic Finite Element Saddle Point Problems

Efficient Solvers for Stochastic Finite Element Saddle Point Problems Efficient Solvers for Stochastic Finite Element Saddle Point Problems Catherine E. Powell c.powell@manchester.ac.uk School of Mathematics University of Manchester, UK Efficient Solvers for Stochastic Finite

More information

Covariance function estimation in Gaussian process regression

Covariance function estimation in Gaussian process regression Covariance function estimation in Gaussian process regression François Bachoc Department of Statistics and Operations Research, University of Vienna WU Research Seminar - May 2015 François Bachoc Gaussian

More information

Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets

Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets Abhirup Datta 1 Sudipto Banerjee 1 Andrew O. Finley 2 Alan E. Gelfand 3 1 University of Minnesota, Minneapolis,

More information

Disease mapping with Gaussian processes

Disease mapping with Gaussian processes EUROHEIS2 Kuopio, Finland 17-18 August 2010 Aki Vehtari (former Helsinki University of Technology) Department of Biomedical Engineering and Computational Science (BECS) Acknowledgments Researchers - Jarno

More information

Polynomial Chaos and Karhunen-Loeve Expansion

Polynomial Chaos and Karhunen-Loeve Expansion Polynomial Chaos and Karhunen-Loeve Expansion 1) Random Variables Consider a system that is modeled by R = M(x, t, X) where X is a random variable. We are interested in determining the probability of the

More information

Machine Learning - MT & 5. Basis Expansion, Regularization, Validation

Machine Learning - MT & 5. Basis Expansion, Regularization, Validation Machine Learning - MT 2016 4 & 5. Basis Expansion, Regularization, Validation Varun Kanade University of Oxford October 19 & 24, 2016 Outline Basis function expansion to capture non-linear relationships

More information

Application and validation of polynomial chaos methods to quantify uncertainties in simulating the Gulf of Mexico circulation using HYCOM.

Application and validation of polynomial chaos methods to quantify uncertainties in simulating the Gulf of Mexico circulation using HYCOM. Application and validation of polynomial chaos methods to quantify uncertainties in simulating the Gulf of Mexico circulation using HYCOM. Mohamed Iskandarani Matthieu Le Hénaff Carlisle Thacker University

More information

Uncertainty Quantification in Computational Models

Uncertainty Quantification in Computational Models Uncertainty Quantification in Computational Models Habib N. Najm Sandia National Laboratories, Livermore, CA, USA Workshop on Understanding Climate Change from Data (UCC11) University of Minnesota, Minneapolis,

More information

At-A-Glance SIAM Events Mobile App

At-A-Glance SIAM Events Mobile App At-A-Glance SIAM Events Mobile App Scan the QR code with any QR reader and download the TripBuilder EventMobile app to your iphone, ipad, itouch or Android mobile device.you can also visit www.tripbuildermedia.com/apps/siamevents

More information

A Posteriori Adaptive Low-Rank Approximation of Probabilistic Models

A Posteriori Adaptive Low-Rank Approximation of Probabilistic Models A Posteriori Adaptive Low-Rank Approximation of Probabilistic Models Rainer Niekamp and Martin Krosche. Institute for Scientific Computing TU Braunschweig ILAS: 22.08.2011 A Posteriori Adaptive Low-Rank

More information

Learning gradients: prescriptive models

Learning gradients: prescriptive models Department of Statistical Science Institute for Genome Sciences & Policy Department of Computer Science Duke University May 11, 2007 Relevant papers Learning Coordinate Covariances via Gradients. Sayan

More information

Dinesh Kumar, Mehrdad Raisee and Chris Lacor

Dinesh Kumar, Mehrdad Raisee and Chris Lacor Dinesh Kumar, Mehrdad Raisee and Chris Lacor Fluid Mechanics and Thermodynamics Research Group Vrije Universiteit Brussel, BELGIUM dkumar@vub.ac.be; m_raisee@yahoo.com; chris.lacor@vub.ac.be October, 2014

More information

Steps in Uncertainty Quantification

Steps in Uncertainty Quantification Steps in Uncertainty Quantification Challenge: How do we do uncertainty quantification for computationally expensive models? Example: We have a computational budget of 5 model evaluations. Bayesian inference

More information

STA414/2104. Lecture 11: Gaussian Processes. Department of Statistics

STA414/2104. Lecture 11: Gaussian Processes. Department of Statistics STA414/2104 Lecture 11: Gaussian Processes Department of Statistics www.utstat.utoronto.ca Delivered by Mark Ebden with thanks to Russ Salakhutdinov Outline Gaussian Processes Exam review Course evaluations

More information

Collocation based high dimensional model representation for stochastic partial differential equations

Collocation based high dimensional model representation for stochastic partial differential equations Collocation based high dimensional model representation for stochastic partial differential equations S Adhikari 1 1 Swansea University, UK ECCM 2010: IV European Conference on Computational Mechanics,

More information

Tensor Sparsity and Near-Minimal Rank Approximation for High-Dimensional PDEs

Tensor Sparsity and Near-Minimal Rank Approximation for High-Dimensional PDEs Tensor Sparsity and Near-Minimal Rank Approximation for High-Dimensional PDEs Wolfgang Dahmen, RWTH Aachen Collaborators: Markus Bachmayr, Ron DeVore, Lars Grasedyck, Endre Süli Paris, Oct.11, 2013 W.

More information

Computation fundamentals of discrete GMRF representations of continuous domain spatial models

Computation fundamentals of discrete GMRF representations of continuous domain spatial models Computation fundamentals of discrete GMRF representations of continuous domain spatial models Finn Lindgren September 23 2015 v0.2.2 Abstract The fundamental formulas and algorithms for Bayesian spatial

More information

arxiv: v2 [math.na] 8 Apr 2017

arxiv: v2 [math.na] 8 Apr 2017 A LOW-RANK MULTIGRID METHOD FOR THE STOCHASTIC STEADY-STATE DIFFUSION PROBLEM HOWARD C. ELMAN AND TENGFEI SU arxiv:1612.05496v2 [math.na] 8 Apr 2017 Abstract. We study a multigrid method for solving large

More information

Overview of Spatial Statistics with Applications to fmri

Overview of Spatial Statistics with Applications to fmri with Applications to fmri School of Mathematics & Statistics Newcastle University April 8 th, 2016 Outline Why spatial statistics? Basic results Nonstationary models Inference for large data sets An example

More information

Fully Bayesian Deep Gaussian Processes for Uncertainty Quantification

Fully Bayesian Deep Gaussian Processes for Uncertainty Quantification Fully Bayesian Deep Gaussian Processes for Uncertainty Quantification N. Zabaras 1 S. Atkinson 1 Center for Informatics and Computational Science Department of Aerospace and Mechanical Engineering University

More information

Bayesian dynamic modeling for large space-time weather datasets using Gaussian predictive processes

Bayesian dynamic modeling for large space-time weather datasets using Gaussian predictive processes Bayesian dynamic modeling for large space-time weather datasets using Gaussian predictive processes Alan Gelfand 1 and Andrew O. Finley 2 1 Department of Statistical Science, Duke University, Durham, North

More information

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples Lars Grasedyck and Wolfgang Hackbusch Bericht Nr. 329 August 2011 Key words: MSC: hierarchical Tucker tensor rank tensor approximation

More information

Stochastic Elastic-Plastic Finite Element Method for Performance Risk Simulations

Stochastic Elastic-Plastic Finite Element Method for Performance Risk Simulations Stochastic Elastic-Plastic Finite Element Method for Performance Risk Simulations Boris Jeremić 1 Kallol Sett 2 1 University of California, Davis 2 University of Akron, Ohio ICASP Zürich, Switzerland August

More information

Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems

Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems Nonlinear Model Reduction for Uncertainty Quantification in Large-Scale Inverse Problems Krzysztof Fidkowski, David Galbally*, Karen Willcox* (*MIT) Computational Aerospace Sciences Seminar Aerospace Engineering

More information

A Vector-Space Approach for Stochastic Finite Element Analysis

A Vector-Space Approach for Stochastic Finite Element Analysis A Vector-Space Approach for Stochastic Finite Element Analysis S Adhikari 1 1 Swansea University, UK CST2010: Valencia, Spain Adhikari (Swansea) Vector-Space Approach for SFEM 14-17 September, 2010 1 /

More information

PC EXPANSION FOR GLOBAL SENSITIVITY ANALYSIS OF NON-SMOOTH FUNCTIONALS OF UNCERTAIN STOCHASTIC DIFFERENTIAL EQUATIONS SOLUTIONS

PC EXPANSION FOR GLOBAL SENSITIVITY ANALYSIS OF NON-SMOOTH FUNCTIONALS OF UNCERTAIN STOCHASTIC DIFFERENTIAL EQUATIONS SOLUTIONS PC EXPANSION FOR GLOBAL SENSITIVITY ANALYSIS OF NON-SMOOTH FUNCTIONALS OF UNCERTAIN STOCHASTIC DIFFERENTIAL EQUATIONS SOLUTIONS M. Navarro, O.P. Le Maître,2, O.M. Knio,3 mariaisabel.navarrojimenez@kaust.edu.sa

More information

Multilevel stochastic collocations with dimensionality reduction

Multilevel stochastic collocations with dimensionality reduction Multilevel stochastic collocations with dimensionality reduction Ionut Farcas TUM, Chair of Scientific Computing in Computer Science (I5) 27.01.2017 Outline 1 Motivation 2 Theoretical background Uncertainty

More information

Matrix assembly by low rank tensor approximation

Matrix assembly by low rank tensor approximation Matrix assembly by low rank tensor approximation Felix Scholz 13.02.2017 References Angelos Mantzaflaris, Bert Juettler, Boris Khoromskij, and Ulrich Langer. Matrix generation in isogeometric analysis

More information

Uncertainty Quantification of Two-Phase Flow in Heterogeneous Porous Media

Uncertainty Quantification of Two-Phase Flow in Heterogeneous Porous Media Uncertainty Quantification of Two-Phase Flow in Heterogeneous Porous Media M.Köppel, C.Rohde Institute for Applied Analysis and Numerical Simulation Inria, Nov 15th, 2016 Porous Media Examples: sponge,

More information

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt.

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt. SINGAPORE SHANGHAI Vol TAIPEI - Interdisciplinary Mathematical Sciences 19 Kernel-based Approximation Methods using MATLAB Gregory Fasshauer Illinois Institute of Technology, USA Michael McCourt University

More information

Estimating functional uncertainty using polynomial chaos and adjoint equations

Estimating functional uncertainty using polynomial chaos and adjoint equations 0. Estimating functional uncertainty using polynomial chaos and adjoint equations February 24, 2011 1 Florida State University, Tallahassee, Florida, Usa 2 Moscow Institute of Physics and Technology, Moscow,

More information

Tensor-Product Representation of Operators and Functions (7 introductory lectures) Boris N. Khoromskij

Tensor-Product Representation of Operators and Functions (7 introductory lectures) Boris N. Khoromskij 1 Everything should be made as simple as possible, but not simpler. A. Einstein (1879-1955) Tensor-Product Representation of Operators and Functions (7 introductory lectures) Boris N. Khoromskij University

More information

Chapter 4 - Fundamentals of spatial processes Lecture notes

Chapter 4 - Fundamentals of spatial processes Lecture notes Chapter 4 - Fundamentals of spatial processes Lecture notes Geir Storvik January 21, 2013 STK4150 - Intro 2 Spatial processes Typically correlation between nearby sites Mostly positive correlation Negative

More information

Uncertainty Quantification in Discrete Fracture Network Models

Uncertainty Quantification in Discrete Fracture Network Models Uncertainty Quantification in Discrete Fracture Network Models Claudio Canuto Dipartimento di Scienze Matematiche, Politecnico di Torino claudio.canuto@polito.it Joint work with Stefano Berrone, Sandra

More information

Polynomial chaos expansions for structural reliability analysis

Polynomial chaos expansions for structural reliability analysis DEPARTMENT OF CIVIL, ENVIRONMENTAL AND GEOMATIC ENGINEERING CHAIR OF RISK, SAFETY & UNCERTAINTY QUANTIFICATION Polynomial chaos expansions for structural reliability analysis B. Sudret & S. Marelli Incl.

More information

4. Multi-linear algebra (MLA) with Kronecker-product data.

4. Multi-linear algebra (MLA) with Kronecker-product data. ect. 3. Tensor-product interpolation. Introduction to MLA. B. Khoromskij, Leipzig 2007(L3) 1 Contents of Lecture 3 1. Best polynomial approximation. 2. Error bound for tensor-product interpolants. - Polynomial

More information

Sparse Tensor Galerkin Discretizations for First Order Transport Problems

Sparse Tensor Galerkin Discretizations for First Order Transport Problems Sparse Tensor Galerkin Discretizations for First Order Transport Problems Ch. Schwab R. Hiptmair, E. Fonn, K. Grella, G. Widmer ETH Zürich, Seminar for Applied Mathematics IMA WS Novel Discretization Methods

More information

Galerkin Methods for Linear and Nonlinear Elliptic Stochastic Partial Differential Equations

Galerkin Methods for Linear and Nonlinear Elliptic Stochastic Partial Differential Equations ScientifiComputing Galerkin Methods for Linear and Nonlinear Elliptic Stochastic Partial Differential Equations Hermann G. Matthies, Andreas Keese Institute of Scientific Computing Technical University

More information

Gaussian Processes for Computer Experiments

Gaussian Processes for Computer Experiments Gaussian Processes for Computer Experiments Jeremy Oakley School of Mathematics and Statistics, University of Sheffield www.jeremy-oakley.staff.shef.ac.uk 1 / 43 Computer models Computer model represented

More information

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 6, No., pp. 578 59 c Society for Industrial and Applied Mathematics STOCHASTIC SOLUTIONS FOR THE TWO-DIMENSIONAL ADVECTION-DIFFUSION EQUATION XIAOLIANG WAN, DONGBIN XIU, AND GEORGE

More information

Multilevel Sequential 2 Monte Carlo for Bayesian Inverse Problems

Multilevel Sequential 2 Monte Carlo for Bayesian Inverse Problems Jonas Latz 1 Multilevel Sequential 2 Monte Carlo for Bayesian Inverse Problems Jonas Latz Technische Universität München Fakultät für Mathematik Lehrstuhl für Numerische Mathematik jonas.latz@tum.de November

More information

Bayesian Inverse problem, Data assimilation and Localization

Bayesian Inverse problem, Data assimilation and Localization Bayesian Inverse problem, Data assimilation and Localization Xin T Tong National University of Singapore ICIP, Singapore 2018 X.Tong Localization 1 / 37 Content What is Bayesian inverse problem? What is

More information

NUMERICAL METHODS WITH TENSOR REPRESENTATIONS OF DATA

NUMERICAL METHODS WITH TENSOR REPRESENTATIONS OF DATA NUMERICAL METHODS WITH TENSOR REPRESENTATIONS OF DATA Institute of Numerical Mathematics of Russian Academy of Sciences eugene.tyrtyshnikov@gmail.com 2 June 2012 COLLABORATION MOSCOW: I.Oseledets, D.Savostyanov

More information

Multigrid and stochastic sparse-grids techniques for PDE control problems with random coefficients

Multigrid and stochastic sparse-grids techniques for PDE control problems with random coefficients Multigrid and stochastic sparse-grids techniques for PDE control problems with random coefficients Università degli Studi del Sannio Dipartimento e Facoltà di Ingegneria, Benevento, Italia Random fields

More information

Sequential Monte Carlo Samplers for Applications in High Dimensions

Sequential Monte Carlo Samplers for Applications in High Dimensions Sequential Monte Carlo Samplers for Applications in High Dimensions Alexandros Beskos National University of Singapore KAUST, 26th February 2014 Joint work with: Dan Crisan, Ajay Jasra, Nik Kantas, Alex

More information

Multivariate modelling and efficient estimation of Gaussian random fields with application to roller data

Multivariate modelling and efficient estimation of Gaussian random fields with application to roller data Multivariate modelling and efficient estimation of Gaussian random fields with application to roller data Reinhard Furrer, UZH PASI, Búzios, 14-06-25 NZZ.ch Motivation Microarray data: construct alternative

More information

A Note on the comparison of Nearest Neighbor Gaussian Process (NNGP) based models

A Note on the comparison of Nearest Neighbor Gaussian Process (NNGP) based models A Note on the comparison of Nearest Neighbor Gaussian Process (NNGP) based models arxiv:1811.03735v1 [math.st] 9 Nov 2018 Lu Zhang UCLA Department of Biostatistics Lu.Zhang@ucla.edu Sudipto Banerjee UCLA

More information

1. Structured representation of high-order tensors revisited. 2. Multi-linear algebra (MLA) with Kronecker-product data.

1. Structured representation of high-order tensors revisited. 2. Multi-linear algebra (MLA) with Kronecker-product data. Lect. 4. Toward MLA in tensor-product formats B. Khoromskij, Leipzig 2007(L4) 1 Contents of Lecture 4 1. Structured representation of high-order tensors revisited. - Tucker model. - Canonical (PARAFAC)

More information

Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems

Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems Bayesian Methods and Uncertainty Quantification for Nonlinear Inverse Problems John Bardsley, University of Montana Collaborators: H. Haario, J. Kaipio, M. Laine, Y. Marzouk, A. Seppänen, A. Solonen, Z.

More information

Research Article Multiresolution Analysis for Stochastic Finite Element Problems with Wavelet-Based Karhunen-Loève Expansion

Research Article Multiresolution Analysis for Stochastic Finite Element Problems with Wavelet-Based Karhunen-Loève Expansion Mathematical Problems in Engineering Volume 2012, Article ID 215109, 15 pages doi:10.1155/2012/215109 Research Article Multiresolution Analysis for Stochastic Finite Element Problems with Wavelet-Based

More information

Spatial Inference of Nitrate Concentrations in Groundwater

Spatial Inference of Nitrate Concentrations in Groundwater Spatial Inference of Nitrate Concentrations in Groundwater Dawn Woodard Operations Research & Information Engineering Cornell University joint work with Robert Wolpert, Duke Univ. Dept. of Statistical

More information

Tensor networks, TT (Matrix Product States) and Hierarchical Tucker decomposition

Tensor networks, TT (Matrix Product States) and Hierarchical Tucker decomposition Tensor networks, TT (Matrix Product States) and Hierarchical Tucker decomposition R. Schneider (TUB Matheon) John von Neumann Lecture TU Munich, 2012 Setting - Tensors V ν := R n, H d = H := d ν=1 V ν

More information