Uncertainty Quantification: Does it need efficient linear algebra?

Size: px
Start display at page:

Download "Uncertainty Quantification: Does it need efficient linear algebra?"

Transcription

1 USA trip October 2014 p. 1/62 Uncertainty Quantification: Does it need efficient linear algebra? David Silvester University of Manchester, UK Catherine Powell University of Manchester,UK

2 Yes. USA trip October 2014 p. 2/62

3 USA trip October 2014 p. 3/62 A framework for the development of implicit solvers for incompressible flow problems David Silvester University of Manchester, UK David Griffiths University of Dundee, Scotland

4 USA trip October 2014 p. 4/62 part I 1991 Incompressible flow: Navier Stokes equations fully implicit schemes and adaptive time stepping

5 USA trip October 2014 p. 5/62 part II 2011 PDEs with random data stochastic Galerkin and h-p adaptivity

6 USA trip October 2014 p. 6/62 Outline of the talk... Incompressible flow: Navier Stokes equations fully implicit schemes and adaptive time stepping PDEs with random data stochastic Galerkin and h-p adaptivity A proof-of-concept implementation: efficient linear algebra the (S)IFISS MATLAB Toolbox

7 USA trip October 2014 p. 6/62 Outline of the talk... Incompressible flow: Navier Stokes equations fully implicit schemes and adaptive time stepping PDEs with random data stochastic Galerkin and h-p adaptivity A proof-of-concept implementation: efficient linear algebra the (S)IFISS MATLAB Toolbox Howard Elman & Alison Ramage & David Silvester IFISS: A computational laboratory for investigating incompressible flow problems. SIAM Review, 56: , 2014.

8 IFISS HOME DOWNLOAD DOCUMENTATION PUBLICATIONS Incompressible Flow & Iterative Solver Software An open-source software package Summary IFISS is a graphical package for the interactive numerical study of incompressible flow problems which can be run under Matlab or Octave. It includes algorithms for discretization by mixed finite element methods and a posteriori error estimation of the computed solutions. The package can also be used as a computational laboratory for experimenting with state-of-the-art preconditioned iterative solvers for the discrete linear equation systems that arise in incompressible flow modelling. Key Features Key features include implementation of a variety of mixed finite element approximation methods; Links Download Documentation Publications Overview Sample output Contact automatic calculation of stabilization parameters where appropriate; a posteriori error estimation for steady problems; a range of state-of-the-art preconditioned Krylov subspace solvers ; built-in geometric and algebraic multigrid solvers and preconditioners; fully implicit self-adaptive time stepping algorithms; useful visualization tools. The developers of the IFISS package are David Silvester (School of Mathematics, University of Manchester), Howard Elman (Computer Science Department, University of Maryland), and Alison Ramage (Department of Mathematics and Statistics, University of Strathclyde). The IFISS logo represents the solution of the double glazing convection-diffusion problem. It can be reproduced in IFISS via the function ifisslogo. This webpage is based on a CSS template from Free CSS Templates. USA trip October 2014 p. 7/62

9 PART I USA trip October 2014 p. 8/62

10 USA trip October 2014 p. 9/62 References I Philip Gresho & David Griffiths & David Silvester Adaptive time-stepping for incompressible flow; part I: scalar advection-diffusion SIAM J. Scientific Computing, 30: , David Kay & Philip Gresho & David Griffiths & David Silvester Adaptive time-stepping for incompressible flow; part II: Navier-Stokes equations SIAM J. Scientific Computing, 32: , Howard Elman, Milan Mihajlović and David Silvester. Fast iterative solvers for buoyancy driven flow problems J. Computational Physics, 230: , 2011.

11 USA trip October 2014 p. 10/62 Buoyancy driven flow u t + u u ν 2 u+ p = jt in W Ω (0,T) u = 0 in W T t + u T ν 2 T = 0 Boundary and initial conditions in W u = 0 on Γ [0,T]; u( x,0) = 0 in Ω. T = T g on Γ D [0,T]; T( x,0) = 0 in Ω. ν T n = 0 on Γ N [0,T];

12 USA trip October 2014 p. 10/62 Buoyancy driven flow u t + u u ν 2 u+ p = jt in W Ω (0,T) u = 0 in W T t + u T ν 2 T = 0 Boundary and initial conditions in W u = 0 on Γ [0,T]; u( x,0) = 0 in Ω. T = T g on Γ D [0,T]; T( x,0) = 0 in Ω. ν T n = 0 on Γ N [0,T]; ν = Pr/Ra, ν = 1/ Pr Ra, T g = (1 e 10t )T.

13 Rayleigh Bénard P r = 7.1, Ra = USA trip October 2014 p. 11/62

14 USA trip October 2014 p. 11/62 Rayleigh Bénard P r = 7.1, Ra = Stationary streamlines: time =

15 USA trip October 2014 p. 12/62 Smart Integrator (SI) Optimal time-stepping Black-box implementation Algorithm efficiency Solver efficiency: the linear solver convergence rate is robust with respect to the mesh size h and the flow problem parameters.

16 USA trip October 2014 p. 13/62 Rayleigh Bénard Pr = 7.1, Ra = time average vorticity time ω = u, ω Ω = 1 2A Ω ω 2

17 USA trip October 2014 p. 14/62 Rayleigh Bénard Pr = 7.1, Ra = time step time time stabilized TR ε t = 10 6 (left) and ε t = 10 5 (right).

18 USA trip October 2014 p. 15/62 Rayleigh Bénard Pr = 7.1, Ra = Isotherms: time = Isotherms: time = Isotherms: time =

19 LINEAR ALGEBRA USA trip October 2014 p. 16/62

20 USA trip October 2014 p. 17/62 Trapezoidal Rule (TR) time discretization Subdivide [0,T] into time levels {t i } N i=1. Given (un,p n,t n ) at time t n, k n+1 := t n+1 t n, compute (u n+1,p n+1,t n+1 ) via 2 k n+1 u n+1 ν 2 u n+1 +u n+1 u n+1 + p n+1 jt n+1 = u n+1 = 0 2 k n+1 u n + u n t in Ω in Ω u n+1 = 0 2 k n+1 T n+1 ν 2 T n+1 +u n+1 T n+1 = k 2 n+1 T n + T t n T n+1 = T n+1 g on Γ in Ω on Γ D ν T n+1 n = 0 on Γ N.

21 USA trip October 2014 p. 18/62 Linearization Subdivide [0,T] into time levels {t i } N i=1. Given (un,p n,t n ) at time t n, k n+1 := t n+1 t n, compute (u n+1,p n+1,t n+1 ) via 2 k n+1 u n+1 ν 2 u n+1 + w n+1 u n+1 + p n+1 jt n+1 = u n+1 = 0 2 k n+1 T n+1 ν 2 T n+1 + w n+1 T n+1 = k 2 n+1 T n + T t with w n+1 = (1+ k n+1 k n ) u n k n+1 k n u n 1. 2 k n+1 u n + u n t in Ω in Ω u n+1 = 0 on Γ. n T n+1 = T n+1 g in Ω on Γ D ν T n+1 n = 0 on Γ N,

22 USA trip October 2014 p. 19/62 Adaptive time stepping components The adaptive time step selection is based on coupled physics. Given L 2 error estimates e n+1 h and e n+1 h for the velocity and temperature respectively, the subsequent TR AB2 time step k n+2 is computed using k n+2 = k n+1 ( e n+1 h ε t 2 + e n+1 h The following parameters must be specified: 2 ) 1/3. time accuracy tolerance ε t (10 5 ) GMRES tolerance itol (10 6 ) GMRES iteration limit maxit (50)

23 USA trip October 2014 p. 20/62 Finite element matrix formulation Introducing the basis sets X h = span{ φ i } n u i=1, Velocity basis functions; M h = span{ψ j } n p j=1, Pressure basis functions. T h = span{φ k } n T k=1, Temperature basis functions; gives the method-of-lines discretized system: u M 0 0 t F B T M u p t + B 0 0 p 0 0 M 0 0 F T T t = 0 0 g with a (vertical ) mass matrix: ( M ) ij = ([0,φ i ],φ j )

24 USA trip October 2014 p. 21/62 Preconditioning strategy F B T M B 0 0 P 1 P 0 0 F α u α p α T = Given S = BF 1 B T, a perfect preconditioner is given by F B T M F 1 F 1 B T S 1 F 1 M B S F } 0 0 {{ F 1 } P 1 = f u f p f T I 0 0 BF 1 I BF 1 M F I

25 USA trip October 2014 p. 22/62 For an efficient preconditioner we need to construct a sparse approximation to the exact Schur complement S 1 = (BF 1 B T ) 1 See Chapter 11 of Howard Elman & David Silvester & Andrew Wathen Finite Elements and Fast Iterative Solvers: with applications in incompressible fluid dynamics Oxford University Press, second edition, For an efficient implementation we must also have an efficient AMG (convection-diffusion) solver...

26 USA trip October 2014 p. 23/62 HSL HSL MI20 PACKAGE SPECIFICATION HSL SUMMARY Givenann nsparsematrixaandann vectorz, HSL MI20computesthevectorx =Mz,whereMisanalgebraic multigrid(amg) v-cycle preconditioner for A. A classical AMG method is used, as described in[1](see also Section 5belowforabriefdescriptionofthealgorithm).ThematrixAmusthavepositivediagonalentriesand(mostof)the off-diagonal entries must be negative(the diagonal should be large compared to the sum of the off-diagonals). During the multigrid coarsening process, positive off-diagonal entries are ignored and, when calculating the interpolation weights, positive off-diagonal entries are added to the diagonal. Reference [1] K. Stüben. An Introduction to Algebraic Multigrid. In U. Trottenberg, C. Oosterlee, A. Schüller, eds, Multigrid, Academic Press, 2001, pp ATTRIBUTES Version: Types: Real(single, double). Uses: HSL MA48, HSL MC65, HSL ZD11, and the LAPACK routines GETRF and GETRS. Date: September Origin: J. W. Boyle, University of Manchester and J. A. Scott, Rutherford Appleton Laboratory. Language: Fortran 95, plus allocatable dummy arguments and allocatable components of derived types. Remark: The development of HSL MI20 was funded by EPSRC grants EP/C000528/1 and GR/S42170.

27 USA trip October 2014 p. 24/62 Schur complement approximation I Introducing the diagonal of the velocity mass matrix M M ij = ( φ i, φ j ), gives the least-squares commutator preconditioner : (BF 1 B T ) 1 (BM 1 B T ) 1 (BM }{{} 1 FM 1 B T )(BM 1 B T }{{} amg amg ) 1

28 USA trip October 2014 p. 25/62 Schur complement approximation II Introducing associated pressure matrices M p ( ψ i, ψ j ), mass A p ( ψ i, ψ j ), diffusion N p ( w h ψ i,ψ j ), convection F p = 2 k n+1 M p +νa p +N p, convection-diffusion gives the pressure convection-diffusion preconditioner : (BF 1 B T ) 1 Mp 1 F p A 1 p }{{} amg

29 USA trip October 2014 p. 26/62 Rayleigh Bénard Pr = 7.1, Ra = Exact PCD preconditioning t=100 t=120 t= Exact LSC preconditioning t=100 t=120 t=300 residual reduction residual reduction iteration number iteration number AMG-ILU PCD preconditioning t=100 t=120 t= AMG-ILU LSC preconditioning t=100 t=120 t=300 residual reduction residual reduction iteration number iteration number

30 USA trip October 2014 p. 27/62 What have we achieved? Black-box implementation: few parameters that have to be estimated a priori. Optimal complexity: essentially O(n) flops per iteration, where n is dimension of the discrete system. Efficient linear algebra: convergence rate is (essentially) independent of h. Given an appropriate time accuracy tolerance convergence is also robust with respect to diffusion parameters ν and ν.

31 PART II USA trip October 2014 p. 28/62

32 USA trip October 2014 p. 29/62 References II Catherine Powell & David Silvester Preconditioning steady-state Navier Stokes equations with random data. SIAM J. Scientific Computing, vol. 34, A2482 A2506, David Silvester & Alex Bespalov & Catherine Powell A framework for the development of implicit solvers for incompressible flow problems. Discrete and Continuous Dynamical Systems Series S, vol. 5, , 2012.

33 USA trip October 2014 p. 30/62 Steady-state flow with random data Problem statement u u ν 2 u+ p = 0 in Ω u = 0 in Ω u = g on Γ D ν u n p n = 0 on Γ N. We model uncertainty in the viscosity as ν(ω) = µ+σξ(ω). If ξ U( 3, 3), then ν is a uniform random variable with E[ν(ω)] = µ, Var[ν(ω)] = σ 2.

34 USA trip October 2014 p. 31/62 N S example I: flow over a step Streamlines of the mean flow field (top) and plot of the mean pressure field (bottom): µ = 1/50, σ = µ/

35 USA trip October 2014 p. 32/62 Variance of the magnitude of flow field (top) and variance of the pressure (bottom) x

36 USA trip October 2014 p. 33/62 N S example II: flow around an obstacle Streamlines of the mean flow field (top) and plot of the mean pressure field (bottom): µ = 1/100, σ = 3µ/

37 USA trip October 2014 p. 34/62 Variance of the magnitude of flow field (top) and variance of the pressure (bottom)

38 USA trip October 2014 p. 35/62 Stochastic discretisation methods Monte Carlo Methods Perturbation Methods Stochastic Galerkin Methods Stochastic Collocation Methods Stochastic Reduced Basis Methods...

39 USA trip October 2014 p. 35/62 Stochastic discretisation methods Monte Carlo Methods Perturbation Methods Stochastic Galerkin Methods Stochastic Collocation Methods Stochastic Reduced Basis Methods... Key points If the number of random variables describing the input data is small then Stochastic Galerkin and Stochastic Collocation methods can outperform Monte Carlo. If software for the deterministic problem is to be useful for Stochastic Galerkin approximation then specialised solvers need to be developed.

40 LINEAR ALGEBRA USA trip October 2014 p. 36/62

41 USA trip October 2014 p. 37/62 Stochastic Galerkin discretisation I Ingredients Picard iteration; standard finite element spaces X h E and Mh ; a suitable finite-dimensional subspace S k L 2 ρ(λ), where Λ:=ξ(Ξ), Λ y.

42 USA trip October 2014 p. 37/62 Stochastic Galerkin discretisation I Ingredients Picard iteration; standard finite element spaces X h E and Mh ; a suitable finite-dimensional subspace S k L 2 ρ(λ), where Λ:=ξ(Ξ), Λ y. Discrete formulation Find u n+1 hk X h E Sk and p n+1 hk M h S k satisfying: [ E ν(y) ( [ ( u [ u n+1 hk, v)] n (p +E hk u n+1 hk, v)] n+1 E hk, v)] = 0 for all v X h 0 Sk and q M h S k. [ E ( u n+1 hk,q)] = 0

43 USA trip October 2014 p. 38/62 Stochastic Galerkin discretisation II Discrete formulation Find u n+1 hk X h E Sk and p n+1 hk M h S k satisfying: [ E ν(y) ( [ ( u [ u n+1 hk, v)] n (p +E hk u n+1 hk, v)] n+1 E hk, v)] = 0 for all v X h 0 Sk and q M h S k. [ E ( u n+1 hk,q)] = 0

44 USA trip October 2014 p. 38/62 Stochastic Galerkin discretisation II Discrete formulation Find u n+1 hk X h E Sk and p n+1 hk M h S k satisfying: [ E ν(y) ( [ ( u [ u n+1 hk, v)] n (p +E hk u n+1 hk, v)] n+1 E hk, v)] = 0 for all v X h 0 Sk and q M h S k. [ E ( u n+1 hk,q)] = 0 Sets of basis functions X h 0 =span{ (φ i ( x),0),(0,φ i ( x)) } n u i=1 ;Mh =span{ψ j ( x)} n p j=1 ; S k =span{ϕ l (y)} k l=0.

45 USA trip October 2014 p. 39/62 Stochastic Galerkin discretisation III The linear system at the (n+1)st Picard iteration is ( )( ) ( ) Fν n B T α n f n B 0 β n = g n with F n ν = ( F n ν 0 0 F n ν ), B = ( G 0 B x1 G 0 B x2 ) and k Fν n := (µg 0 +σg 1 ) A+ H l N l, B x1, B x2 are discrete representations of the first derivatives. The system dimension is: (n u +n p )(k+1) (n u +n p )(k+1). l=0

46 USA trip October 2014 p. 40/62 (1-1) block: F n ν := (µg 0 +σg 1 ) A+ k l=0 H l N l. F n ν is a non-symmetric matrix. convection matrices N l (l = 0,...,k) are given by [N l ] ij = ( u n hl( x) φ i,φ j ) i,j = 0,...,n u. where u n hl are the spatial coefficients in the expansion of the lagged velocity field, k u n hk( x,y) = n u i=1 un il φ i ( x) ϕ }{{} l (y). l=0 u n hl( x)

47 USA trip October 2014 p. 41/62 (1-1) block: F n ν := (µg 0 +σg 1 ) A+ k l=0 H l N l. F n ν is a non-symmetric matrix. convection matrices N l (l = 0,...,k) are given by [N l ] ij = ( u n hl( x) φ i,φ j ) i,j = 0,...,n u. G 0, G 1 and H l are all (k +1) (k +1) matrices: G 0 := [G 0 ] ls = E[ϕ s (y)ϕ l (y)], G 1 := [G 1 ] ls = E[yϕ s (y)ϕ l (y)], H l := [H l ] ms = E[ϕ l (y)ϕ s (y)ϕ m (y)].

48 USA trip October 2014 p. 41/62 (1-1) block: F n ν := (µg 0 +σg 1 ) A+ k l=0 H l N l. F n ν is a non-symmetric matrix. convection matrices N l (l = 0,...,k) are given by [N l ] ij = ( u n hl( x) φ i,φ j ) i,j = 0,...,n u. G 0, G 1 and H l are all (k +1) (k +1) matrices: G 0 := [G 0 ] ls = E[ϕ s (y)ϕ l (y)], G 1 := [G 1 ] ls = E[yϕ s (y)ϕ l (y)], H l := [H l ] ms = E[ϕ l (y)ϕ s (y)ϕ m (y)]. If {ϕ l (y)} k l=0 are scaled Legendre polynomials on Λ, then G 0 = H 0 = I, G 1 = H 1 is sparse (2 non-zeros per row); H l is dense for l 2.

49 USA trip October 2014 p. 42/62 Ideal preconditioning ( F B T B 0 ) P 1 P ( ) α u α p = ( ) f u f p An ideal preconditioner is given by ( )( ) F B T F 1 F 1 B T S 1 B 0 } 0 S 1 {{ } P 1 = ( ) I 0 BF 1 I. For an efficient preconditioner we need to construct a sparse approximation to the exact Schur complement S 1 = (BF 1 B T ) 1

50 USA trip October 2014 p. 43/62 Rearrange the (1-1) block: Preconditioning I F n ν = (µg 0 +σg 1 ) A+ k l=0 H l N l = I (µa 0 +N 0 )+σg 1 A+ k l=1 H l N l and define F 0 := (µa 0 +N 0 ).

51 USA trip October 2014 p. 43/62 Rearrange the (1-1) block: Preconditioning I F n ν = (µg 0 +σg 1 ) A+ k l=0 H l N l and define = I (µa 0 +N 0 )+σg 1 A+ k l=1 H l N l F 0 := (µa 0 +N 0 ). A natural candidate for P F is the block-diagonal mean-based approximation: ( ) I F 0 0 P F = F 0 :=. 0 I F 0 This is a good approximation when σ µ is not too large.

52 USA trip October 2014 p. 44/62 Preconditioning II Replacing F n ν by F 0 in the Schur-complement gives S BF 1 0 B T = (I B x1 )(I F 1 0 )(I B T x 1 )+(I B x2 )(I F 1 0 )(I B T x 2 ) = I (B x1,b x2 )F 1 0 (B x1,b x2 ) T =: I S 0 =: S 0 = P S.

53 USA trip October 2014 p. 44/62 Preconditioning II Replacing F n ν by F 0 in the Schur-complement gives S BF 1 0 B T = (I B x1 )(I F 1 0 )(I B T x 1 )+(I B x2 )(I F 1 0 )(I B T x 2 ) = I (B x1,b x2 )F 1 0 (B x1,b x2 ) T =: I S 0 =: S 0 = P S. S 0 is the Schur-complement corresponding to the deterministic problem with viscosity µ convection coefficient u 0 hk (the mean component of velocity at the previous Picard step)

54 USA trip October 2014 p. 45/62 Preconditioning III Replacing F n ν by F 0 in the Schur-complement gives S BF 1 0 B T = (I B x1 )(I F 1 0 )(I B T x 1 )+(I B x2 )(I F 1 0 )(I B T x 2 ) = I (B x1,b x2 )F 1 0 (B x1,b x2 ) T =: I S 0 =: S 0 = P S. To apply P 1 S in each GMRES iteration requires (k +1) solves with S 0. This can be done exactly (ideal preconditioner); or inexactly with the deterministic approaches: pressure convection diffusion approximation (PCD) least squares commutator approximation (LSC).

55 USA trip October 2014 p. 46/62 Flow over a step ideal PC D L SC ideal PC D L SC residual reduction residual reduction iteration number iteration number GMRES convergence for a coarsened grid (left) and for a reference grid (right) (µ = 1/50; σ = 2µ/10).

56 USA trip October 2014 p. 47/62 Typical GMRES iteration counts Coarse grid Fine grid E[Re] k = k = σ = µ/ Ideal σ = 2µ/ σ = 3µ/ σ = µ/ PCD σ = 2µ/ σ = 3µ/ σ = µ/ LSC σ = 2µ/ σ = 3µ/

57 USA trip October 2014 p. 48/62 What have we achieved? Black-box implementation: no parameters that have to be estimated a priori. Optimal complexity: essentially O(n) flops per iteration, where n is dimension of the discrete system. Efficient linear algebra: convergence rate is independent of h. Convergence is also robust with respect to the spectral approximation parameter k as long as the variance is not too large relative to the mean.

58 Part III USA trip October 2014 p. 49/62

59 USA trip October 2014 p. 50/62 Stochastic Galerkin andh-p adaptivity What s next? Alex Bespalov, Catherine Powell & David Silvester. A posteriori error estimation for parametric operator equations with applications to PDEs with random data. SIAM J. Sci. Comput, 36:A339 A363, 2014.

60 USA trip October 2014 p. 51/62 stochastic Galerkin error estimation I B(u,v) = F(v) v V ( ) B(u XP,v) = F(v) v V XP = X P P. Thus e := u u XP V satisfies B(e,v) = F(v) B(u XP,v) }{{} = 0 v V XP v V.

61 stochastic Galerkin error estimation I B(u,v) = F(v) v V ( ) B(u XP,v) = F(v) v V XP = X P P. Thus e := u u XP V satisfies B(e,v) = F(v) B(u XP,v) }{{} = 0 v V XP v V. This motivates the estimator e V XP satisfying B(e,v) = F(v) B(u XP,v) v V XP = X P P where V XP is an enriched finite-dimensional subspace of V so that X = X Y, X Y = {0}; P P = P P P Q, P P P Q = {0}. VXP := V XP V }{{} XQ V YP V }{{}}{{} YQ X P Q Y P P Y P Q. USA trip October 2014 p. 51/62

62 USA trip October 2014 p. 52/62 stochastic Galerkin error estimation II A simple-minded estimator e VXP satisfies B(e,v) = F(v) B(u XP,v) v VXP, with VXP := V XP (X P Q ) (Y P P ) (Y P Q ).

63 USA trip October 2014 p. 52/62 stochastic Galerkin error estimation II A simple-minded estimator e VXP satisfies B(e,v) = F(v) B(u XP,v) v VXP, with VXP := V XP (X P Q ) (Y P P ) (Y P Q ). A more refined estimator e 0 series structure of ( ): find e 0 V XP is obtained by exploiting the typical such that B 0 (e 0,v) = F(v) B(u XP,v) v V XP. This leads to efficient linear algebra the associated system matrix is block diagonal with each block representing a deterministic problem associated with the mean component of the operator A(y).

64 USA trip October 2014 p. 53/62 stochastic Galerkin error estimation III The refined error estimator e 0 V XP satisfies B 0 (e 0,v) = F(v) B(u XP,v) v VXP, with VXP := V XP (X P Q ) (Y P P ) (Y P Q ).

65 USA trip October 2014 p. 53/62 stochastic Galerkin error estimation III The refined error estimator e 0 V XP satisfies B 0 (e 0,v) = F(v) B(u XP,v) v V XP, with V XP := V XP (X P Q ) (Y P P ) (Y P Q ). A simple energy estimate η is obtained by exploiting the structure of the space VXP : This is given by η := ( 2 ē XQ 2 B 0 + ē YP 2 B 0 +2 ē YQ 2 B 0 ) 1/2, where the contributing estimators ē XQ V XQ, ē YP V YP and ē YQ V YQ satisfy B 0 (ē XQ,v) = F(v) B(u XP,v) v V XQ, B 0 (ē YP,v) = F(v) B(u XP,v) v V YP, ( ) B 0 (ē YQ,v) = F(v) B(u XP,v) v V YQ.

66 USA trip October 2014 p. 54/62 error reduction indicators Recall η := ( 2 ē XQ 2 B 0 + ē YP 2 B 0 +2 ē YQ 2 B 0 ) 1/2 with ē XQ X P Q, ē YP Y P P and ē YQ Y P Q. The construction of η also gives information regarding the error reduction that would result by enriching the approximation either spatially or parametrically: λ ēyp B0 u X P u XP B Λ 1 γ 2 ē YP B0, λ ēxq B0 u XP u XP B Λ ē XQ B0. Here, λ, Λ are the constants in (B 0 ) and γ [0,1) is the constant in the strengthened Cauchy Schwarz inequality. This opens the door to h p adaptivity...

67 USA trip October 2014 p. 55/62 model problem example We solve a steady-state diffusion problem ( ) with x = (x 1,x 2 ) D := [ 1,1] 2, with data f(x) = 1 8 (2 x2 1 x2 2 ) and a(x,y) = }{{} 1 +σ 3 a 0 =E[a] m=1 λm ϕ m (x)y m. Here y Γ = m=1 [ 1,1] and {(λ m,ϕ m )} m=1 are the eigenpairs of the integral operator associated with the correlation function C[a](x,x ) = exp ( 1 2 x x l1 ), x, x [ 1,1] 2. The problem ( ) is well posed as long as σ is small enough: our reference value is σ = 0.2.

68 USA trip October 2014 p. 56/62 model problem detail spaces The detail spaces Y h and Q M,p are chosen so that X h/2 = X h Y h and P M,p+1 = P M,p Q M,p, respectively. Thus, Y h spans the set of bilinear bubble functions corresponding to the edge midpoints and element centroids of the original mesh h (defined locally, see below) whereas Q M,p spans M-variate polynomials of total degree equal to p+1. This gives a decomposition of the error estimate η with V XP := V XP (X h Q M,p ) (Y h P M,p ) (Y h Q M,p ).

69 model problem error estimation V XP := V XP (X h Q M,p ) (Y h P M,p ) (Y h Q M,p ). The smart choice of the detail space Y h gives rise to local problems defined on all elements K h. For example, we compute ē YP K Y h K P M,p satisfying B 0,K (ē YP K,v) = F K (v) + (a(x,y) u XP (x,y) ) v(x,y) dx dπ(y) Γ K [ ] 1 uxp 2 a(s, y) v(s,y) ds dπ(y), n for all v Y h K P M,p. Γ K\ D The coefficient matrix associated with this local problem is the Kronecker product of a 5 5 (stiffness) matrix and an identity matrix of dimension P = dim(p M,p ) = (p+m)! p!m!. USA trip October 2014 p. 57/62

70 USA trip October 2014 p. 58/62 example effectivity I We compute a reference solution u ref for the case M = 3, σ = 0.2, using a grid with p = 7. fixed polynomial degree: p = 2 effectivity Index : X η := η(u XP )/ u ref u XP B Grid u ref u XP B η(u XP ) X η

71 USA trip October 2014 p. 59/62 example effectivity II We compute a reference solution u ref for the case M = 3, σ = 0.2, using a grid with p = 7. fixed spatial grid: effectivity Index : X η := η(u XP )/ u ref u XP B p u ref u XP B η(u XP ) X η

72 USA trip October 2014 p. 60/62 error reduction decreasingh M = 3, σ = 0.2, fixed polynomial degree: p = YP-estimate XQ-estimate YQ-estimate η estimate estimates of the error number of d.o.f.

73 USA trip October 2014 p. 61/62 error reduction increasingp M = 3, σ = 0.2, fixed spatial grid: YP-estimate XQ-estimate YQ-estimate η estimate estimates of the error number of d.o.f.

74 USA trip October 2014 p. 62/62 What have we achieved? computable estimates of the error reduction: these exploit the tensor product structure of the approximation spaces. Efficient linear algebra: CPU time for the error estimation is commensurate with the CPU time taken to solve the original problem...

A Review of Preconditioning Techniques for Steady Incompressible Flow

A Review of Preconditioning Techniques for Steady Incompressible Flow Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/43 PDEs Review : 1984 2005 Update

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

Fast Solvers for Unsteady Incompressible Flow

Fast Solvers for Unsteady Incompressible Flow ICFD25 Workshop p. 1/39 Fast Solvers for Unsteady Incompressible Flow David Silvester University of Manchester http://www.maths.manchester.ac.uk/~djs/ ICFD25 Workshop p. 2/39 Outline Semi-Discrete Navier-Stokes

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 Review of Solution Techniques for Unsteady Incompressible Flow

A Review of Solution Techniques for Unsteady Incompressible Flow Zeist 2009 p. 1/57 A Review of Solution Techniques for Unsteady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/57 PDEs Review : 1966 1999 Update : 2000

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

Theoretical advances. To illustrate our approach, consider the scalar ODE model,

Theoretical advances. To illustrate our approach, consider the scalar ODE model, Final Report GR/R69/ : Analysis of Numerical Methods for Incompressible Fluid Dynamics Personnel supported: Professor Philip Gresho (nominated Visiting Fellow; visited UK: 7/6/ 5//). Dr David Kay (visited

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

CBS Constants and Their Role in Error Estimation for Stochastic Galerkin Finite Element Methods. Crowder, Adam J and Powell, Catherine E

CBS Constants and Their Role in Error Estimation for Stochastic Galerkin Finite Element Methods. Crowder, Adam J and Powell, Catherine E CBS Constants and Their Role in Error Estimation for Stochastic Galerkin Finite Element Methods Crowder, Adam J and Powell, Catherine E 2017 MIMS EPrint: 2017.18 Manchester Institute for Mathematical Sciences

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

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

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

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems

Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems Finding Rightmost Eigenvalues of Large, Sparse, Nonsymmetric Parameterized Eigenvalue Problems AMSC 663-664 Final Report Minghao Wu AMSC Program mwu@math.umd.edu Dr. Howard Elman Department of Computer

More information

An advanced ILU preconditioner for the incompressible Navier-Stokes equations

An advanced ILU preconditioner for the incompressible Navier-Stokes equations An advanced ILU preconditioner for the incompressible Navier-Stokes equations M. ur Rehman C. Vuik A. Segal Delft Institute of Applied Mathematics, TU delft The Netherlands Computational Methods with Applications,

More information

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1)

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1) University of Maryland Department of Computer Science TR-C4930 University of Maryland Institute for Advanced Computer Studies TR-009-0 BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR

More information

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS MICHELE BENZI AND ZHEN WANG Abstract. We analyze a class of modified augmented Lagrangian-based

More information

Chebyshev semi-iteration in Preconditioning

Chebyshev semi-iteration in Preconditioning Report no. 08/14 Chebyshev semi-iteration in Preconditioning Andrew J. Wathen Oxford University Computing Laboratory Tyrone Rees Oxford University Computing Laboratory Dedicated to Victor Pereyra on his

More information

ON THE ROLE OF COMMUTATOR ARGUMENTS IN THE DEVELOPMENT OF PARAMETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLEMS

ON THE ROLE OF COMMUTATOR ARGUMENTS IN THE DEVELOPMENT OF PARAMETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLEMS ON THE ROLE OF COUTATOR ARGUENTS IN THE DEVELOPENT OF PARAETER-ROBUST PRECONDITIONERS FOR STOKES CONTROL PROBLES JOHN W. PEARSON Abstract. The development of preconditioners for PDE-constrained optimization

More information

Efficient iterative algorithms for linear stability analysis of incompressible flows

Efficient iterative algorithms for linear stability analysis of incompressible flows IMA Journal of Numerical Analysis Advance Access published February 27, 215 IMA Journal of Numerical Analysis (215) Page 1 of 21 doi:1.193/imanum/drv3 Efficient iterative algorithms for linear stability

More information

Incompressible Flow & Iterative Solver Software (IFISS) Installation & Software Guide 1

Incompressible Flow & Iterative Solver Software (IFISS) Installation & Software Guide 1 Incompressible Flow & Iterative Solver Software (IFISS) Installation & Software Guide 1 David J Silvester 2 Howard C Elman 3 Alison Ramage 4 Version 35 released 22 September 2016 1 This project was supported

More information

Adaptive algebraic multigrid methods in lattice computations

Adaptive algebraic multigrid methods in lattice computations Adaptive algebraic multigrid methods in lattice computations Karsten Kahl Bergische Universität Wuppertal January 8, 2009 Acknowledgements Matthias Bolten, University of Wuppertal Achi Brandt, Weizmann

More information

On solving linear systems arising from Shishkin mesh discretizations

On solving linear systems arising from Shishkin mesh discretizations On solving linear systems arising from Shishkin mesh discretizations Petr Tichý Faculty of Mathematics and Physics, Charles University joint work with Carlos Echeverría, Jörg Liesen, and Daniel Szyld October

More information

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS CHIN-TIEN WU AND HOWARD C. ELMAN Abstract. The discrete convection-diffusion equations obtained from streamline

More information

c 2011 Society for Industrial and Applied Mathematics

c 2011 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 33, No. 5, pp. 2761 2784 c 2011 Society for Industrial and Applied Mathematics ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER STOKES

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

IFISS: A computational laboratory for investigating incompressible flow problems. Elman, Howard C. and Ramage, Alison and Silvester, David J.

IFISS: A computational laboratory for investigating incompressible flow problems. Elman, Howard C. and Ramage, Alison and Silvester, David J. IFISS: A computational laboratory for investigating incompressible flow problems Elman, Howard C. and Ramage, Alison and Silvester, David J. 22 MIMS EPrint: 22.8 Manchester Institute for Mathematical Sciences

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations Fourteenth International Conference on Domain Decomposition Methods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 23 DDM.org 2. A Dual-Primal FEI Method for solving Stokes/Navier-Stokes

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 27, No. 5, pp. 1651 1668 c 2006 Society for Industrial and Applied Mathematics BLOCK PRECONDITIONERS BASED ON APPROXIMATE COMMUTATORS HOWARD ELMAN, VICTORIA E. HOWLE, JOHN SHADID,

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

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

H(div) Preconditioning for a Mixed Finite Element Formulation of the Stochastic Diffusion Problem 1

H(div) Preconditioning for a Mixed Finite Element Formulation of the Stochastic Diffusion Problem 1 University of Maryland Department of Computer Science CS-TR-4918 University of Maryland Institute for Advanced Computer Studies UMIACS-TR-2008-15 H(div) Preconditioning for a Mixed Finite Element Formulation

More information

Incompressible Flow Iterative Solution Software (IFISS) Installation & Software Guide 1

Incompressible Flow Iterative Solution Software (IFISS) Installation & Software Guide 1 Incompressible Flow Iterative Solution Software (IFISS) Installation & Software Guide 1 David J Silvester 2 Howard C Elman 3 Alison Ramage 4 Version 34 released 24 August 2015 1 This project was supported

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Termination criteria for inexact fixed point methods

Termination criteria for inexact fixed point methods Termination criteria for inexact fixed point methods Philipp Birken 1 October 1, 2013 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany Department of Mathematics/Computer

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 35, pp. 57-80, 009. Copyright 009,. ISSN 1068-9613. ETNA BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR THE NAVIER-STOKES EQUATIONS

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

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

Department of Computer Science, University of Illinois at Urbana-Champaign

Department of Computer Science, University of Illinois at Urbana-Champaign Department of Computer Science, University of Illinois at Urbana-Champaign Probing for Schur Complements and Preconditioning Generalized Saddle-Point Problems Eric de Sturler, sturler@cs.uiuc.edu, http://www-faculty.cs.uiuc.edu/~sturler

More information

Multigrid and Iterative Strategies for Optimal Control Problems

Multigrid and Iterative Strategies for Optimal Control Problems Multigrid and Iterative Strategies for Optimal Control Problems John Pearson 1, Stefan Takacs 1 1 Mathematical Institute, 24 29 St. Giles, Oxford, OX1 3LB e-mail: john.pearson@worc.ox.ac.uk, takacs@maths.ox.ac.uk

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

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

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Algebraic Multigrid Methods for the Oseen Problem

Algebraic Multigrid Methods for the Oseen Problem Algebraic Multigrid Methods for the Oseen Problem Markus Wabro Joint work with: Walter Zulehner, Linz www.numa.uni-linz.ac.at This work has been supported by the Austrian Science Foundation Fonds zur Förderung

More information

A comparison of preconditioners for incompressible Navier Stokes solvers

A comparison of preconditioners for incompressible Navier Stokes solvers INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids (2007) Published online in Wiley InterScience (www.interscience.wiley.com)..1684 A comparison of preconditioners for incompressible

More information

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems.

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems. Robust A Posteriori Error Estimates for Stabilized Finite Element s of Non-Stationary Convection-Diffusion Problems L. Tobiska and R. Verfürth Universität Magdeburg Ruhr-Universität Bochum www.ruhr-uni-bochum.de/num

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

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation

Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Unsteady Incompressible Flow Simulation Using Galerkin Finite Elements with Spatial/Temporal Adaptation Mohamed S. Ebeida Carnegie Mellon University, Pittsburgh, PA 15213 Roger L. Davis and Roland W. Freund

More information

A TAXONOMY AND COMPARISON OF PARALLEL BLOCK MULTI-LEVEL PRECONDITIONERS FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

A TAXONOMY AND COMPARISON OF PARALLEL BLOCK MULTI-LEVEL PRECONDITIONERS FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS University of Maryland Department of Computer Science R-4867 University of Maryland Institute for Advanced Computer Studies R-2007-20 A AXONOMY AND COMPARISON OF PARALLEL BLOCK MULI-LEVEL PRECONDIIONERS

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems Pasqua D Ambra, Alfredo Buttari, Daniela Di Serafino, Salvatore Filippone, Simone Gentile,

More information

A Taxonomy and Comparison of Parallel Block Multi-level Preconditioners for the Incompressible Navier Stokes Equations

A Taxonomy and Comparison of Parallel Block Multi-level Preconditioners for the Incompressible Navier Stokes Equations SANDIA REPORT SAND2007-2761 Unlimited Release Printed May 2007 A Taxonomy and Comparison of Parallel Block Multi-level Preconditioners for the Incompressible Navier Stokes Equations Howard Elman, Victoria

More information

Mathematics and Computer Science

Mathematics and Computer Science Technical Report TR-2007-002 Block preconditioning for saddle point systems with indefinite (1,1) block by Michele Benzi, Jia Liu Mathematics and Computer Science EMORY UNIVERSITY International Journal

More information

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Assignment on iterative solution methods and preconditioning

Assignment on iterative solution methods and preconditioning Division of Scientific Computing, Department of Information Technology, Uppsala University Numerical Linear Algebra October-November, 2018 Assignment on iterative solution methods and preconditioning 1.

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 Introduction Almost all numerical methods for solving PDEs will at some point be reduced to solving A

More information

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs

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

More information

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016 Numerical Modelling in Fortran: day 10 Paul Tackley, 2016 Today s Goals 1. Useful libraries and other software 2. Implicit time stepping 3. Projects: Agree on topic (by final lecture) (No lecture next

More information

Hybrid Discontinuous Galerkin methods for incompressible flow problems

Hybrid Discontinuous Galerkin methods for incompressible flow problems Hybrid Discontinuous Galerkin methods incompressible flow problems Christoph Lehrenfeld, Joachim Schöberl MathCCES Computational Mathematics in Engineering Workshop Linz, May 31 - June 1, 2010 Contents

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-10 Comparison of some preconditioners for the incompressible Navier-Stokes equations X. He and C. Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

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

Preconditioning for Nonsymmetry and Time-dependence

Preconditioning for Nonsymmetry and Time-dependence Preconditioning for Nonsymmetry and Time-dependence Andy Wathen Oxford University, UK joint work with Jen Pestana and Elle McDonald Jeju, Korea, 2015 p.1/24 Iterative methods For self-adjoint problems/symmetric

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS BIT Numerical Mathematics 43: 961 974, 2003. 2003 Kluwer Academic Publishers. Printed in the Netherlands. 961 PRECONDITIONING TECHNIQUES FOR NEWTON S METHOD FOR THE INCOMPRESSIBLE NAVIER STOKES EQUATIONS

More information

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

7.4 The Saddle Point Stokes Problem

7.4 The Saddle Point Stokes Problem 346 CHAPTER 7. APPLIED FOURIER ANALYSIS 7.4 The Saddle Point Stokes Problem So far the matrix C has been diagonal no trouble to invert. This section jumps to a fluid flow problem that is still linear (simpler

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Simulating Solid Tumor Growth Using Multigrid Algorithms

Simulating Solid Tumor Growth Using Multigrid Algorithms Simulating Solid Tumor Growth Using Multigrid Algorithms Asia Wyatt Applied Mathematics, Statistics, and Scientific Computation Program Advisor: Doron Levy Department of Mathematics/CSCAMM Abstract In

More information

Simulating Solid Tumor Growth using Multigrid Algorithms

Simulating Solid Tumor Growth using Multigrid Algorithms Simulating Solid Tumor Growth using Multigrid Applied Mathematics, Statistics, and Program Advisor: Doron Levy, PhD Department of Mathematics/CSCAMM University of Maryland, College Park September 30, 2014

More information

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC

More information

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms www.oeaw.ac.at Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms Y. Efendiev, J. Galvis, R. Lazarov, J. Willems RICAM-Report 2011-05 www.ricam.oeaw.ac.at

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection Journal of Computational and Applied Mathematics 226 (2009) 77 83 Contents lists available at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-07 On preconditioning incompressible non-newtonian flow problems Xin He, Maya Neytcheva and Cornelis Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations

The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations The Mixed Finite Element Multigrid Preconditioned Minimum Residual Method for Stokes Equations K. Muzhinji, S. Shateyi, and S, S. Motsa 2 University of Venda, Department of Mathematics, P Bag X5050, Thohoyandou

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

Sequential Monte Carlo Samplers for Applications in High Dimensions

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

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

More information

ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER *

ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER * Journal of Computational Mathematics Vol.xx, No.x, 2x, 6. http://www.global-sci.org/jcm doi:?? ON THE GENERALIZED DETERIORATED POSITIVE SEMI-DEFINITE AND SKEW-HERMITIAN SPLITTING PRECONDITIONER * Davod

More information

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Elena Virnik, TU BERLIN Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov

More information

Newton s Method and Efficient, Robust Variants

Newton s Method and Efficient, Robust Variants Newton s Method and Efficient, Robust Variants Philipp Birken University of Kassel (SFB/TRR 30) Soon: University of Lund October 7th 2013 Efficient solution of large systems of non-linear PDEs in science

More information

FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS

FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS FINDING RIGHTMOST EIGENVALUES OF LARGE SPARSE NONSYMMETRIC PARAMETERIZED EIGENVALUE PROBLEMS Department of Mathematics University of Maryland, College Park Advisor: Dr. Howard Elman Department of Computer

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2002) 90: 665 688 Digital Object Identifier (DOI) 10.1007/s002110100300 Numerische Mathematik Performance and analysis of saddle point preconditioners for the discrete steady-state Navier-Stokes

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS

STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS STOPPING CRITERIA FOR MIXED FINITE ELEMENT PROBLEMS M. ARIOLI 1,3 AND D. LOGHIN 2 Abstract. We study stopping criteria that are suitable in the solution by Krylov space based methods of linear and non

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

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

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

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