A Review of Solution Techniques for Unsteady Incompressible Flow

Size: px
Start display at page:

Download "A Review of Solution Techniques for Unsteady Incompressible Flow"

Transcription

1 Zeist 2009 p. 1/57 A Review of Solution Techniques for Unsteady Incompressible Flow David Silvester School of Mathematics University of Manchester

2 Zeist 2009 p. 2/57 PDEs Review : Update : Outline

3 Zeist 2009 p. 3/57 PDEs Outline u t + u u ν 2 u + p = 0 u = 0 Navier Stokes

4 Zeist 2009 p. 4/57 PDEs Outline u t + u u ν 2 u + p = 0 u = 0 Navier Stokes u t + u u ν 2 u + p = jt u = 0 T t + u T ν 2 T = 0 Boussinesq

5 Zeist 2009 p. 5/57 Navier-Stokes Equations u t + u u ν 2 u + p = 0 u = 0 in W Ω (0,T) in W Boundary and Initial conditions u = g on Γ D [0,T]; ν u n p n = 0 u( x, 0) = u 0 ( x) in Ω. on Γ N [0,T];

6 Zeist 2009 p. 6/57 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. gives the method-of-lines discretized system: ( ) ( ) ( ) ( ) M 0 u N( u) + νa B T u B 0 p t p t with associated matrices N ij = ( u φ i, φ j ), A ij = ( φ i, φ j ), convection diffusion B ij = ( φ j,ψ i ), divergence. = ( ) f 0

7 Example: Flow over a Step Zeist 2009 p. 7/57

8 Zeist 2009 p. 8/57 PDEs Review : Update : Outline

9 Zeist 2009 p. 9/57 PDEs Outline Review :

10 Zeist 2009 p. 10/57 Spatial Discretization I Suppose that Ω R 2. Introducing u = (u x,u y ) gives u x t + u y t + ( u x x + u y ( u x x + u y With a discrete analogue.. ) u x ν 2 u x + p y ) y x = 0 u y ν 2 u y + p y = 0 ( ux x + u ) y = 0 y

11 Zeist 2009 p. 10/57 Spatial Discretization I Suppose that Ω R 2. Introducing u = (u x,u y ) gives u x t + u y t + ( u x x + u y ( u x x + u y ) u x ν 2 u x + p y ) y x = 0 u y ν 2 u y + p y = 0 ( ux x + u ) y = 0 y With a discrete analogue.. M M α x t α y t α p t F 0 Bx T 0 F By T B x B y 0 α x α y α p = 0 0 0

12 Zeist 2009 p. 11/57 Spatial Discretization II The method-of-lines discretized system is a semi-explicit system of DAEs: M 0 0 F 0 Bx T 0 M F By T = B x B y 0 α x t α y t α p t α x α y α p The DAEs have index equal to two The discrete problem is nonlinear F := νa + N(α)

13 Zeist 2009 p. 11/57 Spatial Discretization II The method-of-lines discretized system is a semi-explicit system of DAEs: M 0 0 F 0 Bx T 0 M F By T = B x B y 0 α x t α y t α p t α x α y α p The DAEs have index equal to two The discrete problem is nonlinear F := νa + N(α) To reduce the index we differentiate the constraint...

14 Zeist 2009 p. 12/57 Spatial Discretization III... to give an index one DAE system: α x t M 1 F 0 M 1 Bx T α y t + 0 M 1 F M 1 By T 0 B x M 1 F B y M 1 F A p α x α y α p = The matrix A p := B x M 1 B T x + B y M 1 B T y is the (consistent) Pressure Poisson matrix. Explicit approximation in time gives a decoupled formulation. Diagonally implicit approximation in time gives a segregated (SIMPLE-like) formulation. Implicit approximation in time does not look attractive!

15 Zeist 2009 p. 13/57 ( ) ( ) M 0 u 0 0 t p t + ( N( u) + νa B T B 0 ) ( ) u p = ( ) f

16 Zeist 2009 p. 14/57 A simple splitting/projection approach I ( ) ( ) M 0 u t p t ( F( u) B T B 0 ) ( ) u p Given a time step dt and a parameter 0 < γ 2 = ( ) f Algorithm: Chorin, 1967; Temam, 1969 for k = 0, 1,... solve M u t + F( u k ) u = f B T p k solve BM 1 B T φ = B u 0 compute compute end u k+1 = u M 1 B T φ p k+1 = p k + (γ/dt)φ

17 Zeist 2009 p. 15/57 A simple splitting/projection approach II Key Question: Is the projection/splitting consistent?

18 Zeist 2009 p. 15/57 A simple splitting/projection approach II Key Question: Is the projection/splitting consistent? Practictioners say yes... Chorin (1967), Temam(1969), Kim & Moin (1985), Van Kan (1986), Bell, Colella & Glaz (1989), Gresho & Chan (1984, 1990), Perot (1993), Turek (1997).

19 Zeist 2009 p. 15/57 A simple splitting/projection approach II Key Question: Is the projection/splitting consistent? Practictioners say yes... Chorin (1967), Temam(1969), Kim & Moin (1985), Van Kan (1986), Bell, Colella & Glaz (1989), Gresho & Chan (1984, 1990), Perot (1993), Turek (1997). Mathematicians say sometimes... Guermond (1984), Rannacher (1992), E & Liu (1995, 1996), Shen (1992, 1996), Prohl (1997, 2007 ).

20 Zeist 2009 p. 16/57 ( ) ( ) M 0 u 0 0 t p t + ( N( u) + νa B T B 0 ) ( ) u p = ( ) f

21 Zeist 2009 p. 17/57 A Stokes splitting/projection approach I ( M ) ( ) u + t p t ( N( u) + νa B T B 0 ) ( ) u p Given a time step dt, discretise the total derivative: Algorithm: Pironneau, 1982; Hansbo, 1982 for k = 0, 1,... compute X m ( x) the solution at τ k = kdt of = ( ) 0 0 dx dτ = u k (X,τ), X(τ k+1 ) = x; end interpolate u k = u k (X m ( x)) ( ) ( ) 1 solve dt M + νa B T u k+1 B 0 p k+1 = ( ) 1 dt M u k 0

22 Zeist 2009 p. 18/57 A simple splitting/projection approach II Key 1 Question: Is the total derivative approximation stable numerically?

23 Zeist 2009 p. 18/57 A simple splitting/projection approach II Key 1 Question: Is the total derivative approximation stable numerically? Mathematicians say yes, but care is needed... Hansbo (1982), Pironneau (1982), Morton, Priestley & Suli (1988,1989, 1994), Bermejo & Staniforth (1991, 1992).

24 Zeist 2009 p. 18/57 A simple splitting/projection approach II Key 1 Question: Is the total derivative approximation stable numerically? Mathematicians say yes, but care is needed... Hansbo (1982), Pironneau (1982), Morton, Priestley & Suli (1988,1989, 1994), Bermejo & Staniforth (1991, 1992). Key 2 Question: Adaptive time stepping?

25 Zeist 2009 p. 19/57 ( ) ( ) M 0 u 0 0 t p t + ( N( u) + νa B T B 0 ) ( ) u p = ( ) f

26 A clever splitting/projection approach I ( M ) ( ) u + t p t ( N( u) + νa B T B 0 ) ( ) u p Given dt and parameters θ = 1 1/ 2, α = 1 2θ 1 θ Algorithm: Glowinski, 1986, 1991 for k = 0, ( 1,... ) ( ) 1 solve θdt M + ανa BT u k+θ = B 0 p k+θ ( ) 1 solve solve end (1 2θ)dT M + N( u k+1 θ) + βνa ) ( ) M + ανa BT u k+1 = B 0 p k+1 ( 1 θdt ( f k 0 ) = ( ) f 0,β = 1 α. u k+1 θ = f k+θ ( f k+1 θ 0 ) Zeist 2009 p. 20/57

27 Zeist 2009 p. 21/57 A clever splitting/projection approach II Key 1 Question: Is the algorithm over-complicated?

28 Zeist 2009 p. 21/57 A clever splitting/projection approach II Key 1 Question: Is the algorithm over-complicated? Mathematicians say no,... Glowinski & Dean (1984, 1993), Bristeau et al. (1985), Rannacher (1989, 1990), Turek (1996), Smith & Silvester (1997).

29 Zeist 2009 p. 21/57 A clever splitting/projection approach II Key 1 Question: Is the algorithm over-complicated? Mathematicians say no,... Glowinski & Dean (1984, 1993), Bristeau et al. (1985), Rannacher (1989, 1990), Turek (1996), Smith & Silvester (1997). Key 2 Question: Adaptive time stepping?

30 Zeist 2009 p. 22/57 Update : 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. MIMS Eprint

31 Zeist 2009 p. 23/57 Smart Integrator (SI) definition Optimal time-stepping: time-steps automatically chosen to follow the physics. Black-box implementation: few parameters that have to be estimated a priori.

32 Zeist 2009 p. 23/57 Smart Integrator (SI) definition Optimal time-stepping: time-steps automatically chosen to follow the physics. Black-box implementation: few parameters that have to be estimated a priori. Solver efficiency: the linear solver convergence rate is robust with respect to the mesh size h and the Reynolds number 1/ν.

33 Zeist 2009 p. 24/57 Trapezoidal Rule (TR) time discretization We subdivide [0,T] into time levels {t i } N i=1. Given ( un,p n ) at time level t n, k n+1 := t n+1 t n, compute ( u n+1,p n+1 ) via 2 k n+1 u n+1 + w n+1 u n+1 ν 2 u n+1 + p n+1 = f n+1 u n+1 = 0 in Ω u n+1 = g n+1 ν u n+1 n p n+1 n = 0 on Γ D on Γ N with second-order linearization f n+1 = 2 k n+1 u n + ν 2 u n u n u n p n w n+1 = (1 + k n+1 k n ) u n k n+1 k n u n 1

34 Zeist 2009 p. 25/57 Saddle-point system In R 2 the discretized Oseen system (*) is: F n+1 0 Bx T α x,n+1 0 F n+1 By T α y,n+1 = B x B y 0 α p,n+1 f x,n+1 f y,n+1 f p,n+1 F n+1 := 2 k n+1 M + νa + N( w n+1 h ) The vector f is constructed from the boundary data g n+1, the computed velocity u n h at the previous time level and the acceleration un h t The system can be efficiently solved using appropriately preconditioned GMRES...

35 Zeist 2009 p. 26/57 Preconditioned system ( F B T B 0 ) P 1 P ( ) α u α p = ( ) f u f p A perfect 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 with F = 2 k n+1 M + νa + N and S = BF 1 B T.

36 Zeist 2009 p. 27/57 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 8 of Howard Elman & David Silvester & Andrew Wathen Finite Elements and Fast Iterative Solvers: with applications in incompressible fluid dynamics Oxford University Press, Two possible constructions...

37 Zeist 2009 p. 28/57 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 } {{ } amg ) 1 (BM 1 FM 1 B T )(BM 1 B T } {{ } amg ) 1

38 Zeist 2009 p. 29/57 Schur complement approximation II Introducing associated pressure matrices M p ( ψ i, ψ j ), A p ( ψ i, ψ j ), N p ( w h ψ i,ψ j ), F p = 2 k n+1 M p + νa p + N p, mass diffusion convection convection-diffusion gives the pressure convection-diffusion preconditioner : (BF 1 B T ) 1 Mp 1 F p A 1 p }{{} amg

39 Zeist 2009 p. 30/57 Adaptive Time Stepping AB2 TR Consider the simple ODE u = f(u) Manipulating the truncation error terms for TR and AB2 gives the estimate T n = u n+1 u n+1 3(1 + k n k n+1 ) Given some user-prescribed error tolerance tol, the new time step is selected to be the biggest possible such that T n+1 tol u max. This criterion leads to k n+2 := k n+1 ( tol umax T n ) 1/3

40 Zeist 2009 p. 30/57 Adaptive Time Stepping AB2 TR Consider the simple ODE u = f(u) Manipulating the truncation error terms for TR and AB2 gives the estimate T n = u n+1 u n+1 3(1 + k n k n+1 ) Given some user-prescribed error tolerance tol, the new time step is selected to be the biggest possible such that T n+1 tol u max. This criterion leads to But look out for ringing... k n+2 := k n+1 ( tol umax T n ) 1/3

41 Zeist 2009 p. 31/57 Stabilized AB2 TR To address the instability issues: We rewrite the AB2 TR algorithm to compute updates v n and w n scaled by the time-step: u n+1 u n = 1 2 k n+1v n ; u n+1 u n = k n+1 w n. We perform time-step averaging every n steps: u n := 1 2 (u n+u n 1 ); u n+1 := u n k n+1v n ; u n+1 := 1 2 v n. Contrast this with the standard acceleration obtained by inverting the TR formula: u n+1 = 2 k n+1 (u n+1 u n ) u n = v n u n

42 Zeist 2009 p. 32/57 Stabilized AB2 TR t 10 2 t t t Advection-Diffusion of step profile on Shishkin grid. tol = 10 3 tol = 10 4

43 Zeist 2009 p. 33/57 Stabilized AB2 TR Spin up driven cavity flow with ν = 1/100.

44 Zeist 2009 p. 34/57 Adaptive Time-Stepping Algorithm I The following parameters must be specified: time accuracy tolerance tol (10 4 ) GMRES tolerance itol (10 6 ) GMRES iteration limit maxit (50)

45 Zeist 2009 p. 34/57 Adaptive Time-Stepping Algorithm I The following parameters must be specified: time accuracy tolerance tol (10 4 ) GMRES tolerance itol (10 6 ) GMRES iteration limit maxit (50) Starting from rest, u 0 = 0, and given a steady state boundary condition u( x, t) = g, we model the impulse with a time-dependent boundary condition: u( x,t) = g(1 e 5t ) on Γ D [0,T].

46 Zeist 2009 p. 34/57 Adaptive Time-Stepping Algorithm I The following parameters must be specified: time accuracy tolerance tol (10 4 ) GMRES tolerance itol (10 6 ) GMRES iteration limit maxit (50) Starting from rest, u 0 = 0, and given a steady state boundary condition u( x, t) = g, we model the impulse with a time-dependent boundary condition: u( x,t) = g(1 e 5t ) on Γ D [0,T]. We specify the frequency of averaging, typically n = 10. We also choose a very small initial timestep, typically, k 1 = 10 8.

47 Zeist 2009 p. 35/57 Adaptive Time-Stepping Algorithm II Setup the Oseen System ( ) and compute [α x,n+1,α y,n+1 ] using GMRES(maxit, itol).

48 Zeist 2009 p. 35/57 Adaptive Time-Stepping Algorithm II Setup the Oseen System ( ) and compute [α x,n+1,α y,n+1 ] using GMRES(maxit, itol). Compute the LTE estimate e v,n+1

49 Zeist 2009 p. 35/57 Adaptive Time-Stepping Algorithm II Setup the Oseen System ( ) and compute [α x,n+1,α y,n+1 ] using GMRES(maxit, itol). Compute the LTE estimate e v,n+1 If e v,n+1 > (1/0.7) 3 tol, we reject the current time step, and repeat the old time step with k n+1 = k n+1 ( tol e v,n+1 )1/3.

50 Zeist 2009 p. 35/57 Adaptive Time-Stepping Algorithm II Setup the Oseen System ( ) and compute [α x,n+1,α y,n+1 ] using GMRES(maxit, itol). Compute the LTE estimate e v,n+1 If e v,n+1 > (1/0.7) 3 tol, we reject the current time step, and repeat the old time step with k n+1 = k n+1 ( tol e v,n+1 )1/3. Otherwise, accept the step and continue with n = n + 1 and k n+2 based on the LTE estimate and the accuracy tolerance tol.

51 Zeist 2009 p. 36/57 Example Flow Problem I (ν = 1/1000)

52 Time step evolution Zeist 2009 p. 37/57

53 Linear solver performance Zeist 2009 p. 38/57

54 Example Flow Problem II (ν = 1/100) Zeist 2009 p. 39/57

55 Lift Coefficient Zeist 2009 p. 40/57

56 Time step evolution Zeist 2009 p. 41/57

57 Zeist 2009 p. 42/57 Bouyancy driven flow u t + u u ν 2 u + p = jt u = 0 T t + u T ν 2 T = 0 in W Ω (0,T) in W in W Boundary and Initial conditions u = 0 on Γ [0,T]; u( x, 0) = 0 in Ω. T = T g on Γ D [0,T]; ν T n = 0 on Γ N [0,T]; T( x, 0) = T 0 ( x) in Ω.

58 Zeist 2009 p. 43/57 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: M 0 0 F B T M u B 0 0 p 0 0 M 0 0 F T u t p t T t = 0 0 g with a (vertical ) mass matrix: ( M ) ij = ([0,φ i ],φ j )

59 Zeist 2009 p. 44/57 Preconditioning strategy F B T B F M P 1 P α 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 1 B S F } 0 0 {{ F 1 } P 1 = f u f p f T I 0 0 I BF 1 M F I BF 1

60 Example: Natural Convection in 1:16 cavity Zeist 2009 p. 45/57

61 Zeist 2009 p. 46/57... with efficient linear algebra 35 Average number of Krylov iterations (AMG) 10 2 Evolution of the time step size N it t Picard Newton time step time step

62 Zeist 2009 p. 47/57 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 ν

63 References Semi-Implicit, Fractional-Step, Pressure Projection I A.J. Chorin A numerical method for solving incompressible viscous flow problems, J. Comput. Phys., 2:12 26, J. Kim & P. Moin Application of a fractional step method to incompressible Navier Stokes equations, J. Comput. Phys., 59: , J. Van Kan A second order accurate pressure correction scheme for viscous incompressible flow, SIAM J. Sci. Stat. Comput., 7(3): , J.B. Bell, P. Colella & H.M. Glaz A second order projection method for the incompressible Navier Stokes equations, J. Comput. Phys., 85:(2) , Zeist 2009 p. 48/57

64 Zeist 2009 p. 49/57 Semi-Implicit, Fractional-Step, Pressure Projection II P.M. Gresho, S.T. Chan, R.L. Lee & C.D. Upson A modified finite element method for solving the time dependent, incompressible Navier Stokes equations. Part 1: Theory, Int. J. Numer. Meth. Fluids, 4: , P.M. Gresho & S.T. Chan On the theory of semi implicit projection methods for viscous incompressible flow and its implementation via a finite element method that also introduces a nearly consistent mass matrix. Part 2: Implementation, Int. J. Numer. Meth. Fluids, 11(5): , J.B. Perot An analysis of the fractional step method, J. Comput. Phys., 108:51 58, 1993.

65 Zeist 2009 p. 50/57 Semi-Implicit, Fractional-Step, Pressure Projection III J. L. Guermond Sur l approximation des équations de Navier Stokes instationnaires par une méthode de projection, C.R. Acad. Sci. Paris, 319: , Serie I. R. Rannacher The Navier Stokes Equations II: Theory and Numerical Methods, Springer Verlag, Berlin, Germany, Chap.On Chorin s projection method for the incompressible Navier Stokes equations; pp ; Lecture Notes in Mathematics, Vol

66 Zeist 2009 p. 51/57 Semi-Implicit, Fractional-Step, Pressure Projection IV W. E & J. G. Liu Projection method I: Convergence and numerical boundary layers, SIAM J. Numer. Anal., 32(4): , W. E & J. G. Liu Vorticity boundary conditions and related issues for finite difference schemes, J. Comput. Phys., 124: , 1996.

67 Zeist 2009 p. 52/57 Semi-Implicit, Fractional-Step, Pressure Projection V J. Shen On error estimates of some higher order projection and penalty projection methods for Navier Stokes equations, Numer. Math., 62:49 73, J. Shen On error estimates of the projection methods for the Navier Stokes equations: Second order schemes, Math. Comput., 65, 215: , A. Prohl Analysis of Chorin s projection method for solving the incompressible Navier Stokes equations, Universität Heidelberg, Institut für Angewandte Mathematik, INF 294, D Heidelberg, Germany, 1996.

68 Zeist 2009 p. 53/57 Transport Diffusion, Lagrange-Galerkin, Backward Method of Characteristics I P. Hansbo The characteristic streamline diffusion method for the time dependent incompressible Navier Stokes equations, Comput. Meth. Appl. Mech. Eng., 99: , O. Pironneau On the transport diffusion algorithm and its application to the Navier Stokes equations, Numer. Math., 38: , K.W. Morton, A. Priestley & E. Süli Stability of the Lagrange Galerkin method with non exact integration, Math. Model. Numer. Anal., 22:(4) , 1988.

69 Zeist 2009 p. 54/57 Transport Diffusion, Lagrange-Galerkin, Backward Method of Characteristics II A. Priestley Exact projections and the Lagrange Galerkin method: A realistic alternative to quadrature, J. Comput. Phys., 112: , 1994 R. Bermejo Analysis of an algorithm for the Galerkin characteristic method, Numer. Math., 60: , 1991.

70 Zeist 2009 p. 55/57 Fractional Step, le Θ scheme I M.O. Bristeau, R. Glowinski, B. Mantel, J. Periaux & P. Perrier, Numerical methods for incompressible and compressible Navier Stokes problems, Finite Elements in Fluids 6 (R.H. Gallagher, G. Carey, J.T. Oden & O.C. Zienkiewicz, eds), Chichester: Wiley, pp E.J. Dean & R. Glowinski On some finite element methods for the numerical simulation of incompressible viscous flow, Incompressible Computational Fluid Dynamics., (M.D. Gunzburger & R.A. Nicolaides, eds), Cambridge University Press, pp

71 Zeist 2009 p. 56/57 Fractional Step, le Θ scheme II R. Rannacher Applications of mathematics in industry and technology, B.G. Teubner, Stuttgart, Germany, Chap. Numerical analysis of nonstationary fluid flow (a survey); pp ; (V.C. Boffi & H. Neunzert, eds). R. Rannacher Navier Stokes equations: theory and numerical methods, Springer Verlag, Berlin, Germany, Chap. On the numerical analysis of the non stationary Navier Stokes equations; pp ; (J. Heywood et al., eds).

72 Zeist 2009 p. 57/57 Fractional Step, le Θ scheme III S. Turek A comparative study of some time stepping techniques for the incompressible Navier Stokes equations: From fully implicit nonlinear schemes to semi implicit projection methods, Int. J. Numer. Meth. Fluids, 22(10): , A. Smith & D.J. Silvester Implicit algorithms and their linearization for the transient incompressible Navier Stokes equations, IMA J. Numer. Anal. 17: , 1997.

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

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

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4 Gauge Finite Element Method for Incompressible Flows Weinan E 1 Courant Institute of Mathematical Sciences New York, NY 10012 Jian-Guo Liu 2 Temple University Philadelphia, PA 19122 Abstract: We present

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

Uncertainty Quantification: Does it need efficient linear algebra?

Uncertainty Quantification: Does it need efficient linear algebra? 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 Yes. USA trip

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

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Jie Shen Department of Mathematics, Penn State University University Par, PA 1680, USA Abstract. We present in this

More information

Gauge finite element method for incompressible flows

Gauge finite element method for incompressible flows INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 34: 701 710 Gauge finite element method for incompressible flows Weinan E a, *,1 and Jian-Guo Liu b,2 a Courant Institute

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

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

PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID

PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID MATHEMATICS OF COMPUTATION Volume 71, Number 237, Pages 27 47 S 0025-5718(01)01313-8 Article electronically published on May 14, 2001 PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID

More information

Finite Element Decompositions for Stable Time Integration of Flow Equations

Finite Element Decompositions for Stable Time Integration of Flow Equations MAX PLANCK INSTITUT August 13, 2015 Finite Element Decompositions for Stable Time Integration of Flow Equations Jan Heiland, Robert Altmann (TU Berlin) ICIAM 2015 Beijing DYNAMIK KOMPLEXER TECHNISCHER

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

Projection Method with Spatial Discretizations

Projection Method with Spatial Discretizations Projection Method with Spatial Discretizations Weinan E School of Mathematics Institute for Advanced Study Princeton, NJ 08540 and Jian-Guo Liu Courant Institute of Mathematical Sciences New York, NY 10012

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

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

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods 1 Introduction Achieving high order time-accuracy in the approximation of the incompressible Navier Stokes equations by means of fractional-step

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

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

Runge-Kutta-Chebyshev Projection Method

Runge-Kutta-Chebyshev Projection Method Runge-Kutta-Chebyshev Projection Method Zheming Zheng Linda Petzold Department of Mechanical Engineering, University of California Santa Barbara, Santa Barbara, CA 93106, USA June 8, 2006 This work was

More information

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume LIII, Number 1, March 2008 HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS IOAN TELEAGA AND JENS

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

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

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Tenth MSU Conference on Differential Equations and Computational Simulations. Electronic Journal of Differential Equations, Conference 3 (06), pp. 9 0. ISSN: 07-669. URL: http://ejde.math.txstate.edu or

More information

New constructions of domain decomposition methods for systems of PDEs

New constructions of domain decomposition methods for systems of PDEs New constructions of domain decomposition methods for systems of PDEs Nouvelles constructions de méthodes de décomposition de domaine pour des systèmes d équations aux dérivées partielles V. Dolean?? F.

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

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

Efficient Solvers for the Navier Stokes Equations in Rotation Form

Efficient Solvers for the Navier Stokes Equations in Rotation Form Efficient Solvers for the Navier Stokes Equations in Rotation Form Computer Research Institute Seminar Purdue University March 4, 2005 Michele Benzi Emory University Atlanta, GA Thanks to: NSF (MPS/Computational

More information

Vector and scalar penalty-projection methods

Vector and scalar penalty-projection methods Numerical Flow Models for Controlled Fusion - April 2007 Vector and scalar penalty-projection methods for incompressible and variable density flows Philippe Angot Université de Provence, LATP - Marseille

More information

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE

A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE A DISCRETE PROJECTION METHOD FOR INCOMPRESSIBLE VISCOUS FLOW WITH CORIOLIS FORCE ANDRIY SOKOLOV, MAXIM A. OLSHANSKII, AND STEFAN TUREK Abstract. The paper presents a new discrete projection method (DPM)

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

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

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

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

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

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN Weierstraß-Institut für Angewandte Analysis und Stochastik im Forschungsverbund Berlin e.v. Preprint ISSN 946 8633 Computational comparison between the Taylor Hood and the conforming Crouzeix Raviart element

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

Glowinski Pironneau method for the 3D ω-ψ equations

Glowinski Pironneau method for the 3D ω-ψ equations 280 GUERMOND AND QUARTAPELLE Glowinski Pironneau method for the 3D ω-ψ equations Jean-Luc Guermond and Luigi Quartapelle 1 LIMSI CNRS, Orsay, France, and Dipartimento di Fisica, Politecnico di Milano,

More information

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU MATHEMATICS OF COMPUTATION Volume 69, Number 232, Pages 135{1407 S 0025-571(00)0124-5 Article electronically published on March 24, 2000 CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 Jie Shen Department of Mathematics, Penn State University University Park, PA 1682 Abstract. We present some

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES

ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES MATHEMATICS OF COMPUTATION Volume, Number, Pages S 5-578XX- ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES RICARDO H. NOCHETTO AND JAE-HONG PYO Abstract.

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

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations A. Ouazzi, M. Nickaeen, S. Turek, and M. Waseem Institut für Angewandte Mathematik, LSIII, TU Dortmund, Vogelpothsweg

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

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

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows Author manuscript, published in "5th International Symposium on Finite Volumes for Complex Applications, Aussois : France 2008)" Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible

More information

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations Songul Kaya and Béatrice Rivière Abstract We formulate a subgrid eddy viscosity method for solving the steady-state

More information

arxiv: v1 [physics.flu-dyn] 23 Apr 2016

arxiv: v1 [physics.flu-dyn] 23 Apr 2016 A numerical study of the transition to oscillatory flow in 3D lid-driven cubic cavity flows Shang-Huan Chiu, Tsorng-Whay Pan, Jiwen He, Aixia Guo, and Roland Glowinski Department of Mathematics, University

More information

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

A posteriori error estimates applied to flow in a channel with corners

A posteriori error estimates applied to flow in a channel with corners Mathematics and Computers in Simulation 61 (2003) 375 383 A posteriori error estimates applied to flow in a channel with corners Pavel Burda a,, Jaroslav Novotný b, Bedřich Sousedík a a Department of Mathematics,

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

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

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev Implementation of 3D Incompressible N-S Equations Mikhail Sekachev Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick

More information

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller Algebraic flux correction and its application to convection-dominated flow Matthias Möller matthias.moeller@math.uni-dortmund.de Institute of Applied Mathematics (LS III) University of Dortmund, Germany

More information

Universität des Saarlandes. Fachrichtung 6.1 Mathematik

Universität des Saarlandes. Fachrichtung 6.1 Mathematik Universität des Saarlandes U N I V E R S I T A S S A R A V I E N I S S Fachrichtung 6. Mathematik Preprint Nr. 228 A Variational Multiscale Method for Turbulent Flow Simulation with Adaptive Large Scale

More information

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N)

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) wwwijmercom Vol2, Issue1, Jan-Feb 2012 pp-464-472 ISSN: 2249-6645 A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) Jaouad El-Mekkaoui 1, Abdeslam Elakkad

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

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations A Least-Squares Finite Element Approximation for the Compressible Stokes Equations Zhiqiang Cai, 1 Xiu Ye 1 Department of Mathematics, Purdue University, 1395 Mathematical Science Building, West Lafayette,

More information

The Deflation Accelerated Schwarz Method for CFD

The Deflation Accelerated Schwarz Method for CFD The Deflation Accelerated Schwarz Method for CFD J. Verkaik 1, C. Vuik 2,, B.D. Paarhuis 1, and A. Twerda 1 1 TNO Science and Industry, Stieltjesweg 1, P.O. Box 155, 2600 AD Delft, The Netherlands 2 Delft

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

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

JURJEN DUINTJER TEBBENS

JURJEN DUINTJER TEBBENS Proceedings of ALGORITMY 005 pp. 40 49 GMRES ACCELERATION ANALYSIS FOR A CONVECTION DIFFUSION MODEL PROBLEM JURJEN DUINTJER TEBBENS Abstract. When we apply the GMRES method [4] to linear systems arising

More information

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS Proceedings of ALGORITMY 2009 pp. 1 10 SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS MILOSLAV VLASÁK Abstract. We deal with a numerical solution of a scalar

More information

2 CAI, KEYES AND MARCINKOWSKI proportional to the relative nonlinearity of the function; i.e., as the relative nonlinearity increases the domain of co

2 CAI, KEYES AND MARCINKOWSKI proportional to the relative nonlinearity of the function; i.e., as the relative nonlinearity increases the domain of co INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 00:1 6 [Version: 2000/07/27 v1.0] Nonlinear Additive Schwarz Preconditioners and Application in Computational Fluid

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

Adaptive preconditioners for nonlinear systems of equations

Adaptive preconditioners for nonlinear systems of equations Adaptive preconditioners for nonlinear systems of equations L. Loghin D. Ruiz A. Touhami CERFACS Technical Report TR/PA/04/42 Also ENSEEIHT-IRIT Technical Report RT/TLSE/04/02 Abstract The use of preconditioned

More information

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS FREE BOUNDARY PROBLEMS IN FLUID MECHANICS ANA MARIA SOANE AND ROUBEN ROSTAMIAN We consider a class of free boundary problems governed by the incompressible Navier-Stokes equations. Our objective is to

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

In honor of Prof. Hokee Minn

In honor of Prof. Hokee Minn In honor of Prof. Hokee Minn It is my greatest honor to be here today to deliver the nd Minn Hokee memorial lecture. I would like to thank the Prof. Ha for the nomination and the selecting committee for

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

More information

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Modeling, Simulating and Rendering Fluids Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Applications Mostly Hollywood Shrek Antz Terminator 3 Many others Games Engineering Animating Fluids is

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

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Numerical Methods for Incompressible Viscous Flow

Numerical Methods for Incompressible Viscous Flow Numerical Methods for Incompressible Viscous Flow Hans Petter Langtangen Kent-Andre Mardal Dept. of Scientific Computing, Simula Research Laboratory and Dept. of Informatics, University of Oslo Ragnar

More information

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000 UNIVERSITY OF MARYLAND INSTITUTE FOR ADVANCED COMPUTER STUDIES DEPARTMENT OF COMPUTER SCIENCE PERFORMANCE AND ANALYSIS OF SADDLE POINT PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS

More information

Preconditioning the incompressible Navier-Stokes equations with variable viscosity

Preconditioning the incompressible Navier-Stokes equations with variable viscosity Preconditioning the incompressible Navier-Stokes equations with variable viscosity Xin He and Maya Neytcheva Abstract This paper deals with preconditioners for the iterative solution of the discrete Oseen

More information

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

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

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

More information

Hamiltonian aspects of fluid dynamics

Hamiltonian aspects of fluid dynamics Hamiltonian aspects of fluid dynamics CDS 140b Joris Vankerschaver jv@caltech.edu CDS 01/29/08, 01/31/08 Joris Vankerschaver (CDS) Hamiltonian aspects of fluid dynamics 01/29/08, 01/31/08 1 / 34 Outline

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

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

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

NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM

NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM Proceedings of ALGORITMY 212 pp. 44 415 NUMERICAL STUDIES OF VARIATIONAL-TYPE TIME-DISCRETIZATION TECHNIQUES FOR TRANSIENT OSEEN PROBLEM NAVEED AHMED AND GUNAR MATTHIES Abstract. In this paper, we combine

More information

A monolithic FEM solver for fluid structure

A monolithic FEM solver for fluid structure A monolithic FEM solver for fluid structure interaction p. 1/1 A monolithic FEM solver for fluid structure interaction Stefan Turek, Jaroslav Hron jaroslav.hron@mathematik.uni-dortmund.de Department of

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

A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations

A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations Journal of Computational Physics 187 (2003) 504 523 www.elsevier.com/locate/jcp A parallel block multi-level preconditioner for the 3D incompressible Navier Stokes equations Howard C. Elman a,1, Victoria

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

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

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

1. Introduction. Consider nonstationary Navier Stokes equations with a nonslip boundary condition

1. Introduction. Consider nonstationary Navier Stokes equations with a nonslip boundary condition SIAM J. SCI. COMPUT. Vol. 3, No., pp. 398 49 c 8 Society for Industrial and Applied Mathematics LONG TIME NUMERICAL SOLUTION OF THE NAVIER STOKES EQUATIONS BASED ON A SEQUENTIAL REGULARIZATION FORMULATION

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information