Uncertainty Quantification

Size: px
Start display at page:

Download "Uncertainty Quantification"

Transcription

1 Uncertaint Quantification in Computational Models Habib N. Najm Sandia National Laboratories Livermore, CA, USA Computational Infrastructure for Geodnamics (CIG) Webinar, UC Davis, CA Feb 11, 2016 SNL Najm UQ in Computations 1 / 42

2 Acknowledgement B.J. Debusschere, R.D. Berr, K. Sargsan, C. Safta, K. Chowdhar, M. Khalil Sandia National Laboratories, CA R.G. Ghanem U. South. California, Los Angeles, CA O.M. Knio Duke Univ., Durham, NC O.P. Le Maître CNRS, Paris, France Y.M. Marzouk Mass. Inst. of Tech., Cambridge, MA This work was supported b: DOE Office of Advanced Scientific Computing Research (ASCR), Scientific Discover through Advanced Computing (SciDAC) DOE ASCR Applied Mathematics program. DOE Office of Basic Energ Sciences, Div. of Chem. Sci., Geosci., & Biosci. Sandia National Laboratories is a multiprogram laborator operated b Sandia Corporation, a Lockheed Martin Compan, for the United States Department of Energ under contract DE-AC04-94-AL SNL Najm UQ in Computations 2 / 42

3 Uncertaint Quantification and Computational Science /)$%&0+!"#$%&'(")'*+,"-.*+ 1%&$%& (")0+ + 2'3'#.&.30+ = f() + Forward problem SNL Najm UQ in Computations 3 / 42

4 Uncertaint Quantification and Computational Science /)$%&0+!"#$%&'(")'*+,"-.*+ 1%&$%& (")0+ + 2'3'#.&.30+ = f() +,.'0%3.#.)&+,"-.*+ z = g() + 6'&'+ Inverse & Forward problems SNL Najm UQ in Computations 3 / 42

5 Uncertaint Quantification and Computational Science /)$%&0+!"#$%&'(")'*+,"-.*+ 1%&$%& (")0+ + 2'3'#.&.30+ = f() +,.'0%3.#.)&+,"-.*+ z = g() + 6'&'+ z d+ Inverse & Forward UQ SNL Najm UQ in Computations 3 / 42

6 Uncertaint Quantification and Computational Science d+ ={f 1 (), f 2 ()7+87+f M ()}+ /)$%&0+!"#$%&'(")'*+,"-.*+ 1%&$%& (")0+ + 2'3'#.&.30+ = f() +,.'0%3.#.)&+,"-.*+ z = g() + 6'&'+ z d+ Inverse & Forward UQ Model validation & comparison, Hpothesis testing SNL Najm UQ in Computations 3 / 42

7 Outline Introduction ForwardPC Baes Closure 1 Introduction 2 Forward UQ - Polnomial Chaos 3 Inverse Problem - Baesian Inference 4 Closure SNL Najm UQ in Computations 4 / 42

8 Forward propagation of parametric uncertaint Forward model: = f() Local sensitivit analsis (SA) and error propagation = df d 0 This is ok for: small uncertaint low degree of non-linearit in f() Non-probabilistic methods Fuzz logic Evidence theor Dempster-Shafer theor Interval math Probabilistic methods this is our focus SNL Najm UQ in Computations 5 / 42

9 Probabilistic Forward UQ = f() Represent uncertain quantities using probabilit theor Random sampling, MC, QMC Generate random samples { i } N i=1 from the PDF of, p() Bin the corresponding { i } to construct p() Not feasible for computationall epensive f() slow convergence of MC/QMC methods ver large N required for reliable estimates Build a cheap surrogate for f(), then use MC Collocation interpolants Regression fitting Galerkin methods Polnomial Chaos (PC) Intrusive and non-intrusive PC methods SNL Najm UQ in Computations 6 / 42

10 Probabilistic Forward UQ & Polnomial Chaos Representation of Random Variables With = f(), a random variable, estimate the RV Can describe a RV in terms of its densit, moments, characteristic function, or as a function on a probabilit space Constraining the analsis to RVs with finite variance Represent RV as a spectral epansion in terms of orthogonal functions of standard RVs Polnomial Chaos Epansion Enables the use of available functional analsis methods for forward UQ SNL Najm UQ in Computations 7 / 42

11 Polnomial Chaos Epansion (PCE) Model uncertain quantities as random variables (RVs) Given a germ ξ(ω) = {ξ 1,, ξ n } a set of i.i.d. RVs where p(ξ) is uniquel determined b its moments An RV in L 2 (Ω, S(ξ), P ) can be written as a PCE: u(, t, ω) = f(, t, ξ) P u k (, t)ψ k (ξ(ω)) k=0 u k (, t) are mode strengths Ψ k () are multivariate functions orthogonal w.r.t. p(ξ) SNL Najm UQ in Computations 8 / 42

12 Orthogonalit B construction, the functions Ψ k () are orthogonal with respect to the densit of ξ u k (, t) = uψ k Ψ 2 k = 1 Ψ 2 k u(, t; λ(ξ))ψ k (ξ) p ξ (ξ) dξ Eamples: Hermite polnomials with Gaussian basis Legendre polnomials with Uniform basis,... Global versus Local PC methods Adaptive domain decomposition of the support of ξ SNL Najm UQ in Computations 9 / 42

13 PC Illustration: WH PCE for a Lognormal RV Lognormal; WH PC order = 1 u = Wiener-Hermite PCE constructed for a Lognormal RV PCE-sampled PDF superposed on true PDF Order = 1 P u k Ψ k (ξ) k=0 = u 0 + u 1 ξ eact-pdf PCE-PDF SNL Najm UQ in Computations 10 / 42

14 PC Illustration: WH PCE for a Lognormal RV Lognormal; WH PC order = 2 u = Wiener-Hermite PCE constructed for a Lognormal RV PCE-sampled PDF superposed on true PDF Order = 2 P u k Ψ k (ξ) k= = u 0 + u 1 ξ + u 2 (ξ 2 1) 0 eact-pdf PCE-PDF SNL Najm UQ in Computations 10 / 42

15 PC Illustration: WH PCE for a Lognormal RV u = Wiener-Hermite PCE constructed for a Lognormal RV PCE-sampled PDF superposed on true PDF Order = 3 P u k Ψ k (ξ) k=0 = u 0 + u 1 ξ + u 2 (ξ 2 1) + u 3 (ξ 3 3ξ) Lognormal; WH PC order = 3 eact-pdf PCE-PDF SNL Najm UQ in Computations 10 / 42

16 PC Illustration: WH PCE for a Lognormal RV u = Wiener-Hermite PCE constructed for a Lognormal RV PCE-sampled PDF superposed on true PDF Order = 4 P u k Ψ k (ξ) k= Lognormal; WH PC order = 4 eact-pdf PCE-PDF = u 0 + u 1 ξ + u 2 (ξ 2 1) + u 3 (ξ 3 3ξ) + u 4 (ξ 4 6ξ 2 + 3) SNL Najm UQ in Computations 10 / 42

17 PC Illustration: WH PCE for a Lognormal RV u = Wiener-Hermite PCE constructed for a Lognormal RV PCE-sampled PDF superposed on true PDF Order = 5 P u k Ψ k (ξ) k= Lognormal; WH PC order = 5 eact-pdf PCE-PDF = u 0 + u 1 ξ + u 2 (ξ 2 1) + u 3 (ξ 3 3ξ) + u 4 (ξ 4 6ξ 2 + 3) + u 5 (ξ 5 10ξ ξ) SNL Najm UQ in Computations 10 / 42

18 Random Fields A random variable is a function on an event space Ω No dependence on other coordinates e.g. space or time A random field is a function on a product space Ω D e.g. sea surface temperature T SS (z, ω), z (, t) It is a more comple object than a random variable A combination of an infinite number of random variables In man phsical sstems, uncertain field quantities, described b random fields: are smooth, i.e. the have an underling low dimensional structure due to large correlation length-scales SNL Najm UQ in Computations 11 / 42

19 Random Fields KLE Smooth random fields can be represented with a small no. of stochastic degrees of freedom A random field M(, ω) with a mean function: µ() a continuous covariance function: C( 1, 2 ) = [M( 1, ω) µ( 1 )][M( 2, ω) µ( 2 )] can be represented with the Karhunen-Loeve Epansion (KLE) M(, ω) = µ() + λi η i (ω)φ i () i=1 where λ i and φ i () are the eigenvalues and eigenfunctions of the covariance function C(, ) η i are uncorrelated zero-mean unit-variance RVs KLE representation of random fields using PC SNL Najm UQ in Computations 12 / 42

20 RF Illustration: KL of 2D Gaussian Process δ = 0.1 δ = δ = 0.5 2D Gaussian Process with covariance: C( 1, 2 ) = ep( /δ 2 ) Realizations smoother as covariance length δ increases SNL Najm UQ in Computations 13 / 42

21 Introduction ForwardPC Baes Closure RF Illustration: 2D KL - Modes for δ = φ1 SNL Najm 0.5 φ4 φ3 0.1 φ2 UQ in Computations 14 / 42

22 RF Illustration: 2D KL - eigenvalue spectrum δ = terms 16 terms Eigenvalue Magnitude δ =0.1 δ = δ = Eigenvalue # 32 terms 64 terms SNL Najm UQ in Computations 15 / 42

23 RF Illustration: 2D KL - eigenvalue spectrum δ = 4 terms 16 terms Eigenvalue Magnitude δ =0.1 δ = δ = Eigenvalue # 32 terms 64 terms SNL Najm UQ in Computations 16 / 42

24 RF Illustration: 2D KL - eigenvalue spectrum δ = terms 16 terms Eigenvalue Magnitude δ =0.1 δ = δ = Eigenvalue # 32 terms 64 terms SNL Najm UQ in Computations 17 / 42

25 Essential Use of PC in UQ Strateg: Represent model parameters/solution as random variables Construct PCEs for uncertain parameters Evaluate PCEs for model outputs Advantages: Computational efficienc Utilit Requirement: Moments: E(u) = u 0, var(u) = P k=1 u2 k Ψ2 k,... Global Sensitivities fractional variances, Sobol indices Surrogate for forward model RVs in L 2, i.e. with finite variance, on (Ω, S(ξ), P ) SNL Najm UQ in Computations 18 / 42

26 Intrusive PC UQ: A direct non-sampling method Given model equations: M(u(, t); λ) = 0 Epress uncertain parameters/variables using PCEs u = P u k Ψ k ; λ = k=0 P λ k Ψ k k=0 Substitute in model equations; appl Galerkin projection G(U(, t), Λ) = 0 New set of equations: with U = [u 0,..., u P ] T, Λ = [λ 0,..., λ P ] T Solving this deterministic sstem once provides the full specification of uncertain model ouputs SNL Najm UQ in Computations 19 / 42

27 Laminar 2D Channel Flow with Uncertain Viscosit Incompressible flow Viscosit PCE ν = ν 0 + ν 1 ξ Streamwise velocit P v = v i Ψ i i=0 v 0 : mean v i : i-th order mode P σ 2 = Ψ 2 i i=1 v 2 i v0 v1 v2 v3 sd v 0 v 1 v 2 v 3 σ (Le Maître et al., J. Comput. Phs., 2001) SNL Najm UQ in Computations 20 / 42

28 Intrusive PC UQ Pros/Cons Cons: Pros: Reformulation of governing equations New discretizations New numerical solution method Consistenc, Convergence, Stabilit Global vs. multi-element local PC constructions New solvers and model codes Opportunities for automated code transformation New preconditioners Tailored solvers can deliver superior performance SNL Najm UQ in Computations 21 / 42

29 Non-intrusive PC UQ Sampling-based Relies on black-bo utilization of the computational model Evaluate projection integrals numericall For an quantit of interest φ(, t; λ) = P k=0 φ k(, t)ψ k (ξ) φ k (, t) = 1 φ(, t; λ(ξ)) Ψ Ψ 2 k (ξ)p ξ (ξ)dξ, k = 0,..., P k Integrals can be evaluated using A variet of (Quasi) Monte Carlo methods Slow convergence; indep. of dimensionalit Quadrature/Sparse-Quadrature methods Fast convergence; depends on dimensionalit SNL Najm UQ in Computations 22 / 42

30 PC and High-Dimensionalit Dimensionalit n of the PC basis: ξ = {ξ 1,..., ξ n } n number of uncertain parameters P + 1 = (n + p)!/n!p! grows fast with n Impacts: Size of intrusive PC sstem Hi-D projection integrals large # non-intrusive samples Sparse quadrature methods Clenshaw-Curtis sparse grid, Level = 3 Clenshaw-Curtis sparse grid, Level = 5 SNL Najm UQ in Computations 23 / 42

31 UQ in LES computations: turbulent bluff-bod flame with M. Khalil, G. Lacaze, & J. Oefelein, Sandia Nat. Labs CH 4 -H 2 jet, air coflow, 3D flow Re=9500, LES subgrid modeling mesh cells, 1024 cores 3 das run time, time steps 3 uncertain parameters (C s, P r t, Sc t ) 2 nd -order PC, 25 sparse-quad. pts 1 Mean aial velocit on centerline 1 RMS aial velocit on centerline Fuel jet 108m/s (3.6mm) Main-Effect Sensitivit Inde C s Pr t Sc t Main-Effect Sensitivit Inde C s Pr t Sc t Ceramic bluff-bod (50mm) 150 mm Air co-flow 35m/s Aial location (cm) Aial location (cm) J. Oefelein & G. Lacaze, SNL Main-Effect Sensitivit Indices SNL Najm UQ in Computations 24 / 42

32 Introduction ForwardPC Baes Closure UQ in Ocean Modeling Gulf of Meico A. Aleanderian, J. Winokur, I. Sraj, O.M. Knio, Duke Univ. A. Srinivasan, M. Iskandarani, Univ. Miami; W.C. Thacker, NOAA Hurricane Ivan, Sep HYCOM ocean model (hcom.org) Predicted Mied Laer Depth (MLD) Four uncertain parameters, i.i.d. U subgrid miing & wind drag params 385 sparse quadrature samples (Aleanderian et al., Winokur et. al., Comput. Geosci., 2012, 2013) SNL Najm UQ in Computations 25 / 42

33 Inverse UQ Estimation of Uncertain Parameters Forward UQ requires specification of uncertain inputs Probabilistic setting Require joint PDF on input space Statistical inference an inverse problem Baesian setting Given Data: PDF on uncertain inputs can be estimated using Baes formula Baesian Inference Given Constraints: PDF on uncertain inputs can be estimated using the Maimum Entrop principle MaEnt Methods SNL Najm UQ in Computations 26 / 42

34 Baes formula for Parameter Inference Data Model (fit model + noise model): Baes Formula: p(λ, ) = p(λ )p() = p( λ)p(λ) p(λ ) Posterior = Likelihood p( λ) Prior: knowledge of λ prior to data p() Evidence Prior p(λ) = f(λ) g(ɛ) Likelihood: forward model and measurement noise Posterior: combines information from prior and data Evidence: normalizing constant for present contet SNL Najm UQ in Computations 27 / 42

35 The Prior Prior p(λ) comes from Phsical constraints Prior data Prior knowledge The prior can be uninformative It can be chosen to impose regularization Unknown aspects of the prior can be added to the rest of the parameters as hperparameters The choice of prior can be crucial when there is little information in the data relative to the number of degrees of freedom in the inference problem When there is sufficient information in the data, the data can overrule the prior SNL Najm UQ in Computations 28 / 42

36 Construction of the Likelihood p( λ) Where does probabilit enter the mapping λ in p( λ)? Through a presumed error model: Eample: Model: m = g(λ) Data: Error between data and model prediction: ɛ = g(λ) + ɛ Model this error as a random variable Eample Error is due to instrument measurement noise Instrument has Gaussian errors, with no bias ɛ N(0, σ 2 ) SNL Najm UQ in Computations 29 / 42

37 Construction of the Likelihood p( λ) cont d For an given λ, this implies or λ, σ N(g(λ), σ 2 ) p( λ, σ) = 1 ) ( g(λ))2 ep ( 2π σ 2σ 2 Given N measurements ( 1,..., N ), and presuming independent identicall distributed (iid) noise i = g(λ) + ɛ i ɛ i N(0, σ 2 ) N L(λ) = p( 1,..., N λ, σ) = p( i λ, σ) i=1 SNL Najm UQ in Computations 30 / 42

38 Likelihood Modeling This is frequentl the core modeling challenge Error model: a statistical model for the discrepanc between the forward model and the data composition of the error model with the forward model Error model composed of discrepanc between data and the truth (data error) model prediction and the truth (model error) Mean bias and correlated/uncorrelated noise structure Hierarchical Baes modeling, and dependence trees p(φ, θ D) = p(φ θ, D)p(θ D) Choice of observable constraint on Quantit of Interest? SNL Najm UQ in Computations 31 / 42

39 Eploring the Posterior Given an sample λ, the un-normalized posterior probabilit can be easil computed p(λ ) p( λ)p(λ) Eplore posterior w/ Markov Chain Monte Carlo (MCMC) Metropolis-Hastings algorithm: Random walk with proposal PDF & rejection rules Computationall intensive, O(10 5 ) samples Each sample: evaluation of the forward model Surrogate models Evaluate moments/marginals from the MCMC statistics SNL Najm UQ in Computations 32 / 42

40 Baesian inference illustration: noise uncertaint data: = ɛ ɛ N (0, σ 2 ), σ = {0.1, 0.5, } Fit model = a 2 + b + c Marginal posterior densit p(a, c): SNL Najm UQ in Computations 33 / 42

41 Baesian inference High Dimensionalit Challenge Judgement on local/global posterior peaks is difficult Multiple chains; Tempering Choosing a good starting point is ver important An initial optimization strateg is useful, albeit not trivial Choosing good MCMC proposals, and attaining good miing Likelihood-informed Markov jump in those dimensions informed b data Sample from prior in complement of dimensions Adaptive proposal learning from MCMC samples Log-Posterior Hessian local Gaussian appro. Adaptive, Geometric, Langevin MCMC Dimension independent Proposal design: good MCMC performance in hid Literature: A. Stuart, M. Girolami, K. Law, T. Cui, Y. Marzouk (Law 2014; Cui et al., 2014,2015; Cotter et al., 2013) SNL Najm UQ in Computations 34 / 42

42 Baesian inference Model Error Challenge Quantifing model error, as distinct from data noise, is important for assessing confidence in model validit Conventional statistical methods for representation of model error have shortcomings when applied to phsical models New methods are under-development for model error: phsical constraints are satisfied feasible disambiguation of model-error/data-noise calibrated model error terms adequatel impact all model outputs of interest uncertainties in predictions from calibrated model reflect the range of discrepanc from the truth Embed model error in submodel components where approimations eist (K. Sargsan et al., 2015) SNL Najm UQ in Computations 35 / 42

43 Quadratic-fit Classical Baesian likelihood 8 7 Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f] 8 7 Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f] N = With additional data, predictive uncertaint around the wrong model is indefinitel reducible Predictive uncertaint not indicative of discrepanc from truth 2 1 N = SNL Najm UQ in Computations 36 / N = 200 Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f]

44 Quadratic-fit ModErr MargGauss 8 7 N = N = Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f] 1σ pushed-forward posterior: model error term Eα[Vξ[f]] Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f] 1σ pushed-forward posterior: model error term Eα[Vξ[f]] With additional data, predictive uncertaint due to data noise is reducible Predictive uncertaint due to model error is not reducible SNL Najm UQ in Computations 37 / Truth function g() Observations {i} with noise Mean pushed-forward posterior EPF[f] 1σ pushed-forward posterior VPF[f] 1σ pushed-forward posterior: model error term Eα[Vξ[f]] N = 200

45 Quadratic-fit ModErr MargGauss Variance Pushed-forward variance V PF[f] Model error E α[v ξ[f]] Data error V α[e ξ[f]] N Calibrating a quadratic f() w.r.t. g() = ( + 1) 3.5 SNL Najm UQ in Computations 38 / 42

46 Model Evidence and Compleit Let M = {M 1, M 2,...} be a set of models of interest Parameter estimation from data is conditioned on the model p(θ D, M k ) = p(d θ, M k)π(θ M k ) p(d M k ) Evidence (marginal likelihood) for M k : p(d M k ) = p(d θ, M k )π(θ M k )dθ Model evidence is useful for model selection Choose model with maimum evidence Compromise between fitting data and model compleit Optimal compleit Occam s razor principle Avoid overfitting SNL Najm UQ in Computations 39 / 42

47 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

48 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

49 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

50 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

51 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

52 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

53 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

54 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

55 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

56 Too much model compleit leads to overfitting Data model: i = 1,..., N i = 3 i + 2 i 6 + ɛ i ɛ i N(0, s) Order = Fitted model 4.0 Nois data True function 4.5 Baesian regression with Legendre PCE fit models, order 1-10 m = P c k ψ k () k= Uniform priors π(c k ), k = 0,..., P Fitted model pushed-forward posterior versus the data SNL Najm UQ in Computations 40 / 42

57 Evidence and Cross-Validation Error Model evidence peaks at the true polnomial order of Cross validation error is equall minimal at order 3 Models with optimal compleit are robust to cross validation Log (Evidence) Log (Validation error) Order Cross validation error and model evidence versus order SNL Najm UQ in Computations 41 / 42

58 Closure Introduction ForwardPC Baes Closure Probabilistic UQ framework Polnomial Chaos representation of random variables Forward UQ Intrusive and non-intrusive forward PC UQ methods Inverse UQ Parameter estimation via Baesian inference Model error Model compleit Challenges High dimensionalit Intrusive Galerkin stabilit Nonlinearit Time dnamics Model error SNL Najm UQ in Computations 42 / 42

Challenges in Uncertainty Quantification in Computational Models

Challenges in Uncertainty Quantification in Computational Models Introduction UQ Basics Challenges Closure Challenges in Uncertaint Quantification in Computational Models Habib N. Najm hnnajm@sandia.gov Sandia National Laboratories, Livermore, CA Computational and Theoretical

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

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

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

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

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

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

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

Stochastic Dimension Reduction

Stochastic Dimension Reduction Stochastic Dimension Reduction Roger Ghanem University of Southern California Los Angeles, CA, USA Computational and Theoretical Challenges in Interdisciplinary Predictive Modeling Over Random Fields 12th

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

Uncertainty Propagation in Puff-based Dispersion Models using Polynomial Chaos

Uncertainty Propagation in Puff-based Dispersion Models using Polynomial Chaos Uncertaint Propagation in Puff-based Dispersion Models using Polnomial Chaos Umamaheswara Konda Dept. of MAE Universit at Buffalo venkatar@buffalo.edu Tarunraj Singh Dept. of MAE Universit at Buffalo tsingh@eng.buffalo.edu

More information

SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN SALINE AQUIFERS USING THE PROBABILISTIC COLLOCATION APPROACH

SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN SALINE AQUIFERS USING THE PROBABILISTIC COLLOCATION APPROACH XIX International Conference on Water Resources CMWR 2012 University of Illinois at Urbana-Champaign June 17-22,2012 SENSITIVITY ANALYSIS IN NUMERICAL SIMULATION OF MULTIPHASE FLOW FOR CO 2 STORAGE IN

More information

Uncertainty Propagation in Puff-based Dispersion Models using Polynomial Chaos

Uncertainty Propagation in Puff-based Dispersion Models using Polynomial Chaos Uncertaint Propagation in Puff-based Dispersion Models using Polnomial Chaos Umamaheswara Konda Dept. of MAE Universit at Buffalo venkatar@buffalo.edu Tarunraj Singh Dept. of MAE Universit at Buffalo tsingh@eng.buffalo.edu

More information

Polynomial Chaos Based Uncertainty Propagation

Polynomial Chaos Based Uncertainty Propagation Polynomial Chaos Based Uncertainty Propagation Lecture 2: Forward Propagation: Intrusive and Non-Intrusive Bert Debusschere bjdebus@sandia.gov Sandia National Laboratories, Livermore, CA Aug 12, 2013 Summer

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

Polynomial chaos expansions for sensitivity analysis

Polynomial chaos expansions for sensitivity analysis c DEPARTMENT OF CIVIL, ENVIRONMENTAL AND GEOMATIC ENGINEERING CHAIR OF RISK, SAFETY & UNCERTAINTY QUANTIFICATION Polynomial chaos expansions for sensitivity analysis B. Sudret Chair of Risk, Safety & Uncertainty

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

Utilizing Adjoint-Based Techniques to Improve the Accuracy and Reliability in Uncertainty Quantification

Utilizing Adjoint-Based Techniques to Improve the Accuracy and Reliability in Uncertainty Quantification Utilizing Adjoint-Based Techniques to Improve the Accuracy and Reliability in Uncertainty Quantification Tim Wildey Sandia National Laboratories Center for Computing Research (CCR) Collaborators: E. Cyr,

More information

Dimensionality reduction and polynomial chaos acceleration of Bayesian inference in inverse problems

Dimensionality reduction and polynomial chaos acceleration of Bayesian inference in inverse problems Dimensionality reduction and polynomial chaos acceleration of Bayesian inference in inverse problems The MIT Faculty has made this article openly available. Please share how this access benefits you. Your

More information

Random Fields in Bayesian Inference: Effects of the Random Field Discretization

Random Fields in Bayesian Inference: Effects of the Random Field Discretization Random Fields in Bayesian Inference: Effects of the Random Field Discretization Felipe Uribe a, Iason Papaioannou a, Wolfgang Betz a, Elisabeth Ullmann b, Daniel Straub a a Engineering Risk Analysis Group,

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

Perturbation Theory for Variational Inference

Perturbation Theory for Variational Inference Perturbation heor for Variational Inference Manfred Opper U Berlin Marco Fraccaro echnical Universit of Denmark Ulrich Paquet Apple Ale Susemihl U Berlin Ole Winther echnical Universit of Denmark Abstract

More information

A Stochastic Collocation based. for Data Assimilation

A Stochastic Collocation based. for Data Assimilation A Stochastic Collocation based Kalman Filter (SCKF) for Data Assimilation Lingzao Zeng and Dongxiao Zhang University of Southern California August 11, 2009 Los Angeles Outline Introduction SCKF Algorithm

More information

Error Budgets: A Path from Uncertainty Quantification to Model Validation

Error Budgets: A Path from Uncertainty Quantification to Model Validation Error Budgets: A Path from Uncertainty Quantification to Model Validation Roger Ghanem Aerospace and Mechanical Engineering Civil Engineering University of Southern California Los Angeles Advanced Simulation

More information

6. Vector Random Variables

6. Vector Random Variables 6. Vector Random Variables In the previous chapter we presented methods for dealing with two random variables. In this chapter we etend these methods to the case of n random variables in the following

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

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

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

Monte Carlo integration

Monte Carlo integration Monte Carlo integration Eample of a Monte Carlo sampler in D: imagine a circle radius L/ within a square of LL. If points are randoml generated over the square, what s the probabilit to hit within circle?

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

Uncertainty Quantification and Validation Using RAVEN. A. Alfonsi, C. Rabiti. Risk-Informed Safety Margin Characterization. https://lwrs.inl.

Uncertainty Quantification and Validation Using RAVEN. A. Alfonsi, C. Rabiti. Risk-Informed Safety Margin Characterization. https://lwrs.inl. Risk-Informed Safety Margin Characterization Uncertainty Quantification and Validation Using RAVEN https://lwrs.inl.gov A. Alfonsi, C. Rabiti North Carolina State University, Raleigh 06/28/2017 Assumptions

More information

Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos

Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos Modeling Uncertainty in Steady State Diffusion Problems via Generalized Polynomial Chaos Dongbin Xiu and George Em Karniadakis Division of Applied Mathematics Brown University Providence, RI 09 Submitted

More information

Data-Driven Bayesian Model Selection: Parameter Space Dimension Reduction using Automatic Relevance Determination Priors

Data-Driven Bayesian Model Selection: Parameter Space Dimension Reduction using Automatic Relevance Determination Priors Data-Driven : Parameter Space Dimension Reduction using Priors Mohammad Khalil mkhalil@sandia.gov, Livermore, CA Workshop on Uncertainty Quantification and Data-Driven Modeling Austin, Texas March 23-24,

More information

Dimension-Independent likelihood-informed (DILI) MCMC

Dimension-Independent likelihood-informed (DILI) MCMC Dimension-Independent likelihood-informed (DILI) MCMC Tiangang Cui, Kody Law 2, Youssef Marzouk Massachusetts Institute of Technology 2 Oak Ridge National Laboratory 2 August 25 TC, KL, YM DILI MCMC USC

More information

Sobol-Hoeffding Decomposition with Application to Global Sensitivity Analysis

Sobol-Hoeffding Decomposition with Application to Global Sensitivity Analysis Sobol-Hoeffding decomposition Application to Global SA Computation of the SI Sobol-Hoeffding Decomposition with Application to Global Sensitivity Analysis Olivier Le Maître with Colleague & Friend Omar

More information

Uncertainty quantification for flow in highly heterogeneous porous media

Uncertainty quantification for flow in highly heterogeneous porous media 695 Uncertainty quantification for flow in highly heterogeneous porous media D. Xiu and D.M. Tartakovsky a a Theoretical Division, Los Alamos National Laboratory, Mathematical Modeling and Analysis Group

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

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

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

Sequential Importance Sampling for Rare Event Estimation with Computer Experiments

Sequential Importance Sampling for Rare Event Estimation with Computer Experiments Sequential Importance Sampling for Rare Event Estimation with Computer Experiments Brian Williams and Rick Picard LA-UR-12-22467 Statistical Sciences Group, Los Alamos National Laboratory Abstract Importance

More information

Density Estimation. Seungjin Choi

Density Estimation. Seungjin Choi Density Estimation Seungjin Choi Department of Computer Science and Engineering Pohang University of Science and Technology 77 Cheongam-ro, Nam-gu, Pohang 37673, Korea seungjin@postech.ac.kr http://mlg.postech.ac.kr/

More information

Multiscale stochastic preconditioners in non-intrusive spectral projection

Multiscale stochastic preconditioners in non-intrusive spectral projection Multiscale stochastic preconditioners in non-intrusive spectral projection Alen Alenxanderian a, Olivier P. Le Maître b, Habib N. Najm c, Mohamed Iskandarani d, Omar M. Knio a, a Department of Mechanical

More information

Bayesian Regression Linear and Logistic Regression

Bayesian Regression Linear and Logistic Regression When we want more than point estimates Bayesian Regression Linear and Logistic Regression Nicole Beckage Ordinary Least Squares Regression and Lasso Regression return only point estimates But what if we

More information

Solving the steady state diffusion equation with uncertainty Final Presentation

Solving the steady state diffusion equation with uncertainty Final Presentation Solving the steady state diffusion equation with uncertainty Final Presentation Virginia Forstall vhfors@gmail.com Advisor: Howard Elman elman@cs.umd.edu Department of Computer Science May 6, 2012 Problem

More information

Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos

Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos Noname manuscript No. (will be inserted by the editor) Uncertainty Evolution In Stochastic Dynamic Models Using Polynomial Chaos Umamaheswara Konda Puneet Singla Tarunraj Singh Peter Scott Received: date

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

Uncertainty Propagation in Puff-based Dispersion Models Using Polynomial Chaos

Uncertainty Propagation in Puff-based Dispersion Models Using Polynomial Chaos Uncertaint Propagation in Puff-based Dispersion Models Using Polnomial Chaos Abstract Atmospheric dispersion is a comple nonlinear phsical process with numerous uncertainties in model parameters, inputs,

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

Machine Learning. 1. Linear Regression

Machine Learning. 1. Linear Regression Machine Learning Machine Learning 1. Linear Regression Lars Schmidt-Thieme Information Sstems and Machine Learning Lab (ISMLL) Institute for Business Economics and Information Sstems & Institute for Computer

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

Original Research. Sensitivity Analysis and Variance Reduction in a Stochastic NDT Problem

Original Research. Sensitivity Analysis and Variance Reduction in a Stochastic NDT Problem To appear in the International Journal of Computer Mathematics Vol. xx, No. xx, xx 2014, 1 9 Original Research Sensitivity Analysis and Variance Reduction in a Stochastic NDT Problem R. H. De Staelen a

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

Predictability of Chemical Systems

Predictability of Chemical Systems Predictability of Chemical Systems Habib N. Najm Sandia National Laboratories, Livermore, CA, USA Collaborators: M.T. Reagan & B.J. Debusschere O.M. Knio, A. Matta, & R.G. Ghanem O.P. Le Maitre Sandia

More information

Efficient Sampling for Non-Intrusive Polynomial Chaos Applications with Multiple Uncertain Input Variables

Efficient Sampling for Non-Intrusive Polynomial Chaos Applications with Multiple Uncertain Input Variables Missouri University of Science and Technology Scholars' Mine Mechanical and Aerospace Engineering Faculty Research & Creative Works Mechanical and Aerospace Engineering 4-1-2007 Efficient Sampling for

More information

Bayesian Quadrature: Model-based Approximate Integration. David Duvenaud University of Cambridge

Bayesian Quadrature: Model-based Approximate Integration. David Duvenaud University of Cambridge Bayesian Quadrature: Model-based Approimate Integration David Duvenaud University of Cambridge The Quadrature Problem ˆ We want to estimate an integral Z = f ()p()d ˆ Most computational problems in inference

More information

Bayesian Inference. Sudhir Shankar Raman Translational Neuromodeling Unit, UZH & ETH. The Reverend Thomas Bayes ( )

Bayesian Inference. Sudhir Shankar Raman Translational Neuromodeling Unit, UZH & ETH. The Reverend Thomas Bayes ( ) The Reverend Thomas Baes (1702-1761) Baesian Inference Sudhir Shankar Raman Translational Neuromodeling Unit, UZH & ETH With man thanks for some slides to: Klaas Enno Stephan & Ka H. Brodersen Wh do I

More information

An Integrated Prognostics Method under Time-Varying Operating Conditions

An Integrated Prognostics Method under Time-Varying Operating Conditions An Integrated Prognostics Method under Time-Varying Operating Conditions Fuqiong Zhao, ZhigangTian, Eric Bechhoefer, Yong Zeng Abstract In this paper, we develop an integrated prognostics method considering

More information

Evaluation of Non-Intrusive Approaches for Wiener-Askey Generalized Polynomial Chaos

Evaluation of Non-Intrusive Approaches for Wiener-Askey Generalized Polynomial Chaos 49th AIAA/ASME/ASCE/AHS/ASC Structures, Structural Dynamics, and Materials Conference 6t 7 - April 28, Schaumburg, IL AIAA 28-892 Evaluation of Non-Intrusive Approaches for Wiener-Askey Generalized

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

Stochastic Spectral Methods for Uncertainty Quantification

Stochastic Spectral Methods for Uncertainty Quantification Stochastic Spectral Methods for Uncertainty Quantification Olivier Le Maître 1,2,3, Omar Knio 1,2 1- Duke University, Durham, North Carolina 2- KAUST, Saudi-Arabia 3- LIMSI CNRS, Orsay, France 38th Conf.

More information

Forward Problems and their Inverse Solutions

Forward Problems and their Inverse Solutions Forward Problems and their Inverse Solutions Sarah Zedler 1,2 1 King Abdullah University of Science and Technology 2 University of Texas at Austin February, 2013 Outline 1 Forward Problem Example Weather

More information

MCMC Sampling for Bayesian Inference using L1-type Priors

MCMC Sampling for Bayesian Inference using L1-type Priors MÜNSTER MCMC Sampling for Bayesian Inference using L1-type Priors (what I do whenever the ill-posedness of EEG/MEG is just not frustrating enough!) AG Imaging Seminar Felix Lucka 26.06.2012 , MÜNSTER Sampling

More information

Markov Chain Monte Carlo methods

Markov Chain Monte Carlo methods Markov Chain Monte Carlo methods Tomas McKelvey and Lennart Svensson Signal Processing Group Department of Signals and Systems Chalmers University of Technology, Sweden November 26, 2012 Today s learning

More information

Risk Estimation and Uncertainty Quantification by Markov Chain Monte Carlo Methods

Risk Estimation and Uncertainty Quantification by Markov Chain Monte Carlo Methods Risk Estimation and Uncertainty Quantification by Markov Chain Monte Carlo Methods Konstantin Zuev Institute for Risk and Uncertainty University of Liverpool http://www.liv.ac.uk/risk-and-uncertainty/staff/k-zuev/

More information

Model Calibration under Uncertainty: Matching Distribution Information

Model Calibration under Uncertainty: Matching Distribution Information Model Calibration under Uncertainty: Matching Distribution Information Laura P. Swiler, Brian M. Adams, and Michael S. Eldred September 11, 008 AIAA Multidisciplinary Analysis and Optimization Conference

More information

Bayesian Inverse Problems

Bayesian Inverse Problems Bayesian Inverse Problems Jonas Latz Input/Output: www.latz.io Technical University of Munich Department of Mathematics, Chair for Numerical Analysis Email: jonas.latz@tum.de Garching, July 10 2018 Guest

More information

Riemann Manifold Methods in Bayesian Statistics

Riemann Manifold Methods in Bayesian Statistics Ricardo Ehlers ehlers@icmc.usp.br Applied Maths and Stats University of São Paulo, Brazil Working Group in Statistical Learning University College Dublin September 2015 Bayesian inference is based on Bayes

More information

Practical unbiased Monte Carlo for Uncertainty Quantification

Practical unbiased Monte Carlo for Uncertainty Quantification Practical unbiased Monte Carlo for Uncertainty Quantification Sergios Agapiou Department of Statistics, University of Warwick MiR@W day: Uncertainty in Complex Computer Models, 2nd February 2015, University

More information

Uncertainty Quantification in Multiscale Models

Uncertainty Quantification in Multiscale Models Uncertainty Quantification in Multiscale Models H.N. Najm Sandia National Laboratories Livermore, CA Workshop on Stochastic Multiscale Methods: Mathematical Analysis and Algorithms Univ. Southern California,

More information

Global sensitivity analysis in an ocean general circulation model: a sparse spectral projection approach

Global sensitivity analysis in an ocean general circulation model: a sparse spectral projection approach Computational Geosciences manuscript No. (will be inserted by the editor) Global sensitivity analysis in an ocean general circulation model: a sparse spectral projection approach Alen Alexanderian Justin

More information

Review of Probability

Review of Probability Review of robabilit robabilit Theor: Man techniques in speech processing require the manipulation of probabilities and statistics. The two principal application areas we will encounter are: Statistical

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 Bayesian Data Analysis

Introduction to Bayesian Data Analysis Introduction to Bayesian Data Analysis Phil Gregory University of British Columbia March 2010 Hardback (ISBN-10: 052184150X ISBN-13: 9780521841504) Resources and solutions This title has free Mathematica

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

arxiv: v1 [math.na] 14 Sep 2017

arxiv: v1 [math.na] 14 Sep 2017 Stochastic collocation approach with adaptive mesh refinement for parametric uncertainty analysis arxiv:1709.04584v1 [math.na] 14 Sep 2017 Anindya Bhaduri a, Yanyan He 1b, Michael D. Shields a, Lori Graham-Brady

More information

A Stochastic Projection Method for Fluid Flow

A Stochastic Projection Method for Fluid Flow Journal of Computational Physics 8, 9 44 (22) doi:.6/jcph.22.74 A Stochastic Projection Method for Fluid Flow II. Random Process Olivier P. Le Maître, Matthew T. Reagan, Habib N. Najm, Roger G. Ghanem,

More information

Quadrature for Uncertainty Analysis Stochastic Collocation. What does quadrature have to do with uncertainty?

Quadrature for Uncertainty Analysis Stochastic Collocation. What does quadrature have to do with uncertainty? Quadrature for Uncertainty Analysis Stochastic Collocation What does quadrature have to do with uncertainty? Quadrature for Uncertainty Analysis Stochastic Collocation What does quadrature have to do with

More information

PART I INTRODUCTION The meaning of probability Basic definitions for frequentist statistics and Bayesian inference Bayesian inference Combinatorics

PART I INTRODUCTION The meaning of probability Basic definitions for frequentist statistics and Bayesian inference Bayesian inference Combinatorics Table of Preface page xi PART I INTRODUCTION 1 1 The meaning of probability 3 1.1 Classical definition of probability 3 1.2 Statistical definition of probability 9 1.3 Bayesian understanding of probability

More information

Stochastic structural dynamic analysis with random damping parameters

Stochastic structural dynamic analysis with random damping parameters Stochastic structural dynamic analysis with random damping parameters K. Sepahvand 1, F. Saati Khosroshahi, C. A. Geweth and S. Marburg Chair of Vibroacoustics of Vehicles and Machines Department of Mechanical

More information

CPSC 540: Machine Learning

CPSC 540: Machine Learning CPSC 540: Machine Learning MCMC and Non-Parametric Bayes Mark Schmidt University of British Columbia Winter 2016 Admin I went through project proposals: Some of you got a message on Piazza. No news is

More information

Enabling Advanced Automation Tools to manage Trajectory Prediction Uncertainty

Enabling Advanced Automation Tools to manage Trajectory Prediction Uncertainty Engineering, Test & Technology Boeing Research & Technology Enabling Advanced Automation Tools to manage Trajectory Prediction Uncertainty ART 12 - Automation Enrique Casado (BR&T-E) enrique.casado@boeing.com

More information

Review. DS GA 1002 Statistical and Mathematical Models. Carlos Fernandez-Granda

Review. DS GA 1002 Statistical and Mathematical Models.   Carlos Fernandez-Granda Review DS GA 1002 Statistical and Mathematical Models http://www.cims.nyu.edu/~cfgranda/pages/dsga1002_fall16 Carlos Fernandez-Granda Probability and statistics Probability: Framework for dealing with

More information

A reduced-order stochastic finite element analysis for structures with uncertainties

A reduced-order stochastic finite element analysis for structures with uncertainties A reduced-order stochastic finite element analysis for structures with uncertainties Ji Yang 1, Béatrice Faverjon 1,2, Herwig Peters 1, icole Kessissoglou 1 1 School of Mechanical and Manufacturing Engineering,

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

Introduction to Linear Models

Introduction to Linear Models Introduction to Linear Models STA721 Linear Models Duke Universit Merlise Clde August 25, 2015 Coordinates Instructor: Merlise Clde 214 Old Chemistr Office Hours MWF 1:00-2:0 or right after class (or b

More information

arxiv: v1 [stat.co] 23 Apr 2018

arxiv: v1 [stat.co] 23 Apr 2018 Bayesian Updating and Uncertainty Quantification using Sequential Tempered MCMC with the Rank-One Modified Metropolis Algorithm Thomas A. Catanach and James L. Beck arxiv:1804.08738v1 [stat.co] 23 Apr

More information

Simulating with uncertainty : the rough surface scattering problem

Simulating with uncertainty : the rough surface scattering problem Simulating with uncertainty : the rough surface scattering problem Uday Khankhoje Assistant Professor, Electrical Engineering Indian Institute of Technology Madras Uday Khankhoje (EE, IITM) Simulating

More information

Part 1: Expectation Propagation

Part 1: Expectation Propagation Chalmers Machine Learning Summer School Approximate message passing and biomedicine Part 1: Expectation Propagation Tom Heskes Machine Learning Group, Institute for Computing and Information Sciences Radboud

More information

Long Time Propagation of Stochasticity by Dynamical Polynomial Chaos Expansions. Hasan Cagan Ozen

Long Time Propagation of Stochasticity by Dynamical Polynomial Chaos Expansions. Hasan Cagan Ozen Long Time Propagation of Stochasticity by Dynamical Polynomial Chaos Expansions Hasan Cagan Ozen Submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy in the Graduate

More information

Uncertainty Propagation and Global Sensitivity Analysis in Hybrid Simulation using Polynomial Chaos Expansion

Uncertainty Propagation and Global Sensitivity Analysis in Hybrid Simulation using Polynomial Chaos Expansion Uncertainty Propagation and Global Sensitivity Analysis in Hybrid Simulation using Polynomial Chaos Expansion EU-US-Asia workshop on hybrid testing Ispra, 5-6 October 2015 G. Abbiati, S. Marelli, O.S.

More information

Lecture 7 and 8: Markov Chain Monte Carlo

Lecture 7 and 8: Markov Chain Monte Carlo Lecture 7 and 8: Markov Chain Monte Carlo 4F13: Machine Learning Zoubin Ghahramani and Carl Edward Rasmussen Department of Engineering University of Cambridge http://mlg.eng.cam.ac.uk/teaching/4f13/ Ghahramani

More information

LECTURE 15 Markov chain Monte Carlo

LECTURE 15 Markov chain Monte Carlo LECTURE 15 Markov chain Monte Carlo There are many settings when posterior computation is a challenge in that one does not have a closed form expression for the posterior distribution. Markov chain Monte

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

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond January 18, 2017 Contents 1 Batch and Recursive Estimation 2 Towards Bayesian Filtering 3 Kalman Filter and Bayesian Filtering and Smoothing

More information

A Non-Intrusive Polynomial Chaos Method for Uncertainty Propagation in CFD Simulations

A Non-Intrusive Polynomial Chaos Method for Uncertainty Propagation in CFD Simulations Missouri University of Science and Technology Scholars' Mine Mechanical and Aerospace Engineering Faculty Research & Creative Works Mechanical and Aerospace Engineering --6 A Non-Intrusive Polynomial Chaos

More information

New issues in LES of turbulent flows: multiphysics and uncertainty modelling

New issues in LES of turbulent flows: multiphysics and uncertainty modelling New issues in LES of turbulent flows: multiphysics and uncertainty modelling Pierre Sagaut Institut Jean Le Rond d Alembert Université Pierre et Marie Curie- Paris 6, France http://www.lmm.jussieu.fr/~sagaut

More information

Bayesian Inference in Astronomy & Astrophysics A Short Course

Bayesian Inference in Astronomy & Astrophysics A Short Course Bayesian Inference in Astronomy & Astrophysics A Short Course Tom Loredo Dept. of Astronomy, Cornell University p.1/37 Five Lectures Overview of Bayesian Inference From Gaussians to Periodograms Learning

More information

Gaussian Process Approximations of Stochastic Differential Equations

Gaussian Process Approximations of Stochastic Differential Equations Gaussian Process Approximations of Stochastic Differential Equations Cédric Archambeau Centre for Computational Statistics and Machine Learning University College London c.archambeau@cs.ucl.ac.uk CSML

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

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