Introduction to Uncertainty Quantification in Computational Science Handout #3

Size: px
Start display at page:

Download "Introduction to Uncertainty Quantification in Computational Science Handout #3"

Transcription

1 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 Ricerca in Ingegneria Industriale Dottorato di Ricerca in Ingegneria Aerospaziale, Navale e della Qualita Universita di Napoli Federico II Based on the Lecture Notes for ME470 prepared with Dr. A. Doostan

2 Uncertainty Propagation Using Stochastic Collocation

3 Uncertainty Quantification Computational Framework Consider a generic computational model (y R d with d large) How do we handle the uncertainties? 1. Data assimilation: characterize uncertainties in the inputs 2. Uncertainty propagation: perform simulations accounting for the identified uncertainties 3. Certification: establish acceptance criteria for predictions

4 Sampling Methods Sample the random input parameter vector according to its probability distributions Perform a sequence of independent simulations Compute statistics of the quantity of interest

5 Sampling Methods Sample the random input parameter vector according to its probability distributions Perform a sequence of independent simulations Compute statistics of the quantity of interest Now we will introduce an alternative way of computing the output statistics without random sampling!

6 Numerical Integration The basic idea is to use advanced numerical integration techniques Recall numerical quadrature: Problem: Compute the integral of f (x) over the interval [a : b].

7 Numerical integration Express integrals as a finite, weighted sum b a f (ξ)dξ N w i f (ξ i ) i=1 Examples: midpoint, trapezoidal, Simpson rules Remark: all use equispaced abscissas ξ i [a : b] (Newton-Cotes)

8 Numerical integration Express integrals as a finite, weighted sum b a f (ξ)dξ N w i f (ξ i ) i=1 Examples: midpoint, trapezoidal, Simpson rules Remark: all use equispaced abscissas ξ i [a : b] (Newton-Cotes) We can do better: Gauss quadrature rules. Observation: We can always fit an N-1 degree polynomial to a set N points (N = 2 line, N 3 parabola, etc.).

9 Numerical integration Express integrals as a finite, weighted sum b a f (ξ)dξ N w i f (ξ i ) i=1 Examples: midpoint, trapezoidal, Simpson rules Remark: all use equispaced abscissas ξ i [a : b] (Newton-Cotes) We can do better: Gauss quadrature rules. Observation: We can always fit an N-1 degree polynomial to a set N points (N = 2 line, N 3 parabola, etc.). By carefully choosing the abscissas and weights (ξ i, w i ), we can exactly evaluate the integral if f (ξ) is (2N 1) degree polynomial.

10 Numerical integration Express integrals as a finite, weighted sum b a f (ξ)dξ N w i f (ξ i ) i=1 Examples: midpoint, trapezoidal, Simpson rules Remark: all use equispaced abscissas ξ i [a : b] (Newton-Cotes) We can do better: Gauss quadrature rules. Observation: We can always fit an N-1 degree polynomial to a set N points (N = 2 line, N 3 parabola, etc.). By carefully choosing the abscissas and weights (ξ i, w i ), we can exactly evaluate the integral if f (ξ) is (2N 1) degree polynomial. What are the abscissas ξ i and the weights w i?

11 Numerical quadrature b a f (ξ)dξ N w i f (ξ i ) i=1

12 Numerical quadrature b a f (ξ)dξ N w i f (ξ i ) i=1 The abscissas are the roots of orthogonal polynomials (Legendre) 1 1 p j (x)p i (x)dx = C i δ ij Abscissas: impose p N (ξ) = 0 ξ 1,..., ξ N

13 Numerical quadrature b a f (ξ)dξ N w i f (ξ i ) i=1 The abscissas are the roots of orthogonal polynomials (Legendre) 1 1 p j (x)p i (x)dx = C i δ ij Abscissas: impose p N (ξ) = 0 ξ 1,..., ξ N The weights are the integrals of the Lagrange interpolating polynomials passing through the abscissas w i = 1 1 L i,n (ξ)dξ with L i,n (ξ) = N k=1 k j ξ ξ k ξ i ξ k

14 Legendre-Gauss quadrature Legendre Polynomials (n+1)p n+1 (ξ) = (2n+1)ξP n (ξ) np n 1 (ξ) 1 1 P j (x)p i (x)dx = 2 2n + 1 δ ij Three-term recurrence Orthogonality

15 Legendre-Gauss quadrature Both the abscissas and the weights are tabulated and can be computed in several ways For example: function I = gauss(f,n) beta =.5/sqrt(1-(2*(1:n))^(-2)); T = diag(beta,1) + diag(beta,-1); [V,D] = eig(t); x = diag(d); [x,i] = sort(x); w = 2*V(1,i)^2; I = w*feval(f,x); % (n+1)-pt Gauss quadrature % 3-term recurrence coeffs % Jacobi matrix % eigenvalue decomposition % nodes (= Legendre points) % weights % the integral The command gauss(cos,6) yields which is correct to double precision [Trefethen, 2008]

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

17 Quadrature for Uncertainty Analysis Stochastic Collocation What does quadrature have to do with uncertainty? Assume y is a uniform random variable describing the uncertainty in the input and Q is he quantity of interest

18 Quadrature for Uncertainty Analysis Stochastic Collocation What does quadrature have to do with uncertainty? Assume y is a uniform random variable describing the uncertainty in the input and Q is he quantity of interest The mean of Q is Q = Q(y)f y dy = Q(y)dy if y = U(-1,1) Similarly for the variance, etc.

19 Quadrature for Uncertainty Analysis Stochastic Collocation What does quadrature have to do with uncertainty? Assume y is a uniform random variable describing the uncertainty in the input and Q is he quantity of interest The mean of Q is Q = Q(y)f y dy = Q(y)dy if y = U(-1,1) Similarly for the variance, etc. Moments of a quantity of interest are integrals in the probability space defined by the uncertain variables!

20 Stochastic Collocation For an input variables that is U( 1, 1) Generate N values of the parameters y k k = 1,..., N: abscissas (the zeros of the Legendre polynomial P N )

21 Stochastic Collocation For an input variables that is U( 1, 1) Generate N values of the parameters y k k = 1,..., N: abscissas (the zeros of the Legendre polynomial P N ) Perform N simulations according to the selected abscissas and obtain Q(y k )

22 Stochastic Collocation For an input variables that is U( 1, 1) Generate N values of the parameters y k k = 1,..., N: abscissas (the zeros of the Legendre polynomial P N ) Perform N simulations according to the selected abscissas and obtain Q(y k ) Compute statistics as weighted sums (the weights are integrals of Lagrange polynomials through the abscissas) Q = 1 1 Q(y)dy = N Q(y k )w k k=1

23 Stochastic Collocation For an input variables that is U( 1, 1) Generate N values of the parameters y k k = 1,..., N: abscissas (the zeros of the Legendre polynomial P N ) Perform N simulations according to the selected abscissas and obtain Q(y k ) Compute statistics as weighted sums (the weights are integrals of Lagrange polynomials through the abscissas) Q = 1 1 Q(y)dy = N Q(y k )w k k=1 No randomness is considered! but convergence is exponential (cfr. MC)

24 Beyond Uniform rvs Gaussian rvs What do we do if the input variables are not distributed as uniform r.v.?

25 Beyond Uniform rvs Gaussian rvs What do we do if the input variables are not distributed as uniform r.v.? As you probably know, numerical quadrature is more than just Legendre-Gauss quadrature!

26 Beyond Uniform rvs Gaussian rvs What do we do if the input variables are not distributed as uniform r.v.? As you probably know, numerical quadrature is more than just Legendre-Gauss quadrature! Consider y distributed as a N(0, 1), we can build orthogonal polynomials w.r.t. to a Gaussian measure as: p j (x)p i (x)e x 2 dx = C i δ ij Hermite polynomials for normal r.v. play the same role as Legendre polynomials for uniform r.v.s!

27 Hermite-Gauss quadrature Hermite Polynomials H n+1 (ξ) = 2ξH n (ξ) 2nH n 1 (ξ) H j (x)h i (x)e x 2 dx = 2 i i! πδ ij Three-term recurrence Orthogonality

28 Stochastic Collocation Summary of the quadrature rules We can use Legendre or Hermite polynomials, can we do even more?

29 Stochastic Collocation Summary of the quadrature rules We can use Legendre or Hermite polynomials, can we do even more? Distribution pdf Polynomials Weights Support Uniform 1/2 Legendre 1 [ 1 : 1] Gaussian (1/ 2π)e ( x2 /2) Hermite e ( x2 /2) [ : ] Exponential e x Laguerre e x [0 : ] (1 x) Beta (1+x) β B(α,β) Jacobi (1 x) α (1 + x) β [ 1 : 1] Table: Some polynomials in the Askey family

30 Stochastic Collocation Summary of the quadrature rules We can use Legendre or Hermite polynomials, can we do even more? Distribution pdf Polynomials Weights Support Uniform 1/2 Legendre 1 [ 1 : 1] Gaussian (1/ 2π)e ( x2 /2) Hermite e ( x2 /2) [ : ] Exponential e x Laguerre e x [0 : ] (1 x) Beta (1+x) β B(α,β) Jacobi (1 x) α (1 + x) β [ 1 : 1] Table: Some polynomials in the Askey family What if the random variables are not distributed according to any of the above?

31 Stochastic Collocation Summary of the quadrature rules We can use Legendre or Hermite polynomials, can we do even more? Distribution pdf Polynomials Weights Support Uniform 1/2 Legendre 1 [ 1 : 1] Gaussian (1/ 2π)e ( x2 /2) Hermite e ( x2 /2) [ : ] Exponential e x Laguerre e x [0 : ] (1 x) Beta (1+x) β B(α,β) Jacobi (1 x) α (1 + x) β [ 1 : 1] Table: Some polynomials in the Askey family What if the random variables are not distributed according to any of the above? 1. Szego (1939). Orthogonal Polynomials - American Mathematical Society. 2. Schoutens (2000). Stochastic Processes and Orthogonal Polynomial - Springer. 3. Gram-Schmidt Procedure

32 Nested rules The choice of abscissas The Gauss quadrature rules introduce different abscissas for each order N considered. They are not nested, no reuse of computed solutions for lower-order quadrature

33 Nested rules The choice of abscissas The Gauss quadrature rules introduce different abscissas for each order N considered. They are not nested, no reuse of computed solutions for lower-order quadrature Two extensions are possible Gauss-Kronrod rules Clenshaw-Curtis rules: express the integrand using Chebyshev polynomials (lower polynomial exactness) Figure: 32 abscissas in [ 1 : 1]

34 Clenshaw-Curtis vs. Gauss Figure: Black: Gauss, White: CC [Trefethen, 2008]

35 Why Nested rules? Assume you have a budget of N = 9 computations. With 9 Gauss abscissas (Legendre), we can obtain an estimate of the statistics of the solution which would be exact if the solution is a polynomial of degree 2N = 18

36 Why Nested rules? Assume you have a budget of N = 9 computations. With 9 Gauss abscissas (Legendre), we can obtain an estimate of the statistics of the solution which would be exact if the solution is a polynomial of degree 2N = 18 With Clenshaw-Curtis we can obtain again an estimate (only exact for polynomials of degree N = 9). On the other hand, with the same computations (N = 9 abscissas) we can also estiamte the solution statistics corresponding to N = 5 and N = 3 error estimate.

37 Multi-dimensional rules Tensor Product The extension of the previous 1D rules (Gauss or CC) is straightforward The abscissas are tensor products of the quadrature points in 1D The weights are the products of the 1D weights

38 Multi-dimensional rules Tensor Product The extension of the previous 1D rules (Gauss or CC) is straightforward The abscissas are tensor products of the quadrature points in 1D The weights are the products of the 1D weights The number of function evaluations increases as N d curse of dimensionality

39 Multi-dimensional rules Sparse Grids - Smolyak Grids Smolyak idea is to sparsify the construction of quadrature grids Figure: Sequence of grids used in 2D by a nested rule

40 Multi-dimensional rules Sparse Grids - Smolyak Grids The nominal accuracy can be preserved with much less points Figure: From Tensor grid to Sparse grid in 2D

41 Multi-dimensional rules Sparse Grids - Smolyak Grids The nominal accuracy can be preserved with much less points Figure: From Tensor grid to Sparse grid in 2D The trick is to use a linear combination of tensor products to build the actual sparse grid

42 Sparse Grids Stochastic Collocation Table: Abscissas for N = 5 in each dimension d = 2 d = 3 d = 4 d = 5 d = 6 d = 7 Tensor Gauss Smolyak Gauss Smolyak CC

43 Stochastic collocation Consider the integral (with a i and b i U(0,1)) [Webster et al. 2006] exp [ ] N ai 2 (y i b i ) 2 d y i=1

44 Stochastic collocation Consider the integral (with a i and b i U(0,1)) [Webster et al. 2006] exp [ ] N ai 2 (y i b i ) 2 d y i=1

45 Sparse Grids Summary A fundamental advance in the development of stochastic collocation approaches in multid Becoming more and more popular

46 Sparse Grids Summary A fundamental advance in the development of stochastic collocation approaches in multid Becoming more and more popular Not perfect Not straightforward to construct (implementation errors) Can lead to negative weights Does not solve the curse of dimensionality, although it is better than tensor grids

47 Uncertainty Propagation Using Response Surfaces

48 Response surface Stochastic collocation methods allows to compute moments of the solution using fewer function evaluations than MC. In same cases we still want to build the PDF, or evaluate a reliability constraint. One possibility is to build an interpolant of the collocation points, for example a Lagrange interpolating polynomial, and then to sample using MC The interpolant is called a response surface, as it represent the approximate dependency of the solution on the input paramters

49 Stochastic Collocation Example Figure: Unstructured grid used in the present computations showing the strong clustering at the cylinder surface to capture the boundary layer. The dark region is the actual computational domain: periodic conditions are used on the upper and lower boundary.

50 Stochastic Collocation Example Figure: Temperature distribution for the baseline case.

51 Stochastic Collocation Example Figure: Streamlines for the baseline case.

52 Stochastic Collocation: Example (a) GL rule on sparse grid. (b) GL rule on tensor grid (c) CC rule on sparse grid (d) CC rule on tensor grid Figure: Expectation of x 1 -velocity along the domain centerline (x 2 = 0).

53 Stochastic Collocation: Example (a) GL rule on sparse grid. (b) GL rule on tensor grid (c) CC rule on sparse grid (d) CC rule on tensor grid Figure: Expectation of the temperature on the cylinder surface.

54 Stochastic Collocation: Example (a) GL rule on sparse-grid. (b) GL rule on tensor grid (c) CC rule on sparse-grid (d) CC rule on tensor grid Figure: Variance of the temperature on the cylinder surface.

55 Stochastic Collocation: Example (a) GL rule on sparse-grid. (b) GL rule on tensor grid (c) CC rule on sparse-grid (d) CC rule on tensor grid Figure: Probability density function of the stochastic temperature at the stagnation point.

56 Stochastic Collocation: Example (a) GL rule on sparse-grid. (b) GL rule on tensor grid (c) CC rule on sparse-grid (d) CC rule on tensor grid Figure: Probability density function of the x 1 -velocity in the wake at the point (2,0).

57 Stochastic Galerkin Approach for Hyperbolic Systems

58 Polynomial Chaos Stochastic Galerkin Approach The unknown is expressed as a spectral expansion of "one" random variable ξ Ω (assumed to be a Gaussian) u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 The ψ i (ξ) are Hermite polynomials and form a complete set of orthogonal basis functions Orthogonal Polynomials ψ n ψ m = Ω ψ n(ξ)ψ m (ξ)w(ξ)dξ = h n δ n,m E[ψ 0 ] = Ω ψ 0(ξ)w(ξ)dξ = 1 E[ψ k ] = Ω ψ k(ξ)w(ξ)dξ = 0, k > 0 where w(ξ) is the pdf of ξ and h n are non-zero constants

59 Polynomial Chaos Stochastic Galerkin Approach Given u(x, t, ξ) = u i (x, t)ψ i (ξ) we can compute the moments Expectation of u u 0 E[u] = Ω Variance of u Ω i=0 uw(ξ)dξ = ψ 0 (ξ)w(ξ)dξ + Var[u] = E[u 2 ] (E[u]) 2 = Ω u i i=1 i=0 u 2 i ( ) u i ψ i w(ξ)dξ = Ω Ω i=0 ψ i (ξ)w(ξ)dξ = u 0 = E[u] ψi 2 w(ξ)dξ u0 2 = ui 2 ψi 2. i=1

60 Polynomial Chaos 1D Linear Convection Equations Consider the 1D linear convection equations u t + cu x = 0 0 x 1 The exact solution is u(x, t) = u initial (x ct)

61 Polynomial Chaos 1D Linear Convection Equations Consider the 1D linear convection equations u t + cu x = 0 0 x 1 The exact solution is u(x, t) = u initial (x ct) Assume the uncertainty is characterized by one parameter; let it be a Guassian random variable ξ Ω

62 Polynomial Chaos 1D Linear Convection Equations Consider the 1D linear convection equations u t + cu x = 0 0 x 1 The exact solution is u(x, t) = u initial (x ct) Assume the uncertainty is characterized by one parameter; let it be a Guassian random variable ξ Ω Consider a (truncated) spectral expansion of the solution in the random space u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 P u i (x, t)ψ i (ξ) i=0 where ψ i (ξ) are (1D) Hermite polynomials (ψ 0 = 1; ψ 1 = ξ; ψ 2 = ξ 2 1; ψ 3 = ξ 3 3ξ; etc.)

63 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition Assume The exact solution is u initial (x, t = 0, ξ) = g(ξ)cos(x) u(x, t, ξ) = g(ξ)cos(x ct)

64 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition Assume The exact solution is u initial (x, t = 0, ξ) = g(ξ)cos(x) u(x, t, ξ) = g(ξ)cos(x ct) Plug in the truncated expansion is the original PDE: ( P P ) u i t ψ u i i(ξ) + c x ψ i(ξ) = 0 i=0 i=0

65 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition Assume The exact solution is u initial (x, t = 0, ξ) = g(ξ)cos(x) u(x, t, ξ) = g(ξ)cos(x ct) Plug in the truncated expansion is the original PDE: ( P P ) u i t ψ u i i(ξ) + c x ψ i(ξ) = 0 i=0 i=0 Multiply by ψ k (ξ) and integrate over the probability space Ω (Galerkin Projection) P u i P t ψ u i iψ k + c x ψ iψ k = 0 for k = 0, 1,..., P. i=0 i=0

66 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition We have P u i P t ψ iψ k + c i=0 i=0 u i x ψ iψ k = 0 for k = 0, 1,..., P.

67 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition We have P u i P t ψ iψ k + c i=0 i=0 u i x ψ iψ k = 0 for k = 0, 1,..., P. The orthogonality property ψ i ψ k = δ ik h k implies u 0 t u P t + c u 0 x = 0 + c u P x = 0 We obtain a system of P + 1 uncoupled & deterministic eqns.

68 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the initial condition Initial conditions for the u 0... u P equations are obtained by projection of the initial condition u initial (x, t = 0, ξ), ψ k = u k (x, t = 0) = = g(ξ), ψ k cos(x) k = 0,..., P The procedure is simply an approximation of g(ξ) on the polynomial basis ψ(ξ)

69 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the transport velocity Assume The exact solution is c = h(ξ) u(x, t, ξ) = cos(x h(ξ)t)

70 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the transport velocity Assume The exact solution is c = h(ξ) u(x, t, ξ) = cos(x h(ξ)t) Plug in the truncated expansion is the original PDE: ( P P ) u i t ψ u i i(ξ) + h(ξ) x ψ i(ξ) = 0 i=0 i=0

71 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the transport velocity Assume The exact solution is c = h(ξ) u(x, t, ξ) = cos(x h(ξ)t) Plug in the truncated expansion is the original PDE: ( P P ) u i t ψ u i i(ξ) + h(ξ) x ψ i(ξ) = 0 i=0 i=0 Multiply by ψ k (ξ) and integrate over the probability space Ω (Galerkin Projection) P u i P t ψ u i iψ k + x h(ξ)ψ iψ k = 0 for k = 0, 1,..., P. i=0 i=0

72 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the transport velocity If we assume P h h(ξ) = h j ψ j (ξ) j=0 The system of equations becomes P i=0 u i t ψ iψ k + P i=0 u i x P h h j ψ j ψ i ψ k = 0 for k = 0, 1,..., P. j=0 We obtain a system of P + 1 coupled & deterministic eqns.

73 Polynomial Chaos 1D Linear Convection Equations - uncertainty in the transport velocity If we assume P h h(ξ) = h j ψ j (ξ) j=0 The system of equations becomes P i=0 u i t ψ iψ k + P i=0 u i x P h h j ψ j ψ i ψ k = 0 for k = 0, 1,..., P. j=0 We obtain a system of P + 1 coupled & deterministic eqns. This is a much tougher non-linear problem and leads to the long-time integration issue [Gottlieb & Xiu, 2008]

74 Polynomial Chaos 1D Burgers Equations Consider the 1D Burgers equations u t + uu x = 0 0 x 1 Assume the uncertainty is characterized by one parameter; let it be a Guassian random variable ξ Ω Consider a (truncated) spectral expansion of the solution in the random space u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 P u i (x, t)ψ i (ξ) i=0 where ψ i (ξ) are (1D) Hermite polynomials (ψ 0 = 1; ψ 1 = ξ; ψ 2 = ξ 2 1; ψ 3 = ξ 3 3ξ; etc.)

75 Polynomial Chaos 1D Burgers Equations Plug in the governing equations ( P u i P t ψ P i(ξ) + u j ψ j (ξ) i=0 j=0 i=0 u i x ψ i(ξ) ) = 0

76 Polynomial Chaos 1D Burgers Equations Plug in the governing equations ( P u i P t ψ P i(ξ) + u j ψ j (ξ) i=0 j=0 i=0 u i x ψ i(ξ) ) = 0 Multiply by ψ k (ξ) and integrate over the probability space Ω (Galerkin Projection) P i=0 u i t ψ iψ k + P P i=0 j=0 u i u j x ψ iψ j ψ k = 0 for k = 0, 1,..., P. We obtain a system of P + 1 coupled & deterministic equations (independently of the type of uncertainty)

77 Polynomial Chaos 1D Burgers Equations PC expansion for the Burgers equations P i=0 u i t ψ iψ k + P P i=0 j=0 Double/Triple products are numbers ψ i ψ j ψ k = and s = (i + j + k)/2 u i u j x ψ iψ j ψ k = 0 for k = 0, 1,..., P. ψ i ψ j = δ ij i! { 0 if i + j + k is odd or max(i, j, k) > s i!j!k! (s i)!(s j)!(s k)! otherwise

78 Polynomial Chaos 1D Burgers Equations PC Expansion for the Burgers equations P=1 u 0 t u 1 t u 0 + u 0 x + u u 1 1 x + u 1 u 0 x + u 0 u 1 x = 0 = 0

79 Polynomial Chaos 1D Burgers Equations PC Expansion for the Burgers equations P=1 u 0 t u 1 t u 0 + u 0 x + u u 1 1 x + u 1 u 0 x + u 0 u 1 x = 0 = 0 PC Expansion for the Burgers equations P=2 u 1 t u 2 t u 0 t u 0 + u 0 x + u u 1 1 x + 2u u 2 2 x + u 1 u 0 x + (u 0 + 2u 2 ) u 1 + u 2 u 0 x + u 1 u 2 x x + 2u 1 u 1 x + (u 0 + 4u 2 ) u 2 x = 0 = 0 = 0

80 Simple example 1D Viscous Burgers Governing equation; note the modified convective flux: Exact solution 1 u (1 u) 2 x = u µ 2 u 2 u(x) = 1 2 [ ( )] x 1 + tanh 4µ Assume uncertainty in the viscosity - Gaussian r.v. with E[µ] = 0.25 and Var[µ] =

81 Monte Carlo Sampling 1D Viscous Burgers Expectation of the solution: Computed solution (32 points) Exact solution

82 Monte Carlo Sampling 1D Viscous Burgers Variance of the solution: Computed solution (32 points) Exact solution

83 Polynomial Chaos 1D Viscous Burgers Statistics of the solution: Expectation Variance

84 Polynomial Chaos 1D Viscous Burgers Polynomial chaos modes of the solution (P = 3) Coefficients 0 and 1 Coefficients 2 and 3 Mode 0 is the mean (as expected) Mode 1 is dominant with respect to the others (u 2 1 closely approximates the variance)

85 Polynomial Chaos Observations Let s consider the PC expansion with P = 1 u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 1 u i (x, t)ψ i (ξ) = u 0 + u 1 ξ i=0

86 Polynomial Chaos Observations Let s consider the PC expansion with P = 1 u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 1 u i (x, t)ψ i (ξ) = u 0 + u 1 ξ i=0 The output is a linear function of the input uncertainty!

87 Polynomial Chaos Observations Let s consider the PC expansion with P = 1 u(x, t, ξ) = u i (x, t)ψ i (ξ) i=0 1 u i (x, t)ψ i (ξ) = u 0 + u 1 ξ i=0 The output is a linear function of the input uncertainty! Remark: ξ = N (0, 1) = u = N (u 0, u 2 1 ) As a consequence f u = e (u u 0) 2 /2u 2 1 2π u1 independently of the governing PDE!

88 Polynomial Chaos 1D Heat Conduction ( ) u(x, ξ) a(x, ξ) = f x D (0, 1) x x u(0, ξ) = u(1, ξ) = 0 where the diffusivity a(x, ξ) is a random field over D where: 0 < a min < a(x, ξ) < a max

89 Polynomial Chaos 1D Heat Conduction ( ) u(x, ξ) a(x, ξ) = f x D (0, 1) x x u(0, ξ) = u(1, ξ) = 0 where the diffusivity a(x, ξ) is a random field over D where: 0 < a min < a(x, ξ) < a max How to define the conductivity? We need data!

90 Polynomial Chaos 1D Heat Conduction We need to represent a random field to describe the conductivity a(x, ξ)

91 Polynomial Chaos 1D Heat Conduction We need to represent a random field to describe the conductivity a(x, ξ) One option is to use a polynomial-chaos type representation: P a a(x, ξ) = a k (x)ψ k k=0 For P a sufficiently high we can represent the random process Figure: Microstructures in a metal (From Professor H. Fujii, JWRI)

92 Polynomial Chaos 1D Heat Conduction ( ) u(x, ξ) a(x, ξ) = f x D (0, 1) x x u(0, ξ) = u(1, ξ) = 0 Plug in the expressions for the (unknown) solution u(x, ξ) = P k=0 u k(x)ψ k and the conductivity a(x, ξ) = P a k=0 a k(x)ψ k, and perform the Galerkin projection: * XP a a k (x)ψ k ( ) P P j=0 u! + j(x)ψ j ( ) f, ψ i = 0 i = 0, 1,, P x x k=0 (1)

93 Polynomial Chaos 1D Heat Conduction Since ψ i ψ j = δ ij ψ i ψ i and ψ 0 = 1 and ψ i = 0, i = 1,, P,!! PX P a X u j (x) a k (x)c ijk = f i = 0 x x j=0 PX x j=0 with C ijk = ψ i ψ j ψ k k=0 XP a k=0 u i (0) = u i (1) = 0 a k (x)c ijk! u j (x) x! i = 0, 1,, P = 0 i = 1,, P This is a system of P + 1 coupled elliptic PDEs

94 Polynomial Chaos 1D Heat Conduction The coupling is due to the randomness in the diffusion term and the fact that in general C ijk δ ij, k Notice the similarity of the terms corresponding to indices i, j and the deterministic version of the original PDE, i.e. when the diffusivity is just a function of space x. However, due to the coupling, one cannot use deterministic codes without changing them accordingly. This is why the Stochastic Galerkin scheme is called an intrusive technique. The space discretization of the coupled system can be done through a suitable scheme of one s choice, e.g. Finite Element, Finite Difference, etc. Due to orthogonality of basis some terms cancel out

95 Polynomial Chaos 1D Heat Conduction K 0,0 K 0,1 K 0,P K 1,0 K 1,1 K 1,P K P,0 K P,1 K P,P u 0 u 1. u P = f The left-hand-side (l.h.s) matrix is block symmetric The l.h.s matrix is symmetric if the space discretization is symmetric If the number of degrees-of-freedom for the space discretization of each u i (x) is N then: Each block K i,j has size N N Thus the l.h.s. matrix has size N(P + 1) N(P + 1)

96 Polynomial Chaos 1D Heat Conduction When a(x, y) is linear w.r.t. y the l.h.s matrix is sparse (C ijk = ψ i ψ j ψ k is sparse) d = 4, p = 1, nnz = 13 d = 4, p = 2, nnz = 55 d = 4, p = 3, nnz = 155 When a(x, y) is non-linear w.r.t. y and p a 2p the l.h.s matrix is full (easy to show)

97 Polynomial Chaos Navier-Stokes Equations Consider the NS equations for an incompressible fluid u i x i = 0 u i t + u j u i x j = 1 ρ p x i + µ 2 u i x j x j

98 Polynomial Chaos Navier-Stokes Equations Consider the NS equations for an incompressible fluid u i t u i x i = 0 u i + u j = 1 p + µ 2 u i x j ρ x i x j x j Assuming that the uncertainty is represented with one uncertain variable ξ, the usual polynomial chaos expansion reads u i (x, t, ξ) = P j=0 u (j) i (x, t)ψ j (ξ) p(x, t, ξ) = P p (j) (x, t)ψ j (ξ) j=0

99 Polynomial Chaos Navier-Stokes Equations The PC expansion for the velocity plugged in the continuity ( u i / x i = 0) gives u (k) i x i = 0 k = 0,..., P

100 Polynomial Chaos Navier-Stokes Equations The PC expansion for the velocity plugged in the continuity ( u i / x i = 0) gives u (k) i x i = 0 k = 0,..., P The momentum equation instead becomes (for each k component) u (k) i t + P P m=0 n=0 u (m) u (n) i ψ m ψ n ψ k j = 1 p (k) x j ψ k ψ k ρ x i + µ 2 u (k) i x j x j

101 Polynomial Chaos Navier-Stokes Equations The PC expansion for the velocity plugged in the continuity ( u i / x i = 0) gives u (k) i x i = 0 k = 0,..., P The momentum equation instead becomes (for each k component) u (k) i t + P P m=0 n=0 u (m) u (n) i ψ m ψ n ψ k j = 1 p (k) x j ψ k ψ k ρ x i + µ 2u (k) i x j x j We obtain P + 1 equations for the velocity-mode vectors and P + 1 constraints.

102 Polynomial Chaos Navier-Stokes Equations The PC expansion for the velocity plugged in the continuity ( u i / x i = 0) gives u (k) i x i = 0 k = 0,..., P The momentum equation instead becomes (for each k component) u (k) i t + P P m=0 n=0 u (m) u (n) i ψ m ψ n ψ k j = 1 p (k) x j ψ k ψ k ρ x i + µ 2u (k) i x j x j We obtain P + 1 equations for the velocity-mode vectors and P + 1 constraints. Not dissimilar from deterministic system Can be solved by projection and results in a coupled system of 3 (P + 1) momentum-like equations with P + 1 constraints.

103 Summary of Probabilistic Uncertainty Propagation Methods

104 Probabilistic Approaches to UQ Define/characterize the input uncertainty in terms of a set of d random variables Propagation methodologies Sampling-based techniques: MC, LHS Quadrature-based methods: SC Galerkin-based approaches: PC Compute statistics of the output of interest

105 Probabilistic Approaches to UQ Computing statistics Sampling methods compute statistics and pdf by interrogating the parameter space SC and PC are radically different, because the moments are computed explicitly SC: from quadrature rules PC: by construction from the assumed solution representation

106 Probabilistic Approaches to UQ Computing statistics Sampling methods compute statistics and pdf by interrogating the parameter space SC and PC are radically different, because the moments are computed explicitly SC: from quadrature rules PC: by construction from the assumed solution representation How do we compute the pdf in SC and PC? We interpret both SC and PC as approximate (surrogate) representations of the solution that depend continuously on the input random variables

107 Probabilistic Approaches to UQ Computing pdfs We interpret both SC and PC as approximate (surrogate) representations of the solution that depend continuously on the input random variables

108 Probabilistic Approaches to UQ Computing pdfs We interpret both SC and PC as approximate (surrogate) representations of the solution that depend continuously on the input random variables P PC: it is obvious that u(x, t, ξ) u P G = u i (x, t)ψ i (ξ) we can sample (MC) ug P (x, t, ξ) directly i=0

109 Probabilistic Approaches to UQ Computing pdfs We interpret both SC and PC as approximate (surrogate) representations of the solution that depend continuously on the input random variables P PC: it is obvious that u(x, t, ξ) u P G = u i (x, t)ψ i (ξ) we can sample (MC) ug P (x, t, ξ) directly SC: Gaussian quadrature rules are weighted sums where the weights are integrals of Lagrange interpolating polynomials, therefore we can interpret SC as M u(x, t, ξ) uc M = u(x, t, ξ i )L i,p (ξ) i=0 we can sample (MC) uc M (x, t, ξ) directly i=0

110 Probabilistic Approaches to UQ Computing pdfs We interpret both SC and PC as approximate (surrogate) representations of the solution that depend continuously on the input random variables P PC: it is obvious that u(x, t, ξ) u P G = u i (x, t)ψ i (ξ) we can sample (MC) ug P (x, t, ξ) directly SC: Gaussian quadrature rules are weighted sums where the weights are integrals of Lagrange interpolating polynomials, therefore we can interpret SC as M u(x, t, ξ) uc M = u(x, t, ξ i )L i,p (ξ) i=0 we can sample (MC) uc M (x, t, ξ) directly Note: sampling u, u G and u C is NOT in general equivalent! i=0

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

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

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

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

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

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

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

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

An Empirical Chaos Expansion Method for Uncertainty Quantification

An Empirical Chaos Expansion Method for Uncertainty Quantification An Empirical Chaos Expansion Method for Uncertainty Quantification Melvin Leok and Gautam Wilkins Abstract. Uncertainty quantification seeks to provide a quantitative means to understand complex systems

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

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

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

Numerical Integration (Quadrature) Another application for our interpolation tools!

Numerical Integration (Quadrature) Another application for our interpolation tools! Numerical Integration (Quadrature) Another application for our interpolation tools! Integration: Area under a curve Curve = data or function Integrating data Finite number of data points spacing specified

More information

Accepted Manuscript. SAMBA: Sparse approximation of moment-based arbitrary polynomial chaos. R. Ahlfeld, B. Belkouchi, F.

Accepted Manuscript. SAMBA: Sparse approximation of moment-based arbitrary polynomial chaos. R. Ahlfeld, B. Belkouchi, F. Accepted Manuscript SAMBA: Sparse approximation of moment-based arbitrary polynomial chaos R. Ahlfeld, B. Belkouchi, F. Montomoli PII: S0021-9991(16)30151-6 DOI: http://dx.doi.org/10.1016/j.jcp.2016.05.014

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

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

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

UNIVERSITY OF CALIFORNIA, SAN DIEGO. An Empirical Chaos Expansion Method for Uncertainty Quantification

UNIVERSITY OF CALIFORNIA, SAN DIEGO. An Empirical Chaos Expansion Method for Uncertainty Quantification UNIVERSITY OF CALIFORNIA, SAN DIEGO An Empirical Chaos Expansion Method for Uncertainty Quantification A Dissertation submitted in partial satisfaction of the requirements for the degree Doctor of Philosophy

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

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

Keywords: Sonic boom analysis, Atmospheric uncertainties, Uncertainty quantification, Monte Carlo method, Polynomial chaos method.

Keywords: Sonic boom analysis, Atmospheric uncertainties, Uncertainty quantification, Monte Carlo method, Polynomial chaos method. Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm SONIC BOOM ANALYSIS UNDER ATMOSPHERIC UNCERTAINTIES BY A NON-INTRUSIVE POLYNOMIAL CHAOS

More information

Fast Numerical Methods for Stochastic Computations: A Review

Fast Numerical Methods for Stochastic Computations: A Review COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol. 5, No. 2-4, pp. 242-272 Commun. Comput. Phys. February 2009 REVIEW ARTICLE Fast Numerical Methods for Stochastic Computations: A Review Dongbin Xiu Department

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

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

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

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

Performance Evaluation of Generalized Polynomial Chaos

Performance Evaluation of Generalized Polynomial Chaos Performance Evaluation of Generalized Polynomial Chaos Dongbin Xiu, Didier Lucor, C.-H. Su, and George Em Karniadakis 1 Division of Applied Mathematics, Brown University, Providence, RI 02912, USA, gk@dam.brown.edu

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 An Extended Abstract submitted for the 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada January 26 Preferred Session Topic: Uncertainty quantification and stochastic methods for CFD A Non-Intrusive

More information

In numerical analysis quadrature refers to the computation of definite integrals.

In numerical analysis quadrature refers to the computation of definite integrals. Numerical Quadrature In numerical analysis quadrature refers to the computation of definite integrals. f(x) a x i x i+1 x i+2 b x A traditional way to perform numerical integration is to take a piece of

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

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

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes).

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes). CE 025 - Lecture 6 LECTURE 6 GAUSS QUADRATURE In general for ewton-cotes (equispaced interpolation points/ data points/ integration points/ nodes). x E x S fx dx hw' o f o + w' f + + w' f + E 84 f 0 f

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

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

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

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

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 Quantification of Radionuclide Release Models using Non-Intrusive Polynomial Chaos. Casper Hoogwerf

Uncertainty Quantification of Radionuclide Release Models using Non-Intrusive Polynomial Chaos. Casper Hoogwerf Uncertainty Quantification of Radionuclide Release Models using Non-Intrusive Polynomial Chaos. Casper Hoogwerf 1 Foreword This report presents the final thesis of the Master of Science programme in Applied

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

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

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

arxiv: v2 [physics.comp-ph] 15 Sep 2015

arxiv: v2 [physics.comp-ph] 15 Sep 2015 On Uncertainty Quantification of Lithium-ion Batteries: Application to an LiC 6 /LiCoO 2 cell arxiv:1505.07776v2 [physics.comp-ph] 15 Sep 2015 Mohammad Hadigol a, Kurt Maute a, Alireza Doostan a, a Aerospace

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

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

Review of Polynomial Chaos-Based Methods for Uncertainty Quantification in Modern Integrated Circuits. and Domenico Spina

Review of Polynomial Chaos-Based Methods for Uncertainty Quantification in Modern Integrated Circuits. and Domenico Spina electronics Review Review of Polynomial Chaos-Based Methods for Uncertainty Quantification in Modern Integrated Circuits Arun Kaintura *, Tom Dhaene ID and Domenico Spina IDLab, Department of Information

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

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

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

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

Uncertainty Quantification in Computational Science

Uncertainty Quantification in Computational Science DTU 2010 - Lecture I Uncertainty Quantification in Computational Science Jan S Hesthaven Brown University Jan.Hesthaven@Brown.edu Objective of lectures The main objective of these lectures are To offer

More information

Hyperbolic Polynomial Chaos Expansion (HPCE) and its Application to Statistical Analysis of Nonlinear Circuits

Hyperbolic Polynomial Chaos Expansion (HPCE) and its Application to Statistical Analysis of Nonlinear Circuits Hyperbolic Polynomial Chaos Expansion HPCE and its Application to Statistical Analysis of Nonlinear Circuits Majid Ahadi, Aditi Krishna Prasad, Sourajeet Roy High Speed System Simulations Laboratory Department

More information

Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids

Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids Uncertainty Quantification for multiscale kinetic equations with high dimensional random inputs with sparse grids Shi Jin University of Wisconsin-Madison, USA Kinetic equations Different Q Boltmann Landau

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

Section 6.6 Gaussian Quadrature

Section 6.6 Gaussian Quadrature Section 6.6 Gaussian Quadrature Key Terms: Method of undetermined coefficients Nonlinear systems Gaussian quadrature Error Legendre polynomials Inner product Adapted from http://pathfinder.scar.utoronto.ca/~dyer/csca57/book_p/node44.html

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

TECHNISCHE UNIVERSITÄT MÜNCHEN. Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies

TECHNISCHE UNIVERSITÄT MÜNCHEN. Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies TECHNISCHE UNIVERSITÄT MÜNCHEN Bachelor s Thesis in Engineering Science Uncertainty Quantification in Fluid Flows via Polynomial Chaos Methodologies Jan Sültemeyer DEPARTMENT OF INFORMATICS MUNICH SCHOOL

More information

arxiv: v1 [math.na] 3 Apr 2019

arxiv: v1 [math.na] 3 Apr 2019 arxiv:1904.02017v1 [math.na] 3 Apr 2019 Poly-Sinc Solution of Stochastic Elliptic Differential Equations Maha Youssef and Roland Pulch Institute of Mathematics and Computer Science, University of Greifswald,

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

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

Ch. 03 Numerical Quadrature. Andrea Mignone Physics Department, University of Torino AA

Ch. 03 Numerical Quadrature. Andrea Mignone Physics Department, University of Torino AA Ch. 03 Numerical Quadrature Andrea Mignone Physics Department, University of Torino AA 2017-2018 Numerical Quadrature In numerical analysis quadrature refers to the computation of definite integrals. y

More information

Beyond Wiener Askey Expansions: Handling Arbitrary PDFs

Beyond Wiener Askey Expansions: Handling Arbitrary PDFs Journal of Scientific Computing, Vol. 27, Nos. 1 3, June 2006 ( 2005) DOI: 10.1007/s10915-005-9038-8 Beyond Wiener Askey Expansions: Handling Arbitrary PDFs Xiaoliang Wan 1 and George Em Karniadakis 1

More information

Quadrature Based Approximations of Non-integer Order Integrator on Finite Integration Interval

Quadrature Based Approximations of Non-integer Order Integrator on Finite Integration Interval Quadrature Based Approximations of Non-integer Order Integrator on Finite Integration Interval Jerzy Baranowski Abstract Implementation of non-integer order systems is the subject of an ongoing research.

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

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

Robust Optimal Control using Polynomial Chaos and Adjoints for Systems with Uncertain Inputs

Robust Optimal Control using Polynomial Chaos and Adjoints for Systems with Uncertain Inputs 2th AIAA Computational Fluid Dynamics Conference 27-3 June 211, Honolulu, Hawaii AIAA 211-369 Robust Optimal Control using Polynomial Chaos and Adjoints for Systems with Uncertain Inputs Sriram General

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

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

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

More information

EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES

EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES 9 th ASCE Specialty Conference on Probabilistic Mechanics and Structural Reliability EFFICIENT SHAPE OPTIMIZATION USING POLYNOMIAL CHAOS EXPANSION AND LOCAL SENSITIVITIES Nam H. Kim and Haoyu Wang University

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

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 and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs.

Uncertainty Quantification and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs. Uncertainty Quantification and hypocoercivity based sensitivity analysis for multiscale kinetic equations with random inputs Shi Jin University of Wisconsin-Madison, USA Shanghai Jiao Tong University,

More information

Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos

Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos Modeling Uncertainty in Flow Simulations via Generalized Polynomial Chaos Dongbin Xiu and George Em Karniadakis Division of Applied Mathematics Brown University Providence, RI 9 Submitted to Journal of

More information

A Framework for Statistical Timing Analysis using Non-Linear Delay and Slew Models

A Framework for Statistical Timing Analysis using Non-Linear Delay and Slew Models A Framework for Statistical Timing Analysis using Non-Linear Delay and Slew Models Sarvesh Bhardwaj, Praveen Ghanta, Sarma Vrudhula Department of Electrical Engineering, Department of Computer Science

More information

Scientific Computing: Numerical Integration

Scientific Computing: Numerical Integration Scientific Computing: Numerical Integration Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Fall 2015 Nov 5th, 2015 A. Donev (Courant Institute) Lecture

More information

Uncertainty Quantification for multiscale kinetic equations with random inputs. Shi Jin. University of Wisconsin-Madison, USA

Uncertainty Quantification for multiscale kinetic equations with random inputs. Shi Jin. University of Wisconsin-Madison, USA Uncertainty Quantification for multiscale kinetic equations with random inputs Shi Jin University of Wisconsin-Madison, USA Where do kinetic equations sit in physics Kinetic equations with applications

More information

c 2004 Society for Industrial and Applied Mathematics

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

More information

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

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

Method of Finite Elements I

Method of Finite Elements I Method of Finite Elements I PhD Candidate - Charilaos Mylonas HIL H33.1 and Boundary Conditions, 26 March, 2018 Institute of Structural Engineering Method of Finite Elements I 1 Outline 1 2 Penalty method

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

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

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

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

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

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

Strain and stress computations in stochastic finite element. methods

Strain and stress computations in stochastic finite element. methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 2007; 00:1 6 [Version: 2002/09/18 v2.02] Strain and stress computations in stochastic finite element methods Debraj

More information

Dynamic System Identification using HDMR-Bayesian Technique

Dynamic System Identification using HDMR-Bayesian Technique Dynamic System Identification using HDMR-Bayesian Technique *Shereena O A 1) and Dr. B N Rao 2) 1), 2) Department of Civil Engineering, IIT Madras, Chennai 600036, Tamil Nadu, India 1) ce14d020@smail.iitm.ac.in

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

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

Chapter 2 Spectral Expansions

Chapter 2 Spectral Expansions Chapter 2 Spectral Expansions In this chapter, we discuss fundamental and practical aspects of spectral expansions of random model data and of model solutions. We focus on a specific class of random process

More information

Electromagnetic Relaxation Time Distribution Inverse Problems in the Time-domain

Electromagnetic Relaxation Time Distribution Inverse Problems in the Time-domain Electromagnetic Relaxation Time Distribution Inverse Problems in the Time-domain Prof Nathan L Gibson Department of Mathematics Joint Math Meeting Jan 9, 2011 Prof Gibson (OSU) Inverse Problems for Distributions

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Miranda Holmes-Cerfon Applied Stochastic Analysis, Spring 2015 Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility),

More information

UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA

UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA UNCERTAINTY ASSESSMENT USING STOCHASTIC REDUCED BASIS METHOD FOR FLOW IN POROUS MEDIA A REPORT SUBMITTED TO THE DEPARTMENT OF ENERGY RESOURCES ENGINEERING OF STANFORD UNIVERSITY IN PARTIAL FULFILLMENT

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

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

ICES REPORT A posteriori error control for partial differential equations with random data

ICES REPORT A posteriori error control for partial differential equations with random data ICES REPORT 13-8 April 213 A posteriori error control for partial differential equations with random data by Corey M. Bryant, Serge Prudhomme, and Timothy Wildey The Institute for Computational Engineering

More information

. Frobenius-Perron Operator ACC Workshop on Uncertainty Analysis & Estimation. Raktim Bhattacharya

. Frobenius-Perron Operator ACC Workshop on Uncertainty Analysis & Estimation. Raktim Bhattacharya .. Frobenius-Perron Operator 2014 ACC Workshop on Uncertainty Analysis & Estimation Raktim Bhattacharya Laboratory For Uncertainty Quantification Aerospace Engineering, Texas A&M University. uq.tamu.edu

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

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