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

Size: px
Start display at page:

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

Transcription

1 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 Matematica, Università di Pavia, Italy SRI UQ Center, KAUST, Saudi Arabia UQAW 2016 KAUST, January 5, 2016 Lorenzo Tamellini (UNIPV) January 5, / 21

2 Outline 1 The lognormal Darcy problem (with rough coefficients) 2 Optimized sparse grids 3 Dimension-adaptive algorithms 4 Numerical results - part I 5 Monte Carlo Control Variate 6 Numerical results - part II Lorenzo Tamellini (UNIPV) January 5, / 21

3 The uncertain Darcy problem Find a pressure p : D Γ R, such that { (e γν p) = f in D, +B.C. (see plot on the right). u = outward flux from the right-hand boundary. ( e γ p ) n = 0 D p=1 p=0 ( e γ p ) n = 0 Lorenzo Tamellini (UNIPV) January 5, / 21

4 The uncertain Darcy problem Find a pressure p(x, y) : D Γ R, such that ϱ-a.e.: { (e γν(x,y) p(x, y)) = f (x) x D, +B.C. (see plot on the right). u(y) = outward flux is a random fun. appr. e.g. E[u] ( e γ p ) n = 0 D p=1 p=0 ( e γ p ) n = 0 γ ν = rand. field with tensor Matérn covariance expanded by Kar.-Loève γ ν (x, y) = σ y k γ k,ν φ k (x), y i N (0, 1) i.i.d. k=1 Lorenzo Tamellini (UNIPV) January 5, / 21

5 The uncertain Darcy problem Find a pressure p(x, y) : D Γ R, such that ϱ-a.e.: { (e γν(x,y) p(x, y)) = f (x) x D, +B.C. (see plot on the right). u(y) = outward flux is a random fun. appr. e.g. E[u] ( e γ p ) n = 0 D p=1 p=0 ( e γ p ) n = 0 γ ν = rand. field with tensor Matérn covariance expanded by Kar.-Loève γ ν (x, y) = σ y k γ k,ν φ k (x), y i N (0, 1) i.i.d. k=1 The smoothness of the realizations of γ (hence the decay of γ k,ν ) depends on ν [0.5, ]: ν = 0.5 γ ν = exponential cov. fun. (C 0,s, s < 1/2 realizations) ν = γ ν = Gaussian cov. fun. (C realizations) Lorenzo Tamellini (UNIPV) January 5, / 21

6 Hierarchical representation of a sparse grid S I [u](y) = i I c i T m(i) [u](y) is a sparse grid interp. = S I [u](y) = T [15 1] [u](y) + T [1 15] [u](y) + T [5 5] [u](y) Q I [u] = c i E [ T m(i) [u] ] = i I i I c i y j T m(i) ω j u(y j ) is a s.g. quadrature Admissibility condition for I: i I, i e j I if i j > 1. Collocation pts: y i N (0, 1) Gauss Hermite, Genz Keister, gen. Leja Lorenzo Tamellini (UNIPV) January 5, / 21

7 Hierarchical representation of a sparse grid S I [u](y) = i I c i T m(i) [u](y) = i I m(i) [u](y) is a sparse grid interp. Un m(in) [u](y n ) is an interpolant along y n over m(i n ) points N T m(i) [u](y) = Un m(in) [u](y) is a tensor interpolant n=1 Un m(in) [u] Un m(in 1) [u] is an interpolation detail N m(i) [u](y) = [u] U m(in 1) [u]) is a hierarchical surplus Q I [u] = i I n=1 (U m(in) n c i E [ T m(i) [u] ] = i I n c i y j T m(i) ω j u(y j ) is a s.g. quadrature Admissibility condition for I: i I, i e j I if i j > 1. Collocation pts: y i N (0, 1) Gauss Hermite, Genz Keister, gen. Leja Lorenzo Tamellini (UNIPV) January 5, / 21

8 Optimized (knapsack) sparse grids S I [u](y) = i I m(i) [u](y). What terms m(i) to include in the sum? 1 How much will the approx. improve if I add m(i) [u]? E(i) 2 How many new problem solves if I add m(i) [u]? W (i) Use as I the set of m(i) [u] with the highest ratio E(i) W (i) (i.e. a knapsack problem solved by the Dantzig algorithm more ) Note: E(i) depends on the norm used to measure the improvement. We show next three different strategies, two a-posteriori and one a-priori Lorenzo Tamellini (UNIPV) January 5, / 21

9 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I curr. idx 1 Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

10 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I reduced margin curr. idx Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

11 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I reduced margin curr. idx Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

12 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I reduced margin curr. idx Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

13 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I reduced margin curr. idx Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

14 A-posteriori (adaptive) strategies Gerstner & Griebel, Multi-index set I reduced margin curr. idx Sparse grid set Given i = 1, I = {i} and R = repeat: 1 Add to R the neighbors of i feasible wrt to I 2 Compute S I B [u] 3 find the index j R with the highest profit (estimated a-posteriori ) 4 set i = j and move it from R to I NB: slight changes needed for non-nested points and unbounded Γ, see later and poster. Lorenzo Tamellini (UNIPV) January 5, / 21

15 Method 1: Quadrature-adaptive sparse grids Here we consider E(i) E [ m(i) [u] ]. { N ( 1 n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite or alternatively W (i) = 1. 2 E(i) = Q I {i} [u] Q I [u] for any I admissible st I {i} is admissible. Note: The algorithm above is not bound to use nested points! Hence we can use Gauss Hermite points, whose m( ) grows much slower than Genz Keister nodes. Lorenzo Tamellini (UNIPV) January 5, / 21

16 Method 2: Interpolation-adaptive sparse grids Here we consider E(i) max y Γ ( m(i) [u](y) π(y) ). Note that π(y) > 0 needs not be equal to ϱ normal (y). { N ( 1 n=1 m(in ) m(i n 1) ) for Genz Keister W (i) = N n=1 m(i n) for Gauss Hermite or alternatively W (i) = 1. 2 If using Genz Keister (nested) knots, ( the sparse grid is interpolatory, hence u(y) E(i) = max y pts(si {i} )\pts(s I ) S m I [u](y) ) π(y). If using Gauss Hermite (non-nested) knots, the sparse grid is not interpolatory, hence ( ) E(i) = max y pts(t m(i) ) SI {i} m [u](y) Sm I [u](y) π(y). So again, we can use the algorithm with non-nested nodes too Lorenzo Tamellini (UNIPV) January 5, / 21

17 A-priori strategy Method 3: Quasi-optimal sparse grids more Here we consider E(i) m(i) [u] L 2 ϱ (Γ). By linking m(i) [u] to the spectral (Hermite) expansion of u, we can get computable estimates of E(i), before actually running the sparse grid algorithm (see next slide). W (i) can also be (easily) estimated (see next slide). { } E(i) Then, just compute the set I k = W (i) > ɛ k Lorenzo Tamellini (UNIPV) January 5, / 21

18 Method 3: Quasi-optimal sparse grids Here we consider E(i) m(i) [u] L 2 ϱ (Γ). Let H p (y) be the Hermite pol. of degree p n wrt y n. 1 Let m(i n ) = i n for Gauss Hermite pts (non-nested), m(i n ) = 1, 3, 9, 19, 35 for Genz Keister { (nested). Then let N ( n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite N 2 E(i) = C e n=1 gnm(in 1) N n=1 m(in 1) B(i), with B(i) = m(i) [H m(i 1) ] L 2 ϱ (Γ) 3 For a suff. large universe U N N compute the profit of each m(i), P(i) = E(i)/ W (i) 4 sort decreasingly P(i) 5 build the sparse grid with the m(i) with largest profits In order to compute the profits we need to assess the rates g n. This can be performed numerically with a comp. cost linear in N ( a priori/a posteriori approach ) Lorenzo Tamellini (UNIPV) January 5, / 21 more

19 Method 3: Quasi-optimal sparse grids Here we consider E(i) m(i) [u] L 2 ϱ (Γ). Let H p (y) be the Hermite pol. of degree p n wrt y n. 1 Let m(i n ) = i n for Gauss Hermite pts (non-nested), m(i n ) = 1, 3, 9, 19, 35 for Genz Keister { (nested). Then let N ( n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite N 2 E(i) = C e n=1 gnm(in 1) N n=1 m(in 1) B(i), with B(i) = m(i) [H m(i 1) ] L 2 ϱ (Γ) 3 For a decreasing sequence ɛ 1, ɛ 2... compute the sets { } E(i) I k = W (i) > ɛ k more In order to compute the profits we need to assess the rates g n. This can be performed numerically with a comp. cost linear in N ( a priori/a posteriori approach ) Lorenzo Tamellini (UNIPV) January 5, / 21

20 In order to compute the profits we need to assess the rates g n. This can be performed numerically with a comp. cost linear in N ( a priori/a posteriori approach ) Lorenzo Tamellini (UNIPV) January 5, / 21 Method 3: Quasi-optimal sparse grids Here we consider E(i) m(i) [u] L 2 ϱ (Γ). Let H p (y) be the Hermite pol. of degree p n wrt y n. 1 Let m(i n ) = i n for Gauss Hermite pts (non-nested), m(i n ) = 1, 3, 9, 19, 35 for Genz Keister { (nested). Then let N ( n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite N 2 E(i) = C e n=1 gnm(in 1) N n=1 m(in 1) B(i), with B(i) = m(i) [H m(i 1) ] L 2 ϱ (Γ) 3 For a decreasing sequence ɛ 1, ɛ 2... compute the sets e N n=1 gnm(in 1) N B(i) n=1 m(in 1) I k = > ɛ k W more

21 In order to compute the profits we need to assess the rates g n. This can be performed numerically with a comp. cost linear in N ( a priori/a posteriori approach ) Lorenzo Tamellini (UNIPV) January 5, / 21 Method 3: Quasi-optimal sparse grids Here we consider E(i) m(i) [u] L 2 ϱ (Γ). Let H p (y) be the Hermite pol. of degree p n wrt y n. 1 Let m(i n ) = i n for Gauss Hermite pts (non-nested), m(i n ) = 1, 3, 9, 19, 35 for Genz Keister { (nested). Then let N ( n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite N 2 E(i) = C e n=1 gnm(in 1) N n=1 m(in 1) B(i), with B(i) = m(i) [H m(i 1) ] L 2 ϱ (Γ) 3 For a decreasing sequence ɛ 1, ɛ 2... compute the sets { ( ) } > log ɛ k I k = log e N n=1 gnm(in 1) B(i) N n=1 m(in 1) W more

22 In order to compute the profits we need to assess the rates g n. This can be performed numerically with a comp. cost linear in N ( a priori/a posteriori approach ) Lorenzo Tamellini (UNIPV) January 5, / 21 Method 3: Quasi-optimal sparse grids Here we consider E(i) m(i) [u] L 2 ϱ (Γ). Let H p (y) be the Hermite pol. of degree p n wrt y n. 1 Let m(i n ) = i n for Gauss Hermite pts (non-nested), m(i n ) = 1, 3, 9, 19, 35 for Genz Keister { (nested). Then let N ( n=1 m(in ) m(i n 1) ) Genz Keister W (i) = N n=1 m(i n) Gauss Hermite N 2 E(i) = C e n=1 gnm(in 1) N n=1 m(in 1) B(i), with B(i) = m(i) [H m(i 1) ] L 2 ϱ (Γ) 3 For an integer sequence w 1, w 2... compute the sets { N I k = g n m(i n 1) log B(i) + log } m(i n 1) + log W (i) < w k n=1 more

23 Convergence theorem for quasi-optimal sparse grids If the profits satisfy the weighted summability condition ( ) 1/τ P τ (i) W (i) = CP (τ) < i N N for some 0 < τ < 1, then the knapsack sparse grid approximation of u satisfies u S I [u] W 1 1/τ C P (τ). where W is the number of collocation points used to build S I [u]. Sketch of proof: Let {Q j } j N+ = j k=1 W k and { P k } k N+ = E 1 E 1 E 1,,..., E 2 E 2 E 2,,.... W 1 W 1 W 1 W 2 W 2 W 2 }{{}}{{} W 1 times W 2 times u SI(w) m [u] i / I(w) m(i) u = j>w E j = k>q Pk w. Use Stechkin Lemma: ( k>q Pk w Qw 1/τ+1 P k>0 k τ ) 1/τ 1/τ+1 ( = Q w k>0 Pτ k W ) 1/τ k It is quite easy to extend the proof for cases where I is not admissible. Lorenzo Tamellini (UNIPV) January 5, / 21

24 Convergence theorem for quasi-optimal sparse grids If the profits satisfy the weighted summability condition ( ) 1/τ P τ (i) W (i) = CP (τ) < i N N for some 0 < τ < 1, then the knapsack sparse grid approximation of u satisfies u S I [u] W 1 1/τ C P (τ). where W is the number of collocation points used to build S I [u]. Ex.: assume for a moment y 1,..., y N uniform random variables, sparse grids with Clenshaw Curtis points, Legendre coeff. decay as C(N)e N n=1 gnm(in 1). Then the theorem above implies that ( u S I [u] C 1 (N) exp C 2 N N ) W Sketch of proof: observe that in this case P are τ-summable for 0 < τ < 1; then, optimize the error estimate w.r.t. τ. Lorenzo Tamellini (UNIPV) January 5, / 21

25 To refine or to add random var.? Dimension-adaptivity Problem: exploring reduced margin in high-dimensional spaces / computing all rates g n beforehand is too expensive. Lorenzo Tamellini (UNIPV) January 5, / 21

26 To refine or to add random var.? Dimension-adaptivity Problem: exploring reduced margin in high-dimensional spaces / computing all rates g n beforehand is too expensive. Assume that the Karhunen Loève expansion γ = σ N k=1 y kγ k φ k introduces a weak ordering of random variables, i.e. there exists B 1 (buffer) s.t. y n+b is guaranteed to be less important than y n. Lorenzo Tamellini (UNIPV) January 5, / 21

27 To refine or to add random var.? Dimension-adaptivity Problem: exploring reduced margin in high-dimensional spaces / computing all rates g n beforehand is too expensive. Assume that the Karhunen Loève expansion γ = σ N k=1 y kγ k φ k introduces a weak ordering of random variables, i.e. there exists B 1 (buffer) s.t. y n+b is guaranteed to be less important than y n. Idea: Add random variables gradually (balance refinement and addition of variables). Note that this means we don t need to truncate a-priori the Karhunen Loève expansion of γ! Lorenzo Tamellini (UNIPV) January 5, / 21

28 To refine or to add random var.? Dimension-adaptivity Problem: exploring reduced margin in high-dimensional spaces / computing all rates g n beforehand is too expensive. Assume that the Karhunen Loève expansion γ = σ N k=1 y kγ k φ k introduces a weak ordering of random variables, i.e. there exists B 1 (buffer) s.t. y n+b is guaranteed to be less important than y n. Idea: Add random variables gradually (balance refinement and addition of variables). Note that this means we don t need to truncate a-priori the Karhunen Loève expansion of γ! Define a random variable y n as activated if min i I i n > 1. Lorenzo Tamellini (UNIPV) January 5, / 21

29 To refine or to add random var.? Dimension-adaptivity Problem: exploring reduced margin in high-dimensional spaces / computing all rates g n beforehand is too expensive. Assume that the Karhunen Loève expansion γ = σ N k=1 y kγ k φ k introduces a weak ordering of random variables, i.e. there exists B 1 (buffer) s.t. y n+b is guaranteed to be less important than y n. Idea: Add random variables gradually (balance refinement and addition of variables). Note that this means we don t need to truncate a-priori the Karhunen Loève expansion of γ! Define a random variable y n as activated if min i I i n > 1. A simple dimension-adaptive algorithm 1 start the adaptive/quasi-optimal algorithm using B rand. var. 2 As soon as one of these buffer variables gets activated, add a new rand. var. to the approximaton (in the quasi optimal setting, this means computing the corresponding g n ). Lorenzo Tamellini (UNIPV) January 5, / 21

30 The uncertain Darcy problem results 1 Field data: σ = 1, corr. length L c = 0.5, ν = 2.5 (C 2 realizations) error MC error AD D AD D/NP ADNN D ADNN D/NP 1(1) 3(2) 1(1) 2(2) work 4(3) 4(3) 8(3) 7(3) 11(4) 17(4) 11(3) 17(4) 27(4) 38(4) 23(4) 35(4) adaptive schemes with activated variables error MC error OPT OPT NN AD WLinf/NP ADNN WLinf/NP AD D ADNN D work adaptive and quasi-optimal schemes moderate number of rand. vars. needed quasi-optimal plateau due to computation of g quasi-optimal and adaptive schemes have similar convergence nested and non-nested points have similar convergence convergence robust wrt. type of points and E[ ]/L -driven adaptation similar results for adaptive sparse interpolation Lorenzo Tamellini (UNIPV) January 5, / 21

31 Case ν = 0.5: Monte Carlo Control Variate Realizations of γ are non-differentiable KL eigenval decay very slow sparse grids may be non-effective. Remedy: use sparse grids as control var. (preconditioner) for MC 1 Consider a smoothed field γ ɛ, such that Q I [u ɛ ] E[u ɛ ] quickly. smoothed field, ɛ = 1/2 4 smoothed field ɛ = 1/2 6 non-smoothed field, ɛ = 0 Lorenzo Tamellini (UNIPV) January 5, / 21

32 Case ν = 0.5: Monte Carlo Control Variate Realizations of γ are non-differentiable KL eigenval decay very slow sparse grids may be non-effective. Remedy: use sparse grids as control var. (preconditioner) for MC 1 Consider a smoothed field γ ɛ, such that Q I [u ɛ ] E[u ɛ ] quickly. 2 Define u CV = u u ɛ + Q I [u ɛ ]. There holds E[u CV ] = E[u], Var(u CV ) = Var(u) + Var(u ɛ ) 2cov(u, u ɛ ) Thus, the smaller ɛ, the smaller the MC error, but slower the convergence Q I [u ɛ ] E[u ɛ ]. Lorenzo Tamellini (UNIPV) January 5, / 21

33 Case ν = 0.5: Monte Carlo Control Variate Realizations of γ are non-differentiable KL eigenval decay very slow sparse grids may be non-effective. Remedy: use sparse grids as control var. (preconditioner) for MC 1 Consider a smoothed field γ ɛ, such that Q I [u ɛ ] E[u ɛ ] quickly. 2 Define u CV = u u ɛ + Q I [u ɛ ]. There holds E[u CV ] = E[u], Var(u CV ) = Var(u) + Var(u ɛ ) 2cov(u, u ɛ ) Thus, the smaller ɛ, the smaller the MC error, but slower the convergence Q I [u ɛ ] E[u ɛ ]. 3 Set E[u CV ] 1 M M u CV (ω i ) = i=1 1 M M (u(ω i ) u ɛ (ω i )) + Q m I [u ɛ ]. M can be chosen balancing either the works or the errors of MC and sparse grids. i=1 Lorenzo Tamellini (UNIPV) January 5, / 21

34 The uncertain Darcy problem results 2 Field data: σ = 1, corr. length L c = 0.5, ν = 0.5 error MC error OPT OPT NN AD D ADNN D AD WLinf/NP ADNN WLinf/NP work MCCV error for adaptive and quasi-optimal sparse grids. 30 r.v. activated. error (1) MC error 10(1) 11(1) 11(1) OPT NN, ε=0 OPT NN, ε=2 5 27(2) 32(2) 79(3) 30(2) 45(3) 71(3) 242(4) 80(4) 113(4) 571(4) 224(4) OPT NN ε= (5) work Sparse grid component of the error for different values of ɛ. The performance deteriorates as ɛ 0 Lorenzo Tamellini (UNIPV) January 5, / 21

35 Conclusions 1 General framework for quasi-optimal and adaptive sparse grids schemes; 2 The schemes can be applied to the lognormal case, also with non-nested points; 3 The dimension-adaptive implementation allows to work without a-priori truncation of the random field; 4 A Monte Carlo Control Variate can be used to improve results in the rough case (exponential covariance). Lorenzo Tamellini (UNIPV) January 5, / 21

36 Thank you for your attention! (see also poster) Lorenzo Tamellini (UNIPV) January 5, / 21

37 Bibliography F. Nobile, L. Tamellini, F. Tesei and R. Tempone. An adaptive sparse grid algorithm for elliptic PDEs with lognormal diffusion coefficient Sparse Grids and Applications 2014, Springer (to appear). Also available as MATHICSE report 4/2015 F. Tesei Numerical Approximation of Flows in Random Porous Media Ph.D. Thesis Nr. 6860, EPFL, to appear on F. Tesei and F. Nobile. A Multi Level Monte Carlo Method with Control Variate for elliptic PDEs with log-normal coefficients. Stochastic Partial Differential Equations: Analysis and Computations, 3(3), F. Nobile, L. Tamellini, and R. Tempone. Convergence of quasi-optimal sparse-grid approximation of Hilbert-space valued functions: application to random elliptic PDEs. Numerische Mathematik (available online) J. Beck, F. Nobile, L. Tamellini, and R. Tempone. A Quasi-optimal Sparse Grids Procedure for Groundwater Flows. Selected papers from the ICOSAHOM 12 conference. J. Beck, F. Nobile, L. Tamellini, and R. Tempone. On the optimal polynomial approximation of stochastic PDEs by Galerkin and Collocation methods Math. Mod. Methods Appl. Sci. (M3AS) 22(9), 2012 Lorenzo Tamellini (UNIPV) January 5, / 21

38 Matérn covariance cov γν (x, x ) = σ 2 2 i=1 ( 2ν xi x i /L ) ν ( c Kν 2ν xi x i /L c) G(ν)2 ν 1 Here K ν is the modified Bessel function of the second kind and G the Gamma function. back Lorenzo Tamellini (UNIPV) January 5, / 21

39 Knapsack approach S I [u](y) = m(i) [u](y). What terms m(i) to include in the sum? i I [ Given that E [u S I [u]] = E i I [u]] m(i) i I E [ m(i) [u] ], Lorenzo Tamellini (UNIPV) January 5, / 21

40 Knapsack approach S I [u](y) = i I m(i) [u](y). What terms m(i) to include in the sum? Given that 1 Set E [ m(i) [u] ] E(i) [ E [u S I [u]] = E i I [u]] m(i) W (i) = work of m(i) [u] x i {0, 1}, x i = 1 i I. i I E(i) Lorenzo Tamellini (UNIPV) January 5, / 21

41 Knapsack approach S I [u](y) = m(i) [u](y). What terms m(i) to include in the sum? i I [ Given that E [u S I [u]] = E i I [u]] m(i) i I E(i) 1 Set E [ m(i) [u] ] E(i) W (i) = work of m(i) [u] x i {0, 1}, x i = 1 i I. 2 Consider max i N N + E(i)x i s.t. i N N + W (i)x i W max and x i {0, 1} Lorenzo Tamellini (UNIPV) January 5, / 21

42 Knapsack approach S I [u](y) = m(i) [u](y). What terms m(i) to include in the sum? i I [ Given that E [u S I [u]] = E i I [u]] m(i) i I E(i) 1 Set E [ m(i) [u] ] E(i) W (i) = work of m(i) [u] x i {0, 1}, x i = 1 i I. 2 Consider max i N N + E(i)x i s.t. i N N + W (i)x i W max and x i {0, 1} 3 Solve by Dantzig Algorithm (knapsack problem approach) 1 compute the profit of each m(i) [u], P(i) = E(i)/ W (i) 2 sort m(i) [u] decreasing in profits 3 set x i = 1 until W max is reached back Lorenzo Tamellini (UNIPV) January 5, / 21

43 Quasi-optimal sparse grids back E(i) = m(i) [u] = m(i)[ ] u q H q = u q m(i) [H q ] q N N q N N Next, by construction m(i) [H q ] = 0 for polynomials such that n : q n < m(i n 1). By triangular inequality we get E(i) u q H 1 (D) m(i) [H q ]. L 2 ρ (Γ) q m(i 1) By assuming that the summation is dominated by the first term, we get E(i) B(i) u H m(i 1) 1 (D), B(i) = m(i) [H m(i 1) ] L 2 ρ (Γ) and we use the Heuristic N u H m(i 1) 1 (D) e n=1 gnm(in 1) N n=1 m(in 1) Lorenzo Tamellini (UNIPV) January 5, / 21

Collocation methods for uncertainty quantification in PDE models with random data

Collocation methods for uncertainty quantification in PDE models with random data Collocation methods for uncertainty quantification in PDE models with random data Fabio Nobile CSQI-MATHICSE, EPFL, Switzerland Acknowlegments: L. Tamellini, G. Migliorati (EPFL), R. Tempone, (KAUST),

More information

Comparison of Clenshaw-Curtis and Leja quasi-optimal sparse grids for the approximation of random PDEs

Comparison of Clenshaw-Curtis and Leja quasi-optimal sparse grids for the approximation of random PDEs MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 41.2014 September 2014 Comparison of Clenshaw-Curtis

More information

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 46.2012 November 2012 A quasi-optimal sparse grids

More information

Adaptive Collocation with Kernel Density Estimation

Adaptive Collocation with Kernel Density Estimation Examples of with Kernel Density Estimation Howard C. Elman Department of Computer Science University of Maryland at College Park Christopher W. Miller Applied Mathematics and Scientific Computing Program

More information

Accuracy, Precision and Efficiency in Sparse Grids

Accuracy, Precision and Efficiency in Sparse Grids John, Information Technology Department, Virginia Tech.... http://people.sc.fsu.edu/ jburkardt/presentations/ sandia 2009.pdf... Computer Science Research Institute, Sandia National Laboratory, 23 July

More information

Optimal polynomial approximation of PDEs with stochastic coefficients by Galerkin and collocation methods

Optimal polynomial approximation of PDEs with stochastic coefficients by Galerkin and collocation methods Optimal polynomial approximation of PDEs with stochastic coefficients by Galerkin and collocation methods Fabio Nobile MOX, Department of Mathematics, Politecnico di Milano Seminaire du Laboratoire Jacques-Louis

More information

Sparse Grids. Léopold Cambier. February 17, ICME, Stanford University

Sparse Grids. Léopold Cambier. February 17, ICME, Stanford University Sparse Grids & "A Dynamically Adaptive Sparse Grid Method for Quasi-Optimal Interpolation of Multidimensional Analytic Functions" from MK Stoyanov, CG Webster Léopold Cambier ICME, Stanford University

More information

Multi-Element Probabilistic Collocation Method in High Dimensions

Multi-Element Probabilistic Collocation Method in High Dimensions Multi-Element Probabilistic Collocation Method in High Dimensions Jasmine Foo and George Em Karniadakis Division of Applied Mathematics, Brown University, Providence, RI 02912 USA Abstract We combine multi-element

More information

J. Beck 1, F. Nobile 2, L. Tamellini 2 and R. Tempone 1

J. Beck 1, F. Nobile 2, L. Tamellini 2 and R. Tempone 1 ESAIM: PROCEEDINGS, October 2011, Vol. 33, p. 10-21 C. Dobrzynski, T. Colin & R. Abgrall, Editors IMPLEMENTATION OF OPTIMAL GALERKIN AND COLLOCATION APPROXIMATIONS OF PDES WITH RANDOM COEFFICIENTS, J.

More information

Multilevel accelerated quadrature for elliptic PDEs with random diffusion. Helmut Harbrecht Mathematisches Institut Universität Basel Switzerland

Multilevel accelerated quadrature for elliptic PDEs with random diffusion. Helmut Harbrecht Mathematisches Institut Universität Basel Switzerland Multilevel accelerated quadrature for elliptic PDEs with random diffusion Mathematisches Institut Universität Basel Switzerland Overview Computation of the Karhunen-Loéve expansion Elliptic PDE with uniformly

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

Low-rank techniques applied to moment equations for the stochastic Darcy problem with lognormal permeability

Low-rank techniques applied to moment equations for the stochastic Darcy problem with lognormal permeability Low-rank techniques applied to moment equations for the stochastic arcy problem with lognormal permeability Francesca Bonizzoni 1,2 and Fabio Nobile 1 1 CSQI-MATHICSE, EPFL, Switzerland 2 MOX, Politecnico

More information

arxiv: v2 [math.na] 21 Jul 2016

arxiv: v2 [math.na] 21 Jul 2016 Multi-Index Stochastic Collocation for random PDEs Abdul-Lateef Haji-Ali a,, Fabio Nobile b, Lorenzo Tamellini b,c, Raúl Tempone a a CEMSE, King Abdullah University of Science and Technology, Thuwal 23955-6900,

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

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

Giovanni Migliorati. MATHICSE-CSQI, École Polytechnique Fédérale de Lausanne

Giovanni Migliorati. MATHICSE-CSQI, École Polytechnique Fédérale de Lausanne Analysis of the stability and accuracy of multivariate polynomial approximation by discrete least squares with evaluations in random or low-discrepancy point sets Giovanni Migliorati MATHICSE-CSQI, École

More information

A sparse grid stochastic collocation method for elliptic partial differential equations with random input data

A sparse grid stochastic collocation method for elliptic partial differential equations with random input data A sparse grid stochastic collocation method for elliptic partial differential equations with random input data F. Nobile R. Tempone C. G. Webster June 22, 2006 Abstract This work proposes and analyzes

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

Slow Growth for Gauss Legendre Sparse Grids

Slow Growth for Gauss Legendre Sparse Grids Slow Growth for Gauss Legendre Sparse Grids John Burkardt, Clayton Webster April 4, 2014 Abstract A sparse grid for multidimensional quadrature can be constructed from products of 1D rules. For multidimensional

More information

Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals

Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals 1/33 Orthogonal Polynomials, Quadratures & Sparse-Grid Methods for Probability Integrals Dr. Abebe Geletu May, 2010 Technische Universität Ilmenau, Institut für Automatisierungs- und Systemtechnik Fachgebiet

More information

Analysis and Computation of Hyperbolic PDEs with Random Data

Analysis and Computation of Hyperbolic PDEs with Random Data Analysis and Computation of Hyperbolic PDEs with Random Data Mohammad Motamed 1, Fabio Nobile 2,3 and Raúl Tempone 1 1 King Abdullah University of Science and Technology, Thuwal, Saudi Arabia 2 EPFL Lausanne,

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

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

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 approximation of PDEs with stochastic coefficients

Polynomial approximation of PDEs with stochastic coefficients POLITECNICO DI MILANO Ph.D. School in Mathematical Models and Methods in Engineering XXIV ciclo Polynomial approximation of PDEs with stochastic coefficients Presented to Dipartimento di Matematica F.

More information

Sparse Quadrature Algorithms for Bayesian Inverse Problems

Sparse Quadrature Algorithms for Bayesian Inverse Problems Sparse Quadrature Algorithms for Bayesian Inverse Problems Claudia Schillings, Christoph Schwab Pro*Doc Retreat Disentis 2013 Numerical Analysis and Scientific Computing Disentis - 15 August, 2013 research

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

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

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

Chaospy: A modular implementation of Polynomial Chaos expansions and Monte Carlo methods

Chaospy: A modular implementation of Polynomial Chaos expansions and Monte Carlo methods Chaospy: A modular implementation of Polynomial Chaos expansions and Monte Carlo methods Simen Tennøe Supervisors: Jonathan Feinberg Hans Petter Langtangen Gaute Einevoll Geir Halnes University of Oslo,

More information

A sparse grid stochastic collocation method for partial differential equations with random input data

A sparse grid stochastic collocation method for partial differential equations with random input data A sparse grid stochastic collocation method for partial differential equations with random input data F. Nobile R. Tempone C. G. Webster May 24, 2007 Abstract This work proposes and analyzes a Smolyak-type

More information

Sparse Grid Collocation for Uncertainty Quantification

Sparse Grid Collocation for Uncertainty Quantification Sparse Grid Collocation for Uncertainty Quantification John Burkardt Department of Scientific Computing Florida State University Ajou University 14 August 2013 http://people.sc.fsu.edu/ jburkardt/presentations/......

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

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

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Jochen Garcke joint work with Axel Kröner, INRIA Saclay and CMAP, Ecole Polytechnique Ilja Kalmykov, Universität

More information

Journal of Computational Physics

Journal of Computational Physics Journal of Computational Physics 229 (2010) 1536 1557 Contents lists available at ScienceDirect Journal of Computational Physics journal homepage: www.elsevier.com/locate/jcp Multi-element probabilistic

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

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

Sparse Grid Collocation for Uncertainty Quantification

Sparse Grid Collocation for Uncertainty Quantification Sparse Grid Collocation for Uncertainty Quantification John Burkardt Department of Scientific Computing Florida State University 13 February 2014 http://people.sc.fsu.edu/ jburkardt/presentations/......

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

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

AN EFFICIENT COMPUTATIONAL FRAMEWORK FOR UNCERTAINTY QUANTIFICATION IN MULTISCALE SYSTEMS

AN EFFICIENT COMPUTATIONAL FRAMEWORK FOR UNCERTAINTY QUANTIFICATION IN MULTISCALE SYSTEMS AN EFFICIENT COMPUTATIONAL FRAMEWORK FOR UNCERTAINTY QUANTIFICATION IN MULTISCALE SYSTEMS A Dissertation Presented to the Faculty of the Graduate School of Cornell University in Partial Fulfillment of

More information

STOCHASTIC SAMPLING METHODS

STOCHASTIC SAMPLING METHODS STOCHASTIC SAMPLING METHODS APPROXIMATING QUANTITIES OF INTEREST USING SAMPLING METHODS Recall that quantities of interest often require the evaluation of stochastic integrals of functions of the solutions

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

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

A MULTILEVEL STOCHASTIC COLLOCATION METHOD FOR PARTIAL DIFFERENTIAL EQUATIONS WITH RANDOM INPUT DATA

A MULTILEVEL STOCHASTIC COLLOCATION METHOD FOR PARTIAL DIFFERENTIAL EQUATIONS WITH RANDOM INPUT DATA A MULTILEVEL STOCHASTIC COLLOCATION METHOD FOR PARTIAL DIFFERENTIAL EQUATIONS WITH RANDOM INPUT DATA A. L. TECKENTRUP, P. JANTSCH, C. G. WEBSTER, AND M. GUNZBURGER Abstract. Stochastic collocation methods

More information

MULTISCALE FINITE ELEMENT METHODS FOR STOCHASTIC POROUS MEDIA FLOW EQUATIONS AND APPLICATION TO UNCERTAINTY QUANTIFICATION

MULTISCALE FINITE ELEMENT METHODS FOR STOCHASTIC POROUS MEDIA FLOW EQUATIONS AND APPLICATION TO UNCERTAINTY QUANTIFICATION MULTISCALE FINITE ELEMENT METHODS FOR STOCHASTIC POROUS MEDIA FLOW EQUATIONS AND APPLICATION TO UNCERTAINTY QUANTIFICATION P. DOSTERT, Y. EFENDIEV, AND T.Y. HOU Abstract. In this paper, we study multiscale

More information

Multi-element probabilistic collocation in high dimensions: Applications to systems biology and physical systems

Multi-element probabilistic collocation in high dimensions: Applications to systems biology and physical systems Multi-element probabilistic collocation in high dimensions: Applications to systems biology and physical systems by Jasmine Y. Foo Sc.M., Applied Mathematics, Brown University, 5 Sc.B., Mathematics/Physics,

More information

Contents. I Basic Methods 13

Contents. I Basic Methods 13 Preface xiii 1 Introduction 1 I Basic Methods 13 2 Convergent and Divergent Series 15 2.1 Introduction... 15 2.1.1 Power series: First steps... 15 2.1.2 Further practical aspects... 17 2.2 Differential

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

Pascal s Triangle on a Budget. Accuracy, Precision and Efficiency in Sparse Grids

Pascal s Triangle on a Budget. Accuracy, Precision and Efficiency in Sparse Grids Covering : Accuracy, Precision and Efficiency in Sparse Grids https://people.sc.fsu.edu/ jburkardt/presentations/auburn 2009.pdf... John Interdisciplinary Center for Applied Mathematics & Information Technology

More information

Sparse Grids for Stochastic Integrals

Sparse Grids for Stochastic Integrals John, Information Technology Department, Virginia Tech.... http://people.sc.fsu.edu/ jburkardt/presentations/ fsu 2009.pdf... Department of Scientific Computing, Florida State University, 08 October 2009.

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

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

Research Article A Pseudospectral Approach for Kirchhoff Plate Bending Problems with Uncertainties

Research Article A Pseudospectral Approach for Kirchhoff Plate Bending Problems with Uncertainties Mathematical Problems in Engineering Volume 22, Article ID 7565, 4 pages doi:.55/22/7565 Research Article A Pseudospectral Approach for Kirchhoff Plate Bending Problems with Uncertainties Ling Guo, 2 and

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

Slow Exponential Growth for Clenshaw Curtis Sparse Grids jburkardt/presentations/... slow growth paper.

Slow Exponential Growth for Clenshaw Curtis Sparse Grids   jburkardt/presentations/... slow growth paper. Slow Exponential Growth for Clenshaw Curtis Sparse Grids http://people.sc.fsu.edu/ jburkardt/presentations/...... slow growth paper.pdf John Burkardt, Clayton Webster April 30, 2014 Abstract A widely used

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

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

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 23.2012 July 2012 NEW 10.2013 Stochastic optimal

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

Introduction to Computational Stochastic Differential Equations

Introduction to Computational Stochastic Differential Equations Introduction to Computational Stochastic Differential Equations Gabriel J. Lord Catherine E. Powell Tony Shardlow Preface Techniques for solving many of the differential equations traditionally used by

More information

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 05.2013 February 2013 (NEW 10.2013 A weighted empirical

More information

4. Numerical Quadrature. Where analytical abilities end... continued

4. Numerical Quadrature. Where analytical abilities end... continued 4. Numerical Quadrature Where analytical abilities end... continued Where analytical abilities end... continued, November 30, 22 1 4.3. Extrapolation Increasing the Order Using Linear Combinations Once

More information

Dimension-adaptive sparse grid for industrial applications using Sobol variances

Dimension-adaptive sparse grid for industrial applications using Sobol variances Master of Science Thesis Dimension-adaptive sparse grid for industrial applications using Sobol variances Heavy gas flow over a barrier March 11, 2015 Ad Dimension-adaptive sparse grid for industrial

More information

Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders

Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders Solution of Stochastic Nonlinear PDEs Using Wiener-Hermite Expansion of High Orders Dr. Mohamed El-Beltagy 1,2 Joint Wor with Late Prof. Magdy El-Tawil 2 1 Effat University, Engineering College, Electrical

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

ASSESSMENT OF COLLOCATION AND GALERKIN APPROACHES TO LINEAR DIFFUSION EQUATIONS WITH RANDOM DATA

ASSESSMENT OF COLLOCATION AND GALERKIN APPROACHES TO LINEAR DIFFUSION EQUATIONS WITH RANDOM DATA International Journal for Uncertainty Quantification, 11):19 33, 2011 ASSESSMENT OF COLLOCATION AND GALERKIN APPROACHES TO LINEAR DIFFUSION EQUATIONS WITH RANDOM DATA Howard C. Elman, 1, Christopher W.

More information

arxiv: v2 [math.na] 6 Aug 2018

arxiv: v2 [math.na] 6 Aug 2018 Bayesian model calibration with interpolating polynomials based on adaptively weighted Leja nodes L.M.M. van den Bos,2, B. Sanderse, W.A.A.M. Bierbooms 2, and G.J.W. van Bussel 2 arxiv:82.235v2 [math.na]

More information

Spectral Representation of Random Processes

Spectral Representation of Random Processes Spectral Representation of Random Processes Example: Represent u(t,x,q) by! u K (t, x, Q) = u k (t, x) k(q) where k(q) are orthogonal polynomials. Single Random Variable:! Let k (Q) be orthogonal with

More information

Application of QMC methods to PDEs with random coefficients

Application of QMC methods to PDEs with random coefficients Application of QMC methods to PDEs with random coefficients a survey of analysis and implementation Frances Kuo f.kuo@unsw.edu.au University of New South Wales, Sydney, Australia joint work with Ivan Graham

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

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

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

Stochastic Regularity of a Quadratic Observable of High Frequency Waves

Stochastic Regularity of a Quadratic Observable of High Frequency Waves Research in the Mathematical Sciences manuscript No. (will be inserted by the editor) Stochastic Regularity of a Quadratic Observable of High Frequency Waves G. Malenová M. Motamed O. Runborg Received:

More information

AN ADAPTIVE REDUCED BASIS COLLOCATION METHOD BASED ON PCM ANOVA DECOMPOSITION FOR ANISOTROPIC STOCHASTIC PDES

AN ADAPTIVE REDUCED BASIS COLLOCATION METHOD BASED ON PCM ANOVA DECOMPOSITION FOR ANISOTROPIC STOCHASTIC PDES AN ADAPTIVE REDUCED BASIS COLLOCATION METHOD BASED ON PCM ANOVA DECOMPOSITION FOR ANISOTROPIC STOCHASTIC PDES Heyrim Cho & Howard Elman 2 Department of Mathematics, University of Maryland, College Park,

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

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

EXPLORING THE LOCALLY LOW DIMENSIONAL STRUCTURE IN SOLVING RANDOM ELLIPTIC PDES

EXPLORING THE LOCALLY LOW DIMENSIONAL STRUCTURE IN SOLVING RANDOM ELLIPTIC PDES MULTISCALE MODEL. SIMUL. Vol. 5, No. 2, pp. 66 695 c 27 Society for Industrial and Applied Mathematics EXPLORING THE LOCALLY LOW DIMENSIONAL STRUCTURE IN SOLVING RANDOM ELLIPTIC PDES THOMAS Y. HOU, QIN

More information

THE CHOICE OF AUXILIARY DENSITY FUNCTION IN STOCHASTIC COLLOCATION

THE CHOICE OF AUXILIARY DENSITY FUNCTION IN STOCHASTIC COLLOCATION IN STOCHASTIC COLLOCATION KELLIN RUMSEY & NEVIN MARTIN 12/06/2016 1 IN STOCHASTIC COLLOCATION 2 1. Introduction Stochastic collocation has been used in a wide range of application spaces as a way to efficiently

More information

A Polynomial Chaos Approach to Robust Multiobjective Optimization

A Polynomial Chaos Approach to Robust Multiobjective Optimization A Polynomial Chaos Approach to Robust Multiobjective Optimization Silvia Poles 1, Alberto Lovison 2 1 EnginSoft S.p.A., Optimization Consulting Via Giambellino, 7 35129 Padova, Italy s.poles@enginsoft.it

More information

A Reduced Basis Approach for Variational Problems with Stochastic Parameters: Application to Heat Conduction with Variable Robin Coefficient

A Reduced Basis Approach for Variational Problems with Stochastic Parameters: Application to Heat Conduction with Variable Robin Coefficient A Reduced Basis Approach for Variational Problems with Stochastic Parameters: Application to Heat Conduction with Variable Robin Coefficient Sébastien Boyaval a,, Claude Le Bris a, Yvon Maday b, Ngoc Cuong

More information

arxiv: v2 [math.na] 8 Sep 2017

arxiv: v2 [math.na] 8 Sep 2017 arxiv:1704.06339v [math.na] 8 Sep 017 A Monte Carlo approach to computing stiffness matrices arising in polynomial chaos approximations Juan Galvis O. Andrés Cuervo September 3, 018 Abstract We use a 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

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

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

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

Differentiation and Integration

Differentiation and Integration Differentiation and Integration (Lectures on Numerical Analysis for Economists II) Jesús Fernández-Villaverde 1 and Pablo Guerrón 2 February 12, 2018 1 University of Pennsylvania 2 Boston College Motivation

More information

On ANOVA expansions and strategies for choosing the anchor point

On ANOVA expansions and strategies for choosing the anchor point On ANOVA expansions and strategies for choosing the anchor point Zhen Gao and Jan S. Hesthaven August 31, 2010 Abstract The classic Lebesgue ANOVA expansion offers an elegant way to represent functions

More information

ELEMENTS OF PROBABILITY THEORY

ELEMENTS OF PROBABILITY THEORY ELEMENTS OF PROBABILITY THEORY Elements of Probability Theory A collection of subsets of a set Ω is called a σ algebra if it contains Ω and is closed under the operations of taking complements and countable

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

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

Nonlinear stochastic Galerkin and collocation methods: application to a ferromagnetic cylinder rotating at high speed

Nonlinear stochastic Galerkin and collocation methods: application to a ferromagnetic cylinder rotating at high speed Nonlinear stochastic Galerkin and collocation methods: application to a ferromagnetic cylinder rotating at high speed Eveline Rosseel Herbert De Gersem Stefan Vandewalle Report TW 541, July 29 Katholieke

More information

Scenario generation for stochastic optimization problems via the sparse grid method

Scenario generation for stochastic optimization problems via the sparse grid method Scenario generation for stochastic optimization problems via the sparse grid method Michael Chen Sanjay Mehrotra Dávid Papp March 7, 0 Abstract We study the use of sparse grids methods for the scenario

More information

Multi-Level Monte-Carlo Finite Element Methods for stochastic elliptic variational inequalities

Multi-Level Monte-Carlo Finite Element Methods for stochastic elliptic variational inequalities Multi-Level Monte-Carlo Finite Element Methods for stochastic elliptic variational inequalities R. Kornhuber and C. Schwab and M. Wolf Research Report No. 2013-12 April 2013 Seminar für Angewandte Mathematik

More information

TENSOR TRAIN APPROXIMATION OF MOMENT EQUATIONS FOR THE LOG-NORMAL DARCY PROBLEM

TENSOR TRAIN APPROXIMATION OF MOMENT EQUATIONS FOR THE LOG-NORMAL DARCY PROBLEM TENSOR TRAIN APPROXIMATION OF MOMENT EQUATIONS FOR THE LOG-NORMAL DARCY PROBLEM FRANCESCA BONIZZONI, FABIO NOBILE, AND DANIEL KRESSNER Abstract. We study the Darcy problem with log-normal permeability,

More information

Simultaneous Gaussian quadrature for Angelesco systems

Simultaneous Gaussian quadrature for Angelesco systems for Angelesco systems 1 KU Leuven, Belgium SANUM March 22, 2016 1 Joint work with Doron Lubinsky Introduced by C.F. Borges in 1994 Introduced by C.F. Borges in 1994 (goes back to Angelesco 1918). Introduced

More information

STRONGLY NESTED 1D INTERPOLATORY QUADRATURE AND EXTENSION TO ND VIA SMOLYAK METHOD

STRONGLY NESTED 1D INTERPOLATORY QUADRATURE AND EXTENSION TO ND VIA SMOLYAK METHOD 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK STRONGLY NESTED 1D INTERPOLATORY QUADRATURE AND

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