Implicit-explicit exponential integrators

Size: px
Start display at page:

Download "Implicit-explicit exponential integrators"

Transcription

1 Implicit-explicit exponential integrators Bawfeh Kingsley Kometa joint work with Elena Celledoni MaGIC 2011 Finse, March 1-4

2 1 Introduction Motivation 2 semi-lagrangian Runge-Kutta exponential integrators SL exponential Runge-Kutta integrators semi-lagrangian methods Krylov methods 3 Semi-Lagrangian multistep exponential integrators Operator-integrating-factor (OIF) SL multistep exponential integrators 4 Remarks 5 Conclusion

3 We consider implicit-explicit (IMEX) commutator-free semi-lagrangian exponential integrators for solving convection-diffusion problems of the form t u =N(u)+Lu (1) with given boundary and initial data; wheren is a nonlinear convection operator and L is a (spatial) linear operator. Examples: Burgers, KdV, Navier-Stokes. Semi-discretization in space leads to an ODE of the form or DAE ẏ = C(y)y + Ay (2) ẏ = f(y, z) (3) 0 = g(y) (4)

4 Motivation Methods presented here are shown to work better than standard IMEX methods for problems with small diffusion coefficients. One considers exact flows of the convection term in a semi-lagrangian fashion via exponential integrators Better linear stability

5 Method SL exponential Runge-Kutta[Celledoni,Kometa;2009] ẏ = C(y)y + Ay (5) Change of variables y = Wz (y z) with the matrix W chosen such that Ẇ C(Wz)W = 0 W(0) = I (6) to obtain ż = W 1 AWz z(0) = y 0 (7) where y(0) = y 0 represents the initial data.

6 Method SL exponential Runge-Kutta[Celledoni,Kometa;2009] Starting with additive s-stage IMEX PRK pair I :={A, b, c} and E :={Â,ˆb, c} respectively, where I represents a DIRK method while E is the explicit RK; Construct coefficients of an explicit commutator-free (CF) Lie-group exponential integrator [Celledoni,Martinsen,Owren;2003], [Owren;2006] C :={α j il,βj }, l = 1,..., J, i, j = 1,..., s, l where J = J(i) is the maximum number of exponentials allowed at each stage i, and J J α j = â il ij, β j = ˆbj l l=0 l=0 C has the same classical order as E

7 Method SL exponential Runge-Kutta[Celledoni,Kometa;2009] Apply the explicit CF method C to solve the convection part (6) and the implicit RK method I to solve the diffusion part (7).

8 Method SL exponential Runge-Kutta[Celledoni,Kometa;2009] Apply the explicit CF method C to solve the convection part (6) and the implicit RK method I to solve the diffusion part (7). The resulting method in the variable y has is given by the algorithm: for i = 1 to s Y i =ϕ i y n + h i a ij ϕ i ϕ 1 j A Y j j=1 ϕ i = ( exp h kα k ij C(Y k) ) (...exp h kα k i1 C(Y k) ) end y n+1 =ϕ s+1 y n + h s b i ϕ s+1 ϕ 1 i A Y i i=1 ϕ s+1 = ( exp h kβ k J C(Y k) ) (...exp h kβ k 1 C(Y k) ) We refer to methods constructed this way as DIRK-CF.

9 SL semi-lagrangian methods To approximate y 1 = exp(hc(ỹ))y 0 (8) we compute the flow of the pure convection problem t u+v u = 0 u(x, 0) = u 0 (9) where V(x i ) = ỹ i and u 0 (x i ) = y i 0 for each grid point x i. This is computed accurately using a semi-lagrangian method. See for example [Pironneau; ], [Giraldo;1998], [Xiu, Karniadakis; 2001] etc.

10 SL Krylov methods In this case y 1 = exp(hc(ỹ))y 0 (10) can also be approximated using a Krylov subspace method. See for example [Celledoni, Moret; 1996], [Hochbruck, Lubich; 1997], [Sidje; 1998], [Lopez,Simoncini; 2006] etc.

11 Burgers equation We consider five (2nd, 3rd & 4th order) DIRK-CF methods contructed from additive IMEX RK methods taken from [Ascher et al.; 1997] and [Kennedy & Capernter; 2003]. Apply the methods to viscous Burgers equation t u+ u x u =ν xx u, x (0, 1), t (0, T] (11) with initial data u(x, 0) = u 0 (x) = sin(πx), and homogeneous Dirichlet boundary conditions.

12 Burgers equation Methods considered here are Methods order IMEX DIRK property DIRK-CF2 2 IMEX(1,2,2)[ARS] impl. midpoint DIRK-CF2L 2 IMEX(2,2,2)[ARS] stiff. acc., L-stable DIRK-CF3 3 IMEX(2,3,3)[ARS] non-stiff. acc. DIRK-CF-3L 3 IMEX(3,4,3)[ARS] stiff. acc., L-stable DIRK-CF4 4 ARK4(3)6L[2]SA[KC] stiff. acc., L-stable [ARS] = [Ascher et al.; 1997]; [KC] = [Kennedy & Capernter; 2003]

13 Burgers equation In the experiments we use Centered finite difference schemes (FDM) for spatial discretization for both the convection and diffusion operators Semi-Lagrangian schemes with cubic spline interpolations; solving the characteristics via 4th order explicit RK method. Krylov projections are used for some of the experiments. The global error are measured in the L 2 -norm Reference or exact solution are obtained via MATLAB s ode45

14 Burgers equation: Temporal error Error (L 2 ) 10 6 DIRK CF DIRK CF2L DIRK CF DIRK CF3L DIRK CF h Figure: DIRK-CF methods; Centered FDM are used in space with N = 32 nodes; x (0, 1), u(x, 0) = sin(πx), T = 1; stepsize h = T/2 k, k = 3 : 9; Temporal order [2.0076, , , , ] respectively. Krylov projections

15 Burgers equation: The three classes of methods compared We now compare the three classes of methods IMEX Runge-Kutta DIRK-CF using Krylov methods to compute the exponentials DIRK-CF using semi-lagrangian methods to compute the exponentials exponentials = flows of convecting vector fields (exp(c(ỹ)y 0 ) We measure the relative error in the discrete L -norm at time T = 2, as a function of viscosity. We use MATLAB sode15s function to compute a reference solution.

16 Burgers equation: The three classes of methods compared 10 0 Rel. Error ( L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90; We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.01

17 Burgers equation: The three classes of methods compared 10 0 Rel. Error ( L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90; We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.01

18 Burgers equation: The three classes of methods compared 10 0 Rel. Error ( L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90; We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.01

19 Burgers equation: The three classes of methods compared 10 0 Rel. Error (L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90. We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.001

20 Burgers equation: The three classes of methods compared 10 0 Rel. Error (L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90. We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.001

21 Burgers equation: The three classes of methods compared 10 0 Rel. Error (L ) ν Figure: Centered FDM are used in space with N = 81 nodes; x (0, 1), u(x, 0) = sin(πx), T = 2; stepsize h = T/90. We have SL DIRK-CF, IMEX, DIRK-CF with Krylov projections in blue, red, black resp ly. = order 2, =order 3, =order 4. Viscosity range ν 0.001

22 Operator-integrating-factor (OIF) Operator-integrating-factor (OIF)[Maday et al.; 1990] Given ẏ = C(y)y + Ay, y(t n ) = y n ; (12) Find an integrating factor I c via the convection operator C such that di c dt = I c C(ỹ(t)), I c (t n+1 ) = I = (identity matrix). (13) Differentiate the product I c y and substitute (12) and (15) to obtain d dt (I cy) = I c Ay. (14)

23 Operator-integrating-factor (OIF) Operator-integrating-factor (OIF)[Maday et al.; 1990] We have two equations and di c dt = I c C(ỹ(t)), I c (t n+1 ) = I = (identity matrix) (15) d dt (I cy) = I c Ay. (16) We apply a k-step method of order p to (16) and a one-step (multi-step also allowed) to (15). The approximation ỹ(t) := ỹ n (t) is constructed in terms of the initial values of y at time t n+k i, i = 1,...,k, such that y(t n+1 ) ỹ n (t) =O(h p+1 )

24 Operator-integrating-factor (OIF) Operator-integrating-factor (OIF)[Maday et al.; 1990] The resulting method is of the form k k α i (I c ) i y n+1 k i = h β i (I c ) i A y n+1 k i, (17) i=0 where for i = 0,...,k 1, (I C ) i w, represents the flow of the linearized ODE dψ ds = C(ỹn (t))ψ, t n+1+k i < s t n+1, ψ(t n+1+k i ) = w, and (I C ) k w = w. Meanwhileα i,β i withα k 0 are coefficients of the multistep method. i=0 (18)

25 Method SL multistep exponential[celledoni,kometa;2011] Analogous to the OIF, a general k-step multistep method is written as k k α i (I c ) i y n+1 k i = h β i (I c ) i A y n+1 k i, (19) where i=0 ϕ k = I, ϕ i = exp(hc(ỹ n i )), ỹ n i = i=0 k 1 j=0 e ij y n+1 k j, i = 0,...,k 1. Here e ij are the extrapolation coefficients, used to approximate C(y(t n+1 )) by frosen vector fields C(ỹ n i ). The coefficients e ij are be chosen so as to achieve the appropriate order of the overall method.

26 Method SL multistep exponential[celledoni,kometa;2011] Analogous to the OIF, a general k-step multistep method is written as k k α i ϕ i y n+1 k i = h β i ϕ i A y n+1 k i, (20) where i=0 ϕ k = I, ϕ i = exp(hc(ỹ n i )), ỹ n i = i=0 k 1 j=0 e ij y n+1 k j, i = 0,...,k 1. Here e ij are the extrapolation coefficients, used to approximate C(y(t n+1 )) by frosen vector fields C(ỹ n i ). The coefficients e ij are be chosen so as to achieve the appropriate order of the overall method.

27 Method SL multistep exponential[celledoni,kometa;2011] An example is the Crank-Nicolson exponential integrator (2-step, order 2): y n+1 = exp(hc(ỹ n 0 ))y n + h 2 (exp(hc(ỹn 0 ))Ay n + Ay n+1 ) (21) where ỹ n 0 := 3 2 y n 1 2 y n 1. Here we have ( α 0 = 0, α 1 =α 2 = 1;β 0 = 0,β 1 =β 2 = 1 2 while (e ij) = Using BDF schemes, methods of the type (20) upto order 4 have been derived. We refer to them as BDF-CF. We compute flows exp(hc(ỹ))y 0 in a semi-lagrangian fashion as mentioned earlier. 3 2 ).

28 Navier-Stokes, BDF-CF methods We consider the Navier-Stokes problem t u+(u )u = u p (22) u = 0 (23) with Dirichlet boundary conditions on Ω = [0, 1] 2 and initial data determined from the exact solution u 1 = y(1 x 2 )e t (24) u 2 = x(1 y 2 )e t (25) p = = t 3 x + y 1 2 (1+t 3 ) (26)

29 Navier-Stokes, BDF-CF methods We consider integrate in space, using (P N P N 2 ) spectral method, with N = 8 [Fischer,2002] in time, on interval t [0, 1] using the BDF-CF methods [Celledoni & Kometa,2011], choosing time steps h = 1/2 k, k = 3,...,8 Measuring the global error at time T = 1 we demonstrate the temporal convergence of the BDF-CF methods

30 Navier-Stokes, BDF-CF methods Error (L 2 ) BDF1 CF BDF2 CF BDF3 CF BDF4 CF h Figure: Temporal order (velocity): BDF1-CF (1.0029), BDF2-CF (1.9282), BDF3-CF (3.2982), BDF4-CF (4.3509)

31 Navier-Stokes, BDF-CF methods Error (L 2 ) BDF1 CF BDF2 CF BDF3 CF BDF4 CF Figure: Temporal order (pressure): BDF1-CF (1.0257), BDF2-CF (2.0578), BDF3-CF (3.1176), BDF4-CF (4.3446) h

32 Burgers eq: BDF-CF vs SBDF methods We compare the performance of some BDF-CF methods and the SBDF IMEX multistep methods of [Ascher et al.; 1995] for the viscous Burgers equation t u+ u x u =ν xx u, x ( 1, 1), t (0, 2] (27) with initial data u(x, 0) = u 0 (x) = sin(πx), and homogeneous Dirichlet boundary conditions.

33 Burgers eq: BDF-CF vs SBDF methods Spatial discretization: Gauss-Lobatto-Chebyshev spectral collocation method with N = 40 nodes. Relative error in L grid-norm is measured at time T = 2 as a function of viscosity, ν 0.1. The reference or exact solution is computed for N = 80 spatial nodes using MATLABs build-in ode45 function For different stepsizes h = 1/10, 1/20, 1/40, 1/80, compare the performance of SBDF and BDF-CF.

34 Burgers eq: BDF-CF vs SBDF methods Rel. Error (L ) SBDF1 SBDF2 SBDF3 BDF1 CF BDF2 CF BDF3 CF ν Figure: h = 1/80

35 Burgers eq: BDF-CF vs SBDF methods Rel. Error (L ) SBDF1 SBDF2 SBDF3 BDF1 CF BDF2 CF BDF3 CF ν Figure: h = 1/40

36 Burgers eq: BDF-CF vs SBDF methods Rel. Error (L ) SBDF1 SBDF2 SBDF3 BDF1 CF BDF2 CF BDF3 CF ν Figure: h = 1/20

37 Burgers eq: BDF-CF vs SBDF methods Rel. Error (L ) 10 3 SBDF SBDF2 SBDF3 BDF1 CF 10 5 BDF2 CF BDF3 CF ν Figure: h = 1/10

38 DIRK-CF methods on Navier-Stokes Direct applications of DIRK-CF methods on the discrete equations leads to a loss in order of convergence. Possible reasons include low stage order of the constituent DIRK methods [Hairer & Wanner,2ed.; 1996] insufficient treatment of the vector fields on the constraint manifold [O. Verdier]

39 Can we fix this? Replace the discrete problem ẏ = C(y)y + Ay D T z, Dy = 0 (28) by its restriction on the constraint manifold M :={y : Dy = 0}, namely: ẏ = ΠC(y)y +ΠAy, (29) where Π represents the orthogonal projection on M. Apply the DIRK-CF method on (29) instead of (28).

40 Can we fix this? slope = Error ( L 2 ) 10 6 slope = NS Projected Figure: Toy Navier-Stokes: dim(y) = 20, dim(z) = 10; DIRK-CF3L; Error in y : T = 1, h = T/2 l, l = 2 : 8 h

41 Can we fix this? slope = Error (L 2 ) slope = NS Projected h Figure: Toy Navier-Stokes: dim(y) = 20, dim(z) = 10; DIRK-CF4; Error in y : T = 1, h = T/2 l, l = 2 : 8

42 Conclusion Classical order theory required Efficient implementation of the semi-lagrangian interpolations required Work still in progress. Thanks for your attention!

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients AM 205: lecture 13 Last time: ODE convergence and stability, Runge Kutta methods Today: the Butcher tableau, multi-step methods, boundary value problems Butcher tableau Can summarize an s + 1 stage Runge

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

Time-Parallel Algorithms for Weather Prediction and Climate Simulation

Time-Parallel Algorithms for Weather Prediction and Climate Simulation Time-Parallel Algorithms for Weather Prediction and Climate Simulation Jean Côté Adjunct Prof. ESCER Centre (Étude et la Simulation du Climat à l Échelle Régionale) Sciences de la Terre & de l Atmosphère

More information

The family of Runge Kutta methods with two intermediate evaluations is defined by

The family of Runge Kutta methods with two intermediate evaluations is defined by AM 205: lecture 13 Last time: Numerical solution of ordinary differential equations Today: Additional ODE methods, boundary value problems Thursday s lecture will be given by Thomas Fai Assignment 3 will

More information

Numerical Oscillations and how to avoid them

Numerical Oscillations and how to avoid them Numerical Oscillations and how to avoid them Willem Hundsdorfer Talk for CWI Scientific Meeting, based on work with Anna Mozartova (CWI, RBS) & Marc Spijker (Leiden Univ.) For details: see thesis of A.

More information

A Composite Runge Kutta Method for the Spectral Solution of Semilinear PDEs

A Composite Runge Kutta Method for the Spectral Solution of Semilinear PDEs Journal of Computational Physics 8, 57 67 (00) doi:0.006/jcph.00.77 A Composite Runge Kutta Method for the Spectral Solution of Semilinear PDEs Tobin A. Driscoll Department of Mathematical Sciences, University

More information

norges teknisk-naturvitenskapelige universitet Semi-Lagrangian exponential integrators for the incompressible Navier-Stokes equations

norges teknisk-naturvitenskapelige universitet Semi-Lagrangian exponential integrators for the incompressible Navier-Stokes equations norges teknisk-naturvitenskapelige universitet Semi-Lagrangian eponential integrators for the incompressible Navier-Stokes equations b Elena Celledoni, Bawfeh Kingsle Kometa and Olivier Verdier preprint

More information

Integrating-Factor-Based 2-Additive Runge Kutta methods for Advection-Reaction-Diffusion Equations

Integrating-Factor-Based 2-Additive Runge Kutta methods for Advection-Reaction-Diffusion Equations Integrating-Factor-Based 2-Additive Runge Kutta methods for Advection-Reaction-Diffusion Equations A Thesis Submitted to the College of Graduate Studies and Research in Partial Fulfillment of the Requirements

More information

Symplectic integration with Runge-Kutta methods, AARMS summer school 2015

Symplectic integration with Runge-Kutta methods, AARMS summer school 2015 Symplectic integration with Runge-Kutta methods, AARMS summer school 2015 Elena Celledoni July 13, 2015 1 Hamiltonian systems and their properties We consider a Hamiltonian system in the form ẏ = J H(y)

More information

Exponential integrators for semilinear parabolic problems

Exponential integrators for semilinear parabolic problems Exponential integrators for semilinear parabolic problems Marlis Hochbruck Heinrich-Heine University Düsseldorf Germany Innsbruck, October 2004 p. Outline Exponential integrators general class of methods

More information

Exponential integration of large systems of ODEs

Exponential integration of large systems of ODEs Exponential integration of large systems of ODEs Jitse Niesen (University of Leeds) in collaboration with Will Wright (Melbourne University) 23rd Biennial Conference on Numerical Analysis, June 2009 Plan

More information

Validated Explicit and Implicit Runge-Kutta Methods

Validated Explicit and Implicit Runge-Kutta Methods Validated Explicit and Implicit Runge-Kutta Methods Alexandre Chapoutot joint work with Julien Alexandre dit Sandretto and Olivier Mullier U2IS, ENSTA ParisTech 8th Small Workshop on Interval Methods,

More information

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

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

More information

SEMI-IMPLICIT INTEGRAL DEFERRED CORRECTION CONSTRUCTED WITH ADDITIVE RUNGE-KUTTA METHODS

SEMI-IMPLICIT INTEGRAL DEFERRED CORRECTION CONSTRUCTED WITH ADDITIVE RUNGE-KUTTA METHODS SEMI-IMPLICIT INTEGRAL DEFERRED CORRECTION CONSTRUCTED WITH ADDITIVE RUNGE-KUTTA METHODS ANDREW CHRISTLIEB, MAUREEN MORTON, BENJAMIN ONG, AND JING-MEI QIU Abstract. In this paper, we consider construct

More information

Time-Parallel Algorithms for Weather Prediction and Climate Simulation

Time-Parallel Algorithms for Weather Prediction and Climate Simulation Time-Parallel Algorithms for Weather Prediction and Climate Simulation Jean Côté Adjunct Prof. ESCER Centre (Étude et la Simulation du Climat à l Échelle Régionale) Sciences de la Terre & de l Atmosphère

More information

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions Applied Mathematical Sciences, Vol. 6, 22, no. 3, 563-565 Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions M. C. Kweyu, W. A. Manyonge 2, A. Koross

More information

A note on the uniform perturbation index 1

A note on the uniform perturbation index 1 Rostock. Math. Kolloq. 52, 33 46 (998) Subject Classification (AMS) 65L5 M. Arnold A note on the uniform perturbation index ABSTRACT. For a given differential-algebraic equation (DAE) the perturbation

More information

Partitioned Runge-Kutta Methods for Semi-explicit Differential-Algebraic Systems of Index 2

Partitioned Runge-Kutta Methods for Semi-explicit Differential-Algebraic Systems of Index 2 Partitioned Runge-Kutta Methods for Semi-explicit Differential-Algebraic Systems of Index 2 A. Murua Konputazio Zientziak eta A. A. Saila, EHU/UPV, Donostia-San Sebastián email ander@si.ehu.es December

More information

Implicit explicit numerical schemes for Parabolic Integro-Differential Equations. Maya Briani. LUISS Guido Carli

Implicit explicit numerical schemes for Parabolic Integro-Differential Equations. Maya Briani. LUISS Guido Carli Implicit explicit numerical schemes for Parabolic Integro-Differential Equations Maya Briani LUISS Guido Carli & Istituto per le Applicazioni del Calcolo - CNR Joint work with R. Natalini (Istituto per

More information

Energy-Preserving Runge-Kutta methods

Energy-Preserving Runge-Kutta methods Energy-Preserving Runge-Kutta methods Fasma Diele, Brigida Pace Istituto per le Applicazioni del Calcolo M. Picone, CNR, Via Amendola 122, 70126 Bari, Italy f.diele@ba.iac.cnr.it b.pace@ba.iac.cnr.it SDS2010,

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

SPECIALIZED RUNGE-KUTTA METHODS FOR INDEX 2 DIFFERENTIAL-ALGEBRAIC EQUATIONS

SPECIALIZED RUNGE-KUTTA METHODS FOR INDEX 2 DIFFERENTIAL-ALGEBRAIC EQUATIONS MATHEMATICS OF COMPUTATION Volume 75, Number 254, Pages 641 654 S 0025-5718(05)01809-0 Article electronically published on December 19, 2005 SPECIALIZED RUNGE-KUTTA METHODS FOR INDEX 2 DIFFERENTIAL-ALGEBRAIC

More information

Time-adaptive methods for the incompressible Navier-Stokes equations

Time-adaptive methods for the incompressible Navier-Stokes equations Time-adaptive methods for the incompressible Navier-Stokes equations Joachim Rang, Thorsten Grahs, Justin Wiegmann, 29.09.2016 Contents Introduction Diagonally implicit Runge Kutta methods Results with

More information

Surprising Computations

Surprising Computations .... Surprising Computations Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca www.cs.ubc.ca/ ascher/ Uri Ascher (UBC) Surprising Computations Fall 2012 1 / 67 Motivation.

More information

Exponential integrators and functions of the matrix exponential

Exponential integrators and functions of the matrix exponential Exponential integrators and functions of the matrix exponential Paul Matthews, Stephen Cox, Hala Ashi and Linda Cummings School of Mathematical Sciences, University of Nottingham, UK Introduction to exponential

More information

Numerical Mathematics

Numerical Mathematics Alfio Quarteroni Riccardo Sacco Fausto Saleri Numerical Mathematics Second Edition With 135 Figures and 45 Tables 421 Springer Contents Part I Getting Started 1 Foundations of Matrix Analysis 3 1.1 Vector

More information

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

The need for de-aliasing in a Chebyshev pseudo-spectral method

The need for de-aliasing in a Chebyshev pseudo-spectral method The need for de-aliasing in a Chebyshev pseudo-spectral method Markus Uhlmann Potsdam Institut für Klimafolgenforschung, D-442 Potsdam uhlmann@pik-potsdam.de (March 2) Abstract In the present report, we

More information

arxiv: v1 [physics.comp-ph] 30 Sep 2015

arxiv: v1 [physics.comp-ph] 30 Sep 2015 On the quasi-unconditional stability of BDF-ADI solvers for the compressible Navier-Stokes equations arxiv:1509.09213v1 [physics.comp-ph] 30 Sep 2015 Oscar P. Bruno and Max Cubillos Abstract The companion

More information

multistep methods Last modified: November 28, 2017 Recall that we are interested in the numerical solution of the initial value problem (IVP):

multistep methods Last modified: November 28, 2017 Recall that we are interested in the numerical solution of the initial value problem (IVP): MATH 351 Fall 217 multistep methods http://www.phys.uconn.edu/ rozman/courses/m351_17f/ Last modified: November 28, 217 Recall that we are interested in the numerical solution of the initial value problem

More information

Discontinuous Collocation Methods for DAEs in Mechanics

Discontinuous Collocation Methods for DAEs in Mechanics Discontinuous Collocation Methods for DAEs in Mechanics Scott Small Laurent O. Jay The University of Iowa Iowa City, Iowa, USA July 11, 2011 Outline 1 Introduction of the DAEs 2 SPARK and EMPRK Methods

More information

Geometric Numerical Integration

Geometric Numerical Integration Geometric Numerical Integration (Ernst Hairer, TU München, winter 2009/10) Development of numerical ordinary differential equations Nonstiff differential equations (since about 1850), see [4, 2, 1] Adams

More information

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations mathematics Article Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations Michael Machen and Yong-Tao Zhang * Department of Applied and Computational Mathematics and Statistics,

More information

Southern Methodist University.

Southern Methodist University. Title: Continuous extensions Name: Lawrence F. Shampine 1, Laurent O. Jay 2 Affil./Addr. 1: Department of Mathematics Southern Methodist University Dallas, TX 75275 USA Phone: +1 (972) 690-8439 E-mail:

More information

The collocation method for ODEs: an introduction

The collocation method for ODEs: an introduction 058065 - Collocation Methods for Volterra Integral Related Functional Differential The collocation method for ODEs: an introduction A collocation solution u h to a functional equation for example an ordinary

More information

Multistage Methods I: Runge-Kutta Methods

Multistage Methods I: Runge-Kutta Methods Multistage Methods I: Runge-Kutta Methods Varun Shankar January, 0 Introduction Previously, we saw that explicit multistep methods (AB methods) have shrinking stability regions as their orders are increased.

More information

Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations

Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations Outline ODEs and initial conditions. Explicit and implicit Euler methods. Runge-Kutta methods. Multistep

More information

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems Institute for Mathematics and Scientific Computing, Austria DISC Summerschool 5 Outline of the talk POD and singular value decomposition

More information

ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs

ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs E. CELLEDONI Department of Mathematical Sciences, NTNU 749 Trondheim, Norway. email: elenac@math.ntnu.no Abstract This note considers energy-preservation

More information

Co-sponsored School/Workshop on Integrable Systems and Scientific Computing June Exponential integrators for stiff systems

Co-sponsored School/Workshop on Integrable Systems and Scientific Computing June Exponential integrators for stiff systems 2042-2 Co-sponsored School/Workshop on Integrable Systems and Scientific Computing 15-20 June 2009 Exponential integrators for stiff systems Paul Matthews University of Nottingham U.K. e-mail: Paul.Matthews@nottingham.ac.uk

More information

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Oren Peles and Eli Turkel Department of Applied Mathematics, Tel-Aviv University In memoriam of

More information

Energy Preserving Numerical Integration Methods

Energy Preserving Numerical Integration Methods Energy Preserving Numerical Integration Methods Department of Mathematics and Statistics, La Trobe University Supported by Australian Research Council Professorial Fellowship Collaborators: Celledoni (Trondheim)

More information

Applied Numerical Analysis

Applied Numerical Analysis Applied Numerical Analysis Using MATLAB Second Edition Laurene V. Fausett Texas A&M University-Commerce PEARSON Prentice Hall Upper Saddle River, NJ 07458 Contents Preface xi 1 Foundations 1 1.1 Introductory

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

CS520: numerical ODEs (Ch.2)

CS520: numerical ODEs (Ch.2) .. CS520: numerical ODEs (Ch.2) Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca people.cs.ubc.ca/ ascher/520.html Uri Ascher (UBC) CPSC 520: ODEs (Ch. 2) Fall

More information

Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential Equations

Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential Equations International journal of scientific and technical research in engineering (IJSTRE) www.ijstre.com Volume Issue ǁ July 206. Four Point Gauss Quadrature Runge Kuta Method Of Order 8 For Ordinary Differential

More information

A Fast Spectral Algorithm for Nonlinear Wave Equations with Linear Dispersion

A Fast Spectral Algorithm for Nonlinear Wave Equations with Linear Dispersion Journal of Computational Physics 155, 456 467 (1999) Article ID jcph.1999.6351, available online at http://www.idealibrary.com on A Fast Spectral Algorithm for Nonlinear Wave Equations with Linear Dispersion

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

More information

Exponential Runge-Kutta methods for parabolic problems

Exponential Runge-Kutta methods for parabolic problems Exponential Runge-Kutta methods for parabolic problems Marlis Hochbruck a,, Alexander Ostermann b a Mathematisches Institut, Heinrich-Heine Universität Düsseldorf, Universitätsstraße 1, D-4225 Düsseldorf,

More information

Navier-Stokes equations

Navier-Stokes equations 1 Navier-Stokes equations Introduction to spectral methods for the CSC Lunchbytes Seminar Series. Incompressible, hydrodynamic turbulence is described completely by the Navier-Stokes equations where t

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 2: Runge Kutta and Linear Multistep methods Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the

More information

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Xinghui Zhong 12/09/ 2009 Outline 1 Introduction Why SSP methods Idea History/main reference 2 Explicit SSP Runge-Kutta Methods

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

Linear algebra for exponential integrators

Linear algebra for exponential integrators Linear algebra for exponential integrators Antti Koskela KTH Royal Institute of Technology Beräkningsmatematikcirkus, 28 May 2014 The problem Considered: time integration of stiff semilinear initial value

More information

Numerical Methods for the Optimal Control of Scalar Conservation Laws

Numerical Methods for the Optimal Control of Scalar Conservation Laws Numerical Methods for the Optimal Control of Scalar Conservation Laws Sonja Steffensen, Michael Herty, and Lorenzo Pareschi RWTH Aachen University, Templergraben 55, D-52065 Aachen, GERMANY {herty,steffensen}@mathc.rwth-aachen.de

More information

C1.2 Ringleb flow. 2nd International Workshop on High-Order CFD Methods. D. C. Del Rey Ferna ndez1, P.D. Boom1, and D. W. Zingg1, and J. E.

C1.2 Ringleb flow. 2nd International Workshop on High-Order CFD Methods. D. C. Del Rey Ferna ndez1, P.D. Boom1, and D. W. Zingg1, and J. E. C. Ringleb flow nd International Workshop on High-Order CFD Methods D. C. Del Rey Ferna ndez, P.D. Boom, and D. W. Zingg, and J. E. Hicken University of Toronto Institute of Aerospace Studies, Toronto,

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

Quintic B-Spline Galerkin Method for Numerical Solutions of the Burgers Equation

Quintic B-Spline Galerkin Method for Numerical Solutions of the Burgers Equation 5 1 July 24, Antalya, Turkey Dynamical Systems and Applications, Proceedings, pp. 295 39 Quintic B-Spline Galerkin Method for Numerical Solutions of the Burgers Equation İdris Dağ 1,BülentSaka 2 and Ahmet

More information

A definition of stiffness for initial value problems for ODEs SciCADE 2011, University of Toronto, hosted by the Fields Institute, Toronto, Canada

A definition of stiffness for initial value problems for ODEs SciCADE 2011, University of Toronto, hosted by the Fields Institute, Toronto, Canada for initial value problems for ODEs SciCADE 2011, University of Toronto, hosted by the Fields Institute, Toronto, Canada Laurent O. Jay Joint work with Manuel Calvo (University of Zaragoza, Spain) Dedicated

More information

Numerical approximation for optimal control problems via MPC and HJB. Giulia Fabrini

Numerical approximation for optimal control problems via MPC and HJB. Giulia Fabrini Numerical approximation for optimal control problems via MPC and HJB Giulia Fabrini Konstanz Women In Mathematics 15 May, 2018 G. Fabrini (University of Konstanz) Numerical approximation for OCP 1 / 33

More information

The use of cubic spline and far-side boundary condition for the collocation solution of a transient convection-diffusion problem

The use of cubic spline and far-side boundary condition for the collocation solution of a transient convection-diffusion problem Korean J Chem Eng, 24(2), 204-208 (2007) SHORT COMMUNICATION The use of cubic spline and far-side boundary condition for the collocation solution of a transient convection-diffusion problem Woohyun Yun

More information

Linearly implicit Runge Kutta methods for advection reaction diffusion equations

Linearly implicit Runge Kutta methods for advection reaction diffusion equations Applied Numerical Mathematics 37 (2001) 535 549 Linearly implicit Runge Kutta methods for advection reaction diffusion equations M.P. Calvo, J. de Frutos, J. Novo Departamento de Matemática Aplicada y

More information

NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET. Singly diagonally implicit Runge-Kutta methods with an explicit first stage

NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET. Singly diagonally implicit Runge-Kutta methods with an explicit first stage NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET Singly diagonally implicit Runge-Kutta methods with an explicit first stage by Anne Kværnø PREPRINT NUMERICS NO. 1/2004 NORWEGIAN UNIVERSITY OF SCIENCE AND

More information

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements Electronic Text Provided with the Book Numerical Methods for Problems with Moving Fronts by Bruce A. Finlayson Ravenna Park Publishing, Inc., 635 22nd Ave. N. E., Seattle, WA 985-699 26-524-3375; ravenna@halcyon.com;www.halcyon.com/ravenna

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

CHAPTER 5: Linear Multistep Methods

CHAPTER 5: Linear Multistep Methods CHAPTER 5: Linear Multistep Methods Multistep: use information from many steps Higher order possible with fewer function evaluations than with RK. Convenient error estimates. Changing stepsize or order

More information

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Accuracy Enhancement Using Spectral Postprocessing for Differential Equations and Integral Equations

Accuracy Enhancement Using Spectral Postprocessing for Differential Equations and Integral Equations COMMUICATIOS I COMPUTATIOAL PHYSICS Vol. 5, o. -4, pp. 779-79 Commun. Comput. Phys. February 009 Accuracy Enhancement Using Spectral Postprocessing for Differential Equations and Integral Equations Tao

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 6 Chapter 20 Initial-Value Problems PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

Part IB Numerical Analysis

Part IB Numerical Analysis Part IB Numerical Analysis Definitions Based on lectures by G. Moore Notes taken by Dexter Chua Lent 206 These notes are not endorsed by the lecturers, and I have modified them (often significantly) after

More information

Stabilität differential-algebraischer Systeme

Stabilität differential-algebraischer Systeme Stabilität differential-algebraischer Systeme Caren Tischendorf, Universität zu Köln Elgersburger Arbeitstagung, 11.-14. Februar 2008 Tischendorf (Univ. zu Köln) Stabilität von DAEs Elgersburg, 11.-14.02.2008

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

Exponential multistep methods of Adams-type

Exponential multistep methods of Adams-type Exponential multistep methods of Adams-type Marlis Hochbruck and Alexander Ostermann KARLSRUHE INSTITUTE OF TECHNOLOGY (KIT) 0 KIT University of the State of Baden-Wuerttemberg and National Laboratory

More information

Lecture 42 Determining Internal Node Values

Lecture 42 Determining Internal Node Values Lecture 42 Determining Internal Node Values As seen in the previous section, a finite element solution of a boundary value problem boils down to finding the best values of the constants {C j } n, which

More information

Comparing Leja and Krylov approximations of large scale matrix exponentials

Comparing Leja and Krylov approximations of large scale matrix exponentials Comparing Leja and Krylov approximations of large scale matrix exponentials L. Bergamaschi 1, M. Caliari 2, A. Martínez 2, and M. Vianello 2 1 Dept. of Math. Methods and Models, University of Padova, berga@dmsa.unipd.it

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 6 Chapter 20 Initial-Value Problems PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction

More information

Exponential Integrators

Exponential Integrators Exponential Integrators John C. Bowman and Malcolm Roberts (University of Alberta) June 11, 2009 www.math.ualberta.ca/ bowman/talks 1 Outline Exponential Integrators Exponential Euler History Generalizations

More information

Segregated Runge-Kutta methods for the incompressible Navier-Stokes equations

Segregated Runge-Kutta methods for the incompressible Navier-Stokes equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 0000; 00:1 29 Published online in Wiley InterScience (www.interscience.wiley.com). Segregated Runge-Kutta methods for

More information

A SEMI-LAGRANGIAN RUNGE-KUTTA METHOD FOR TIME-DEPENDENT PARTIAL DIFFERENTIAL EQUATIONS

A SEMI-LAGRANGIAN RUNGE-KUTTA METHOD FOR TIME-DEPENDENT PARTIAL DIFFERENTIAL EQUATIONS Journal of pplied nalysis and Computation Website:http://jaac-online.com/ Volume 3, Number 3, ugust 23 pp. 25 263 SEMI-LGRNGIN RUNGE-KUTT METHOD FOR TIME-DEPENDENT PRTIL DIFFERENTIL EQUTIONS Daniel X.

More information

Suboptimal feedback control of PDEs by solving HJB equations on adaptive sparse grids

Suboptimal feedback control of PDEs by solving HJB equations on adaptive sparse grids Wegelerstraße 6 53115 Bonn Germany phone +49 228 73-3427 fax +49 228 73-7527 www.ins.uni-bonn.de Jochen Garcke and Axel Kröner Suboptimal feedback control of PDEs by solving HJB equations on adaptive sparse

More information

A Differential Quadrature Algorithm for the Numerical Solution of the Second-Order One Dimensional Hyperbolic Telegraph Equation

A Differential Quadrature Algorithm for the Numerical Solution of the Second-Order One Dimensional Hyperbolic Telegraph Equation ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.13(01) No.3,pp.59-66 A Differential Quadrature Algorithm for the Numerical Solution of the Second-Order One Dimensional

More information

Backward error analysis

Backward error analysis Backward error analysis Brynjulf Owren July 28, 2015 Introduction. The main source for these notes is the monograph by Hairer, Lubich and Wanner [2]. Consider ODEs in R d of the form ẏ = f(y), y(0) = y

More information

Applications of Lie group integrators and exponential schemes

Applications of Lie group integrators and exponential schemes Applications of Lie group integrators and exponential schemes Workshop on Lie group methods and control theory, Edinburgh, 28.6-1.7, 2004, Brynjulf Owren Dept of Math Sci, NTNU Applications of Lie group

More information

Numerical Analysis. A Comprehensive Introduction. H. R. Schwarz University of Zürich Switzerland. with a contribution by

Numerical Analysis. A Comprehensive Introduction. H. R. Schwarz University of Zürich Switzerland. with a contribution by Numerical Analysis A Comprehensive Introduction H. R. Schwarz University of Zürich Switzerland with a contribution by J. Waldvogel Swiss Federal Institute of Technology, Zürich JOHN WILEY & SONS Chichester

More information

An Empirical Chaos Expansion Method for Uncertainty Quantification

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

More information

Stability of the Parareal Algorithm

Stability of the Parareal Algorithm Stability of the Parareal Algorithm Gunnar Andreas Staff and Einar M. Rønquist Norwegian University of Science and Technology Department of Mathematical Sciences Summary. We discuss the stability of the

More information

Numerical solution of ODEs

Numerical solution of ODEs Numerical solution of ODEs Arne Morten Kvarving Department of Mathematical Sciences Norwegian University of Science and Technology November 5 2007 Problem and solution strategy We want to find an approximation

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

Mathematics subject classification: 65M12, 76D05. Key words: Incompressible flow, Stream-function formulation, Finite difference methods.

Mathematics subject classification: 65M12, 76D05. Key words: Incompressible flow, Stream-function formulation, Finite difference methods. Journal of Computational Mathematics, Vol.27, No.4, 2009, 441 458. STABLE FOURTH-ORDER STREAM-FUNCTION METHODS FOR INCOMPRESSIBLE FLOWS WITH BOUNDARIES * Thomas Y. Hou Department of Applied and Computational

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 2: Runge Kutta and Multistep Methods Gustaf Söderlind Numerical Analysis, Lund University Contents V4.16 1. Runge Kutta methods 2. Embedded RK methods

More information

Spectral Vanishing Viscosity Method for Large-Eddy Simulation of Turbulent Flows

Spectral Vanishing Viscosity Method for Large-Eddy Simulation of Turbulent Flows Journal of Scientific Computing ( 2006) DOI: 10.1007/s10915-005-9029-9 Spectral Vanishing Viscosity Method for Large-Eddy Simulation of Turbulent Flows Richard Pasquetti 1 Received October 6, 2004; accepted

More information

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

More information

CRANK-NICOLSON FINITE DIFFERENCE METHOD FOR SOLVING TIME-FRACTIONAL DIFFUSION EQUATION

CRANK-NICOLSON FINITE DIFFERENCE METHOD FOR SOLVING TIME-FRACTIONAL DIFFUSION EQUATION Journal of Fractional Calculus and Applications, Vol. 2. Jan. 2012, No. 2, pp. 1-9. ISSN: 2090-5858. http://www.fcaj.webs.com/ CRANK-NICOLSON FINITE DIFFERENCE METHOD FOR SOLVING TIME-FRACTIONAL DIFFUSION

More information

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations Spectral element schemes for the Korteweg-de Vries and Saint-Venant equations R. PASQUETTI a a. Université Côte d Azur, CNRS, Inria, LJAD, France, richard.pasquetti@unice.fr... Résumé : Les sytèmes hyperboliques

More information

Rosenbrock time integration combined with Krylov subspace enrichment for unsteady flow simulations

Rosenbrock time integration combined with Krylov subspace enrichment for unsteady flow simulations Master of Science Thesis Rosenbrock time integration combined with Krylov subspace enrichment for unsteady flow simulations Unsteady aerodynamics David Blom January 11, 2013 Ad Rosenbrock time integration

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