Partial Differential Equations with Stochastic Coefficients

Size: px
Start display at page:

Download "Partial Differential Equations with Stochastic Coefficients"

Transcription

1 Partial Differential Equations with Stochastic Coefficients Hermann G. Matthies gemeinsam mit Andreas Keese Institut für Wissenschaftliches Rechnen Technische Universität Braunschweig

2 Why Probabilistic or Stochastic Models? 2 Many descriptions (especially of future events) contain elements, which are uncertain and not precisely known. Future rainfall, or discharge from a river. More generally, the action from the surrounding environment. The system itself may contain only incompletely known parameters, processes or fields (not possible or too costly to measure) There may be small, unresolved scales in the model, they act as a kind of background noise. All these items introduce a certain kind of uncertainty in the model.

3 Ontology and Modelling 3 A bit of ontology: Uncertainty may be aleatoric, which means random and not reducible, or epistemic, which means due to incomplete knowledge. Stochastic models give quantitative information about uncertainty. They can be used to model both types of uncertainty. Possible areas of use: Reliability, heterogeneous materials, upscaling, incomplete knowledge of details, uncertain [inter-]action with environment, random loading, etc.

4 Quantification of Uncertainty 4 Uncertainty may be modelled in different ways: Intervals / convex sets do not give a degree of uncertainty, quantification only through size of sets. Fuzzy and possibilistic approaches model quantitative possibility with certain rules. Mathematically no measure. Evidence theory models basic probability, but also (as a generalisation) plausability (a kind of lower bound) and belief (a kind of upper bound) in a quantitative way. Mathematically no measures. Stochastic / probabilistic methods model probability quantitatively, have most developed theory.

5 Physical Models 5 Models for a system S may be stationary with state u, exterior action f and random model description (realisation) ω, which may include random fields S(u, ω) = f(ω). Evolution in time may be discrete (e.g. Markov chain), may be driven by discrete random process u n+ = F(u n, ω), or continuous, (e.g. Markov process, stochastic differential equation), may be driven by random processes du = (S(u, ω) f(ω, t))dt + B(u, ω)dw (ω, t) + P(u, ω)dq(ω, t) In this Itô evolution equation, W (ω, t) is the Wiener process, and Q(ω, t) is the (compensated) Poisson process.

6 References (Incomplete) 6 Formulation of PDEs with random coefficients, i.e. Stochastic Partial Differntial Equations (SPDEs): Babuška, Tempone; Glimm; Holden, Øksendal; Xiu, Karniadakis; M., Keese; Schwab, Tudor Spatial/temporal expansion of stochastic processes/ random fields: Adler; Fourier; Karhunen, Loève; Krée; Wiener White noise analysis/ polynomial chaos/ multiple Itô integrals: Cameron, Martin; Hida, Potthoff; Holden, Øksendal; Itô; Kondratiev; Malliavin; Wiener Galerkin methods for SPDEs: Babuška, Tempone; Benth, Gjerde; Cao; Ghanem, Spanos; Xiu, Karniadakis; M., Keese Adjoint Methods: Giles; Johnson; Kleiber; Marchuk; M., Meyer; Rannacher, Becker

7 Statistics 7 Desirable: Uncertainty Quantification or Optimisation under uncertainty: The goal is to compute statistics which are deterministic functionals of the solution: Ψ u = Ψ(u) := E (Ψ(u)) := Ψ(u(ω), ω) dp (ω) Ω e.g.: ū = E (u), or var u = E ( (ũ) 2), where ũ = u ū, or Pr{u u } = E ( ) χ {u u } Principal Approach:. Discretise / approximate physical model (e.g. via finite elements, finite differences), and approximate stochastic model (processes, fields) in finitely many independent random variables (RVs), stochastic discretisation. 2. Compute statistics: Via direct integration (e.g. Monte Carlo, Smolyak (= sparse grids)). Each integration point requires one PDE solution (with rough data). Or approximate solution with some response-surface, then integration by sampling a cheap expression at each integration point.

8 Model Problem 8 Geometry Aquifer 2D Model simple stationary model of groundwater flow (Darcy) (κ(x) u(x)) = f(x) & b.c., x G R d κ(x, u) u(x) = g(x), x Γ G, u hydraulic head, κ conductivity, f and g sinks and sources.

9 Stochastic Model 9 Uncertainty of system parameters e.g. κ = κ(x, ω) = κ(x) + κ(x, ω), f = f(x, ω), g = g(x, ω) are stochastic fields ω Ω = probability space of all realisations, with probability measure P. Assumption: < κ κ(x, ω) < κ. Possibilities: Bounded distributions (such as beta), or transformation / translation of Gaussian field γ κ(x, ω) = φ(x, γ(x, ω)) := F κ(x) (Φ(γ(x, ω))) x e.g. log-normal distribution (but this violates assumption), κ(x, ω) = a(x) + exp(γ(x, ω))

10 Realisation of κ(x, ω)

11 Stochastic PDE and Variational Form Insert stochastic parameters into PDE stochastic PDE (κ(x, ω) u(x, ω)) = f(x, ω), x G & b.c. on G Solution u(x, ω) is a stochastic field in tensor product form W S u(x, ω) = µ v µ (x) u (µ) (ω) = µ v µ (x)u (µ) (ω) W is a normal spatial Sobolev space, and S a space of random variables, e.g. S = L 2 (Ω, P ). Then W S L 2 (Ω, P ; W). Variational formulation: Find u W S, such that v W S : a(v, u) := v(x, ω) (κ(x, ω) u(x, ω)) dx dp (ω) = Ω Ω G [ G v(x, ω)f(x, ω) dx + G ] v(x, ω)g(x, ω) ds(x) dp (ω) =: f, v.

12 Mathematical Results 2 To find a solution u W S such that for v : a(v, u) = f, v is guaranteed by Lax-Milgram lemma, problem is well-posed in the sense of Hadamard (existence, uniqueness, continuous dependence on data f, g in L 2 and on κ in L -norm). may be approximated by Galerkin methods, convergence established with Céa s lemma Galerkin methods are stable, if no variational crimes are committed Good approximating subspaces of W S have to be found, as well as efficient numerical procedures worked out. Different ways to discretise: Simultaneously in W S, or first in W (spatial), or first in S (stochastic).

13 Computational Approach 3 Principal Approach:. Discretise spatial (and temporal) part (e.g. via finite elements, finite differences). 2. Represent computationally stochastic fields which are input to problem. 3. Compute solution/statistics: Directly via high-dimensional integration (e.g. Monte Carlo, Smolyak, FORM). Or approximate solution with response-surface, then integration Variational formulation discretised in space, e.g. via finite element ansatz u(x, ω) = n l= u l(ω)n l (x) = [N (x),..., N n (x)][u (ω),..., u n (ω)] T = N(x) T u(ω): K(ω)[u(ω)] = f(ω). Remark on Computing with Averages: Ku = f K u, as K and u are not independent, but if K and f are independent u = K f = K f K u = f

14 Example Solution 4 Geometry 2.5 flow = flow out.5 2 Sources Dirichlet b.c Realization of κ Realization of solution Mean of solution Variance of solution x Pr{u(x) > 8}.5 y.5

15 First Summary 5 Probabilistic formulation to quantify uncertainty, or find variation / distribution of response, Mathematical formulation in variational form gives well-posed problem Numerical approach may first perform familiar space / time semi-discretisation, Computational representation of input stochastic fields is needed, Statistics / Expectations may be computed either through direct integration with various methods (best known is Monte Carlo) or indirectly by first computing representation of solution u(ω) in terms of stochastic input, and then perform integration

16 Computational Requirements 6 How to represent a stochastic process for computation, both simulation or otherwise? Best would be as some combination of countably many independent random variables (RVs). How to compute the required integrals or expectations numerically? Best would be to have probability measure as a product measure P = P... P l, then integrals can be computed as iterated one-dimensional integrals via Fubini s theorem, Ψ dp (ω) = Ω... Ω Ψ dp (ω )... dp l (ω l ) Ω l

17 Random Fields 7 Consider region in space G, a random field is a RV κ x at each x G, alternatively for each ω Ω a random function a realisation κ ω (x) on G Mean κ(x) = E (κ ω (x)) now a function of x and fluctuating part κ(x, ω). Covariance may be considered at different positions C κ (x, x 2 ) := E ( κ(x, ) κ(x 2, )) If κ(x) κ, and C κ (x, x 2 ) = c κ (x x 2 ), process is (weakly) homogeneous. Here representation through spectrum as a Fourier sum or integral is well known. We have to deal with another function (RV) at each point x! Need to discretise spatial aspect (generalise Fourier representation). One possibility is the Karhunen-Loève Expansion. Need to discretise each of the random variables in Fourier synthesis. One possibility is the Polynomial Chaos Expansion.

18 Karhunen-Loève Expansion I 8 KL mode KL mode Eigenvalue-Problem for Karhunen-Loève Expansion KLE. Other names: Proper Orth. Decomp.(POD), Sing. Value Decomp.(SVD), Prncpl. Comp. Anal.(PCA): C κ (x, y)g j (y) dy = κ 2 jg j (x) G gives spectrum {κ 2 j} and orthogonal KLE eigenfunctions g j (x) Representation of κ: κ(x, ω) = κ(x) + κ j g j (x)ξ j (ω) =: κ j g j (x)ξ j (ω) = κ j g j (x) ξ j (ω) j= with centred, uncorrelated random variables ξ j (ω) with unit variance. Truncate after m largest eigenvalues optimal in variance expansion in m RVs. A sparse representation in tensor products. j= j=

19 Karhunen-Loève Expansion II 9 Singular Value Decomposition: To every random field with vanishing mean w(x, ω) W L 2 (Ω) (W Hilbert) associate a linear map W : W L 2 (Ω). W : W v W(v)(ω) = v( ), w(, ω) W = v(x)w(x, ω) dx L 2 (Ω). KLE is SVD of the map W, the covariance operator is C w := W W, and u, v W : u, C w v W = W(u), W(v) L2 (Ω) = ( E (W(u)W(v)) = E G G G u(x)w(x, ω) dx u(x)e (w(x, ω)w(y, ω)) v(y) dy dx = G G ) v(y)w(y, ω) dy G u(x) G = C w (x, y)v(y) dy dx The covariance operator C w is represented by the covariance kernel C w (x, y). Truncating the KLE is therefore the same as what is done when truncating a SVD, finding a sparse representation.

20 Representation in Gaussian Random Variables 2 How to handle the RVs {ξ j (ω)} in the KLE? In L 2 (Ω, P ) take the Hilbert subspace Θ of centred Gaussian RVs. Let {θ k (ω)} be an orthonormal (uncorrelated and unit variance) basis in the Gaussian Hilbert space Θ. For Gaussian RVs: uncorrelated independent. On a m-dimensional subspace Θ (m) = span{θ,..., θ m } we have (with the notation θ m (ω) = (θ (ω),..., θ m (ω)) R m ): Θ (m) can be represented by R m with a Gaussian product measure Γ m : dγ m (θ m ) = (2π) m/2 exp( θ m 2 /2) dθ m m m = dγ (θ j ) = (2π) /2 exp( θj 2 /2) dθ j j= j= Represent {ξ j (ω)} as functions of those Gaussian RVs, i.e. as functions of basis.

21 Polynomial Chaos Expansion 2 As Θ L p (Ω) p <, finite products of Gaussians are in L 2 (Ω): Theorem[Polynomial Chaos Expansion]: Any RV r(ω) L 2 (Ω, P ) can be represented in orthogonal polynomials of Gaussian RVs {θ m (ω)} m= =: θ(ω): r(ω) = ϱ (α) H α (θ(ω)), with H α (θ(ω)) = h αj (θ j (ω)), α J j= where J := N (N) = {α α = (α,..., α j,...), α j N, α := j= α j < }, are multi-indices, where only finitely many of the α j are non-zero, and h l (ϑ) are the usual Hermite polynomials. The series converges in L 2 (Ω). In other words, the H α are an orthogonal basis in L 2 (Ω), with H α, H β L2 (Ω) = E (H α H β ) = α! δ αβ, where α! := j= (α j!). H n = span{h α : α = n} is homogeneous chaos of degree n, and L 2 (Ω) = n= H n. Especially each ξ j (ω) = α ξ(α) j H α (θ(ω)) from KLE may be expanded in PCE.

22 Second Summary 22 Representation in a countable number of uncorrelated independent Gaussian RVs Allows direct simulation independent Gaussian RVs in computer by random generators (quasi-random), or direct hardware (e.g. sample noise from sound device). Each finite dimensional joint Gaussian measure Γ m (θ m ) is a product measure, allows Fubini s theorem (Γ m (θ) = m l= Γ (θ l )). Polynomial expansion theorem allows approximation of any random variable which depends on this representation, especially also the output / response u(x, ω) = u(x, θ), resp. in the spatially discretised case u(ω) = u(θ). Still open: How to actually compute u(θ)? How to perform integration? In which order?

23 Computational Approaches 23 The principal computational approaches are: Direct Integration (Monte Carlo) Directly compute statistic by quadrature: Ψ u = E (Ψ(u(ω), ω)) = Ψ(u(θ), θ) dγ (θ) by numerical integration. Θ Perturbation Assume that stochastics is a small perturbation around mean value, do Taylor expansion and truncate usually after linear or quadratic term. Response Surface Try to find a functional fit u(θ) v(θ), then compute with v. Integrand is now cheap. Stochastic Galerkin Use an ansatz for the solution u(θ) = β u(β) H β (θ) in the stochastic dimension, then do Galerkin method to obtain u (β). Observe that this is one possible functional form of response surface.

24 Stability Issues 24 For direct integration approaches direct expansion (both KLE and PCE) pose stability problems: Both expansions only converge in L 2, not in L (uniformly) as required spatially discrete problems to compute u(θ z ) for a specific realisation θ z may not be well posed. Convergence of KLE may be uniform if covariance C κ (x, x 2 ) smooth enough. E.g. not possible for C κ (x, x 2 ) = exp(a x x 2 + b) here for truncated KLE there are always regions in space where κ is negative. Truncation of PCE gives a polynomial, as soon as one α j is odd, there are θ j values where κ is negative compare approximating exp(ξ) with a truncated Taylor poplynomial at odd power. This can not be repaired. Like negative Jacobian in normal FEM. For methods which directly require u(θ z ) for a specific realisation, transformation method κ(x, ω) = φ(x, γ(x, ω)) possible with KLE of Gaussian γ(x, ω).

25 Stochastic Galerkin I 25 Recipe: Stochastic ansatz and projection in stochastic dimensions u(θ) = β u (β) H β (θ) = [..., u (β),...][..., H β (θ),...] T = uh(θ) Goal: Compute coefficients u (β). Directly through projection as explained, has problems. 2. Through stochastic Galerkin Methods (weighted residuals), α : E ( H α (θ)(f(θ) K(θ)u(θ)) ) =, requires solution of one huge system, only integrals of residua 3. For stochastic Galerkin methods the convergence issues of KLE and PCE may be solved. A (forgivable) variational crime like numerical integration in normal FEM.

26 Stochastic Galerkin II 26 Of course we can not use all α J, but we limit ourselves to a finite subset J k,m = {α J α k, ı > m α ı = } J. Let S k,m = span{h α : α J k,m }, ( ) m + p + then dim S k,m = p + m k dim S k,m

27 Third Summary 27 Integration may require many evaluations of integrand, if combined with expensive to evaluate integrand tremendous effort (this hits direct Monte Carlo). Direct integration and response surface method is conceptually simple, but may have stability problems. Stochastic Galerkin methods require solution of huge system, and a bit more changes to existing programs. Stochastic Galerkin methods require only much cheaper integrands of residua. Stochastic Galerkin methods are stable (here (variational) crime pays).

28 Results of Galerkin Method 28 err. 4 in mean m = 6 k = x.5 y.5 err. 4 in std dev m = 6 k = x.5 y.5 u (α) for α = (,,,,, ) x y Error 4 in u (α) Galerkin scheme x y

29 Galerkin-Methods for the Linear Case 29 α satisfy: [ β G N(x) E (H α (θ)κ(x, θ)h β (θ)) N(x) T dx ] u (β) = E (f(θ)h α (θ)) }{{} =:α! f (α) More efficient representation through direct expansion of κ in KLE and PCE and analytic computation of expectations. κ(x, θ) = κ j ξ j (θ)g j (x) j= r κ j ξ j (γ) H γ (θ)g j (x). γ J 2k,m j=

30 Resulting Equations 3 Insertion of expansion of κ ( α satisfy): κ j ξ j (γ) E (H α H β H γ ) N(x) g }{{} j (x) N(x) T dx β γ j }{{} =: (γ) α,β K j u (β) = α! f (α) K j is a sparse stiffness matrix of a FEM discretisation for the material g j (x). As j, κ j, and as γ, ξ (γ) j. The Hermite polynomials form an algebra, i.e. H β H γ = ɛ c(ɛ) β,γ H ɛ; the c (ɛ) known, they are the structure constants of the Hermite algebra. Therefore the matrix (γ) = ( (γ) α,β ) may be evaluated analytically. (γ) α,β = E ( H α ɛ c (ɛ) β,γ H ɛ ) = ɛ c (ɛ) β,γ E (H αh ɛ ) = ɛ β,γ are c (ɛ) β,γ α! δ αɛ = α! c (α) β,γ

31 Tensor Product Structure 3 The equations have the structure of a Kronecker or tensor product κ j ξ j (γ) (γ) α,β K j (γ) α 2,β K j (γ) α,β 2 K j (γ) α 2,β 2 K j u(β ). = γ j..... u (β N) f (α ).. f (α N) or with tensors u = [u (β),..., u (βn) ] and f = [f (α),..., f (αn) ] K u = κ j ξ j (γ) (γ) K j u = f j γ #dof space #dof stoch linear equations (curse of dimensions). Exploit parallelism in the multiplication, parallel operator-sum Block-matrix efficiently stored and used in tensor-representation.

32 Sparsity Structure of 32 Non-zero blocks for increasing degree of H γ

33 Approximation Theory 33 Stability of discrete approximation under truncated KLE and PCE. Matrix stays uniformly positive definite. Convergence follows from Céa s Lemma. Convergence rates under stochastic regularity in stochastic Hilbert spaces stochastic regularitry theory?. Error estimation via dual weighted residuals possible. Stochastic Hilbert spaces start with formal PCE: R(θ) = α J R(α) H α (θ). Define for ρ and p norm (with (2N) β := j N (2j)β j ): R 2 ρ,p = α R (α) 2 (α!) +ρ (2N) pα.

34 Stochastic Hilbert Spaces Convergence Rates 34 Define for ρ, p : (S) ρ,p = {R(θ) = α J R (α) H α (θ) : R ρ,p < }. These are Hilbert spaces, the duals are denoted by (S) ρ, p, and L 2 (Ω) = (S),. Let P k,m be orthogonal projection from (S) ρ,p into the finite dimensional subspace S k,m. Theorem: Let p >, r > and let ρ. Then for any R (S) ρ,p : R P k,m (R) 2 ρ, p R 2 ρ, p+r c(m, k, r) 2, where c(m, k, r) 2 = c (r)m r + c 2 (r)2 kr. dim S k,m grows too quickly with k and m. Needed are sparser spaces and error estimates for them.

35 Matrix Expansion Errors 35 H γ is orthogonal on polynomials of degree < γ (γ) αβ = E (H αh β H γ ) = hence sum over γ is finite. for γ > α + β, K j in a finite dimensional space One can choose J such that expansion J κ j ξ j (γ) (γ) K j u j= γ is arbitrarily close to = N(x) E (κ(x, θ)h α (θ)h β (θ)) N(x) T dx u (β), β G and hence global matrix uniformly positive definite. This stability argument is only valid for the Galerkin method.

36 Properties of Global Equations 36 K u = j α κ j ξ j (α) (α) K j u = f Each K j is symmetric, and each (α). Block-matrix K is symmetric. SPDE ist positive definite. Appropriate expansion of κ K is uniformly positive definite stability. Solving the Equations: Never assemble block-matrix explicitly. Use K only as multiplication. Use Krylov Method (here CG) with pre-conditioner.

37 Block-Diagonaler Pre-Conditioner 37 Let K = K = stiffness-matrix for average material κ(x). Use deterministic solver as pre-conditioner: P = K = I K... K Good pre-conditioner, when variance of κ not too large. Otherwise use P = block-diag(k). This may again be done with existing deterministic solver. Block-diagonal P is well suited for parallelisation.

38 Parallelising the Matrix-Vector Product 38 α : (K u) (α) = J j γ β κ j ξ (γ) j (γ) α,β K j u β K j = deterministic solver. This may be a (lower-level) parallel program to do K j u β. Parallelise operator-sum in j several instances of deterministic solver in parallel. Distribute u and f Parallelise sum in β. Sum in α may also be done in parallel, but usually not essential.

39 Further Sparsification 39 One term of matrix vector product may also be written as κ j ξ (γ) j (γ) K j u = κ j ξ (γ) j K j u( (γ) ) T. Use discretised version of KLE of right hand side f(ω) with KLE eigenvectors f l : f(ω) = f + ϕ l φ l (ω)f l = f + ϕ l φ (α) l H α (ω)f l. l l α In particular α! f (α) = l ϕ l φ (α) l f l. As ϕ l, only a few l are needed. Let φ = (φ (α) l ), ϕ = diag(ϕ l ), and ˆf = [..., f l,...]; then the SVD of f(ω) is f = [..., f (α),...] = ˆfϕφ T = l Similar sparsification needed for u via SVD with small m: ϕ l f l φ l. u = [..., u (β),...] = [..., u m,...]diag(υ m )(y (β) m ) T = ûυy T. Then K j u( (γ) ) T = (K j û)υ ( (γ) y) T is much cheaper.

40 Computation of Moments 4 Let M (k) f k { times }}{ = E f(ω)... f(ω) = E ( f k ), or clearer (as M (k) f is symmetric) M (k) f = E ( f k ), with M () f = f and M (2) f = C f and symmetric tensor product. KLE of C f is C f = l ϕ l f l f l. For deterministic operator K, just compute Kv l = f l, and then Kū = f, and ( M (2) u = C u = E ũ k) = ϕ l v l v l. l As ũ(ω) = l α ϕ l φ (α) l M (k) u = k l... l k m= H α (ω)v l, it results that k ϕ lm α (),...,α (k) n= ) φ α (n) l n E (H α() H α(k) v l... v lk.

41 Non-Linear Equations 4 Example: Use κ(x, u, ω) = a(x, ω) + b(x, ω)u 2, and a, b random (similarily as before). Space discretisation generates a non-linear equation A( β u(β) H β (θ)) = f(θ). Projection onto PCE: a[u] = [..., E H α (θ)a( β u (β) H β (θ)),...] = f = ˆfϕφ T Expressions in a need high-dimensional integration (in each iteration), e.g. Monte Carlo or Smolyak (sparse grid) quadrature. After that, a should be sparsified or compressed. The residual equation to be solved is r(u) := f a[u] =.

42 Solution of Non-Linear Equations 42 As model problem is gradient of some functional, use a quasi-newton (here BFGS with line-search) method, to solve in k-th iteration ( u) k = H k r(u) u k = u k + ( u) k H k = H + k (a j p j p j + b j q j q j ) j= Tensors p and q computed from residuum and last increment. Notice tensor products of (hopefully sparse) tensors. Needs pre-conditioner H for good convergence: May use linear solver as described before, or just preconditioner (uses again deterministic solver), i.e. H = Dr(u ) or H = I K.

43 Fourth Summary 43 Stochastic Galerkin methods work. They are computationally possible on todays hardware. They are numerically stable, and have variational convergence theory behind them. They can use existing software efficiently. Software framework is being built for easy integration of existing software.

44 Important Features of Stochastic Galerkin 44 For efficency try and use sparse representation throughout: ansatz in tensor products, as well as storage of solution and residuum and matrix in tensor products, sparse grids for integration. In contrast to MCS, they are stable and have only cheap integrands. Can be coupled to existing software, only marginally more complicated than with MCS.

45 Outlook 45 Stochastic problems at very beginning (like FEM in the 96 s), when to choose which stochastic discretisation? Nonlinear (and instationary) problems possible (but much more work). Development of framework for stochastic coupling and parallelisation. Computational algorithms have to be further developed. Hierarchical parallelisation well possible.

Quantifying Uncertainty: Modern Computational Representation of Probability and Applications

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

More information

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

Stochastic Finite Elements: Computational Approaches to SPDEs

Stochastic Finite Elements: Computational Approaches to SPDEs Stochastic Finite Elements: Computational Approaches to SPDEs Hermann G. Matthies Andreas Keese, Elmar Zander, Alexander Litvinenko, Bojana Rosić Technische Universität Braunschweig wire@tu-bs.de http://www.wire.tu-bs.de

More information

Sampling and Low-Rank Tensor Approximations

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

More information

Galerkin Methods for Linear and Nonlinear Elliptic Stochastic Partial Differential Equations

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

More information

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

Non-Intrusive Solution of Stochastic and Parametric Equations

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

More information

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

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

More information

Uncertainty analysis of large-scale systems using domain decomposition

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

More information

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

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

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

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

More information

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

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

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

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

Solving the stochastic steady-state diffusion problem using multigrid

Solving the stochastic steady-state diffusion problem using multigrid IMA Journal of Numerical Analysis (2007) 27, 675 688 doi:10.1093/imanum/drm006 Advance Access publication on April 9, 2007 Solving the stochastic steady-state diffusion problem using multigrid HOWARD ELMAN

More information

Schwarz Preconditioner for the Stochastic Finite Element Method

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

More information

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

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

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

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

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

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

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

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

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

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

Paradigms of Probabilistic Modelling

Paradigms of Probabilistic Modelling Paradigms of Probabilistic Modelling Hermann G. Matthies Brunswick, Germany wire@tu-bs.de http://www.wire.tu-bs.de abstract RV-measure.tex,v 4.5 2017/07/06 01:56:46 hgm Exp Overview 2 1. Motivation challenges

More information

arxiv: v2 [math.na] 8 Apr 2017

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

More information

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

Spectral methods for fuzzy structural dynamics: modal vs direct approach

Spectral methods for fuzzy structural dynamics: modal vs direct approach Spectral methods for fuzzy structural dynamics: modal vs direct approach S Adhikari Zienkiewicz Centre for Computational Engineering, College of Engineering, Swansea University, Wales, UK IUTAM Symposium

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

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

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

Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen

Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen PARAMetric UNCertainties, Budapest STOCHASTIC PROCESSES AND FIELDS Noémi Friedman Institut für Wissenschaftliches Rechnen, wire@tu-bs.de

More information

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

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

More information

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

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

Block-diagonal preconditioning for spectral stochastic finite-element systems

Block-diagonal preconditioning for spectral stochastic finite-element systems IMA Journal of Numerical Analysis (2009) 29, 350 375 doi:0.093/imanum/drn04 Advance Access publication on April 4, 2008 Block-diagonal preconditioning for spectral stochastic finite-element systems CATHERINE

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

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

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD

PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD 13 th World Conference on Earthquake Engineering Vancouver, B.C., Canada August 1-6, 24 Paper No. 569 PARALLEL COMPUTATION OF 3D WAVE PROPAGATION BY SPECTRAL STOCHASTIC FINITE ELEMENT METHOD Riki Honda

More information

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

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

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

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

Stochastic Solvers for the Euler Equations

Stochastic Solvers for the Euler Equations 43rd AIAA Aerospace Sciences Meeting and Exhibit 1-13 January 5, Reno, Nevada 5-873 Stochastic Solvers for the Euler Equations G. Lin, C.-H. Su and G.E. Karniadakis Division of Applied Mathematics Brown

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

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

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

Model Reduction, Centering, and the Karhunen-Loeve Expansion

Model Reduction, Centering, and the Karhunen-Loeve Expansion Model Reduction, Centering, and the Karhunen-Loeve Expansion Sonja Glavaški, Jerrold E. Marsden, and Richard M. Murray 1 Control and Dynamical Systems, 17-81 California Institute of Technology Pasadena,

More information

Uncertainty Quantification in MEMS

Uncertainty Quantification in MEMS Uncertainty Quantification in MEMS N. Agarwal and N. R. Aluru Department of Mechanical Science and Engineering for Advanced Science and Technology Introduction Capacitive RF MEMS switch Comb drive Various

More information

Proper Generalized Decomposition for Linear and Non-Linear Stochastic Models

Proper Generalized Decomposition for Linear and Non-Linear Stochastic Models Proper Generalized Decomposition for Linear and Non-Linear Stochastic Models Olivier Le Maître 1 Lorenzo Tamellini 2 and Anthony Nouy 3 1 LIMSI-CNRS, Orsay, France 2 MOX, Politecnico Milano, Italy 3 GeM,

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

Approximating Infinity-Dimensional Stochastic Darcy s Equations without Uniform Ellipticity

Approximating Infinity-Dimensional Stochastic Darcy s Equations without Uniform Ellipticity Approximating Infinity-Dimensional Stochastic Darcy s Equations without Uniform Ellipticity Marcus Sarkis Jointly work with Juan Galvis USC09 Marcus Sarkis (WPI) SPDE without Uniform Ellipticity USC09

More information

Bilinear Stochastic Elliptic Equations

Bilinear Stochastic Elliptic Equations Bilinear Stochastic Elliptic Equations S. V. Lototsky and B. L. Rozovskii Contents 1. Introduction (209. 2. Weighted Chaos Spaces (210. 3. Abstract Elliptic Equations (212. 4. Elliptic SPDEs of the Full

More information

component risk analysis

component risk analysis 273: Urban Systems Modeling Lec. 3 component risk analysis instructor: Matteo Pozzi 273: Urban Systems Modeling Lec. 3 component reliability outline risk analysis for components uncertain demand and uncertain

More information

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

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

More information

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

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

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

More information

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

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

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

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

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

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

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

More information

Partial Differential Equations

Partial Differential Equations Part II Partial Differential Equations Year 2015 2014 2013 2012 2011 2010 2009 2008 2007 2006 2005 2015 Paper 4, Section II 29E Partial Differential Equations 72 (a) Show that the Cauchy problem for u(x,

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

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

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

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

Second Order Elliptic PDE

Second Order Elliptic PDE Second Order Elliptic PDE T. Muthukumar tmk@iitk.ac.in December 16, 2014 Contents 1 A Quick Introduction to PDE 1 2 Classification of Second Order PDE 3 3 Linear Second Order Elliptic Operators 4 4 Periodic

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

Numerical methods for the discretization of random fields by means of the Karhunen Loève expansion

Numerical methods for the discretization of random fields by means of the Karhunen Loève expansion Numerical methods for the discretization of random fields by means of the Karhunen Loève expansion Wolfgang Betz, Iason Papaioannou, Daniel Straub Engineering Risk Analysis Group, Technische Universität

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

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

A Posteriori Adaptive Low-Rank Approximation of Probabilistic Models

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

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS

EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS EFFICIENT STOCHASTIC GALERKIN METHODS FOR RANDOM DIFFUSION EQUATIONS DONGBIN XIU AND JIE SHEN Abstract. We discuss in this paper efficient solvers for stochastic diffusion equations in random media. We

More information

A Stochastic Finite Element Method with a Deviatoric-volumetric Split for the Stochastic Linear Isotropic Elasticity Tensor

A Stochastic Finite Element Method with a Deviatoric-volumetric Split for the Stochastic Linear Isotropic Elasticity Tensor TECHNISCHE MECHANIK,,, (), 79 submitted: April, A Stochastic Finite Element Method with a Deviatoric-volumetric Split for the Stochastic Linear Isotropic Elasticity Tensor A. Dridger, I. Caylak,. Mahnken

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

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

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

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Random Vibrations & Failure Analysis Sayan Gupta Indian Institute of Technology Madras

Random Vibrations & Failure Analysis Sayan Gupta Indian Institute of Technology Madras Random Vibrations & Failure Analysis Sayan Gupta Indian Institute of Technology Madras Lecture 1: Introduction Course Objectives: The focus of this course is on gaining understanding on how to make an

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

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Dynamic response of structures with uncertain properties

Dynamic response of structures with uncertain properties Dynamic response of structures with uncertain properties S. Adhikari 1 1 Chair of Aerospace Engineering, College of Engineering, Swansea University, Bay Campus, Fabian Way, Swansea, SA1 8EN, UK International

More information

arxiv: v2 [math.pr] 27 Oct 2015

arxiv: v2 [math.pr] 27 Oct 2015 A brief note on the Karhunen-Loève expansion Alen Alexanderian arxiv:1509.07526v2 [math.pr] 27 Oct 2015 October 28, 2015 Abstract We provide a detailed derivation of the Karhunen Loève expansion of a stochastic

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

III. Iterative Monte Carlo Methods for Linear Equations

III. Iterative Monte Carlo Methods for Linear Equations III. Iterative Monte Carlo Methods for Linear Equations In general, Monte Carlo numerical algorithms may be divided into two classes direct algorithms and iterative algorithms. The direct algorithms provide

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

Stochastic representation of random positive-definite tensor-valued properties: application to 3D anisotropic permeability random fields

Stochastic representation of random positive-definite tensor-valued properties: application to 3D anisotropic permeability random fields Sous la co-tutelle de : LABORATOIRE DE MODÉLISATION ET SIMULATION MULTI ÉCHELLE CNRS UPEC UNIVERSITÉ PARIS-EST CRÉTEIL UPEM UNIVERSITÉ PARIS-EST MARNE-LA-VALLÉE Stochastic representation of random positive-definite

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

Bath Institute For Complex Systems

Bath Institute For Complex Systems BICS Bath Institute for Complex Systems Finite Element Error Analysis of Elliptic PDEs with Random Coefficients and its Application to Multilevel Monte Carlo Methods Julia Charrier, Robert Scheichl and

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

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

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

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information