University of Houston, Department of Mathematics Numerical Analysis II. Chapter 4 Numerical solution of stiff and differential-algebraic equations

Size: px
Start display at page:

Download "University of Houston, Department of Mathematics Numerical Analysis II. Chapter 4 Numerical solution of stiff and differential-algebraic equations"

Transcription

1 Chapter 4 Numerical solution of stiff and differential-algebraic equations 4.1 Characteristics of stiff systems The solution has components with extremely different growth properties. Example: 2 u (x) = (q 1 + q 2 ) u(x) + ((q 1 q 2 ) v(x), u(a) = 2, 2 v (x) = (q 1 q 2 ) u(x) + ((q 1 + q 2 ) v(x), v(a) = 0 with the solution u(x) = exp(q 1 (x a)) + exp(q 2 (x a)), v(x) = exp(q 1 (x a)) exp(q 2 (x a)). The explicit Euler method provides the approximations u j = (1 + h q 1 ) j + (1 + h q 2 ) j, v j = (1 + h q 1 ) j (1 + h q 2 ) j. If Req 1 < 0, Req 2 < 0 and the approximations should behave in the same way as the solution, the following two conditions must be satisfied simultaneously: 1 + h q 1 < 1, 1 + h q 2 < 1.

2 In case Req 2 < Req 1 < 0, the requirements 1 + h q 1 < 1, 1 + h q 2 < 1 imply the condition ( ) h q 2 < 2. The components of u and v associated with q 2 decay faster than the components associated with q 1, in particular, if Req 2 Req 1. After an initial phase until a sufficient decay of exp(q 2 (x a)) compared to exp(q 1 (x a)), one should expect that the accuracy of the approximations and hence the step size h is only determined by the component associated with q 1, if only the component associated with q 2 is integrated stably, i.e., such that it does not increase. However, this does not hold true for the explicit Euler method. Here, the step size has always to be chosen according to ( ), which is much too small from the point of view of accuracy.

3 On the other hand, the application of the implicit Euler method gives: u j = v j = 1 + (1 h q 1 ) j 1 (1 h q 1 ) j 1 (1 h q 2 ) j, j 0, 1 (1 h q 2 ) j, j 0. Without any restriction of the step size h, the approximations decay for increasing j. Consequence: We need special integrators for stiff systems.

4 4.2 One step methods for stiff systems Linear stability theory In case of linear systems y = Ay, the growth properties of the solutions are determined by the eigenvalues λ σ(a). In case of nonlinear systems y = f(y), local information is obtained by the eigenvalues of the Jacobi matrix J f (y ) := f y (y ). Definition 4.1 Lokal and global contractivity Assume that f C 1 (D), D lr d, and that <, > is an inner product on lr d with associated norm. Moreover, let y C(I) and A := f y (y ). If < u, A u > µ(a) u 2, u lr d, the quantity µ(a) is called the local, one-sided Lipschitz constant. If µ(a) < 0, the system y = f(y) is said to be locally contractive. If there exists µ lr such that < f(u) f(v), u v > µ u v 2, u,v lr d, the quantity µ is called the global, one-sided Lipschitz constant. If µ < 0, the system y = f(y) is said to be globally contractive.

5 Theorem 4.2 Growth properties of nonlinear autonomous systems Under the assumption < f(u) f(v), u v > µ u v 2, u,v lr d, for x I there holds u(x) v(x) exp( µ(x a)) u(a) v(a). Proof: Straightforward application of Gronwall s lemma. Theorem 4.3 Ljapunov stability Assume that A lr n n is a matrix whose eigenvalues λ(a) σ(a) satisfy Re λ(a) < 0. Then, there exist constants c 0 and µ 0 such that the solution y C 1 (I) of the initial value problem y = Ay, y(a) = α, satisifies y(x) c exp(µ(x a)), x I. Proof: Orthogonal transformation of A to Schur s normal form and recursive solution of the transformed initial value problem.

6 Affine covariance of autonomous systems Consider the initial value problem (AWP) 1 y (x) = f(y(x)), x I, (AWP) 2 y(a) = α. If B is a non singular n n matrix such that B x 0, the affine transformation y By =: ȳ of the variable y results in the transformed initial value problem (AWP) 1 ȳ = f(ȳ(x)), x I, (AWP) 2 ȳ(a) = Bα, where f(ȳ) := Bf(B 1 ȳ). The existence and uniqueness theorem provides the relationship ȳ = By, which is referred to as the affine covariance of the autonomous system.

7 Definition 4.4 Affine covariance of numerical integrators A numerical integrator for the solution of an initial value problem for a system of first order ordinary differential equations is called affine covariant, if there holds: If B is a non singular n n matrix such that B x 0 and y h C(I h ) is an approximation of the solution y C 1 (I) of the initial value problem, obtained by the integrator, then ȳ h = By h is an approximation of ȳ = By. Consequence of affine covariance: scalar test equation The local stability of the initial value problem (AWP) 1, (AWP) 2 is determined by the eigenvalues of the Jacobi matrix f y. The spectrum of the Jacobi matrix is invariant with respect to similarity transformations f y B f y B 1. If A := f y is diagonalizable, there exists a non singular matrix B such that B A B 1 = diag(λ 1,..., λ n ), where λ i σ(a), 1 i n. Due to the affine covariance it is sufficient to consider the scalar test equation (T) y (x) = λ y(x), x > 0, y(0) = 1 (λ C).

8 The solution of the scalar test equation (T) is given by y(x) = exp(λx), x 0. Setting z := λx,z C, the restriction of y to a uniform grid of step size h > 0 results in the following characterization of the stability of the solution of the scalar test equation: (i) Re z < 0 = y(h) = exp(z) < 1, (ii) Re z = 0 = y(h) = exp(z) = 1, (iii) Re z > 0 = y(h) = exp(z) > 1. Going to the limit z, we see that in z = there is an essential singularity of the solution of the test equation: (i) Re z < 0 = y(h) 0 (z ), (ii) Re z = 0 = y(h) = 1 (z ), (iii) Re z > 0 = y(h) (z ).

9 Behavior of solutions of classical one-step methods applied to the test equation a) Explicit Euler method y 1 = y 0 + h λ y 0 = (1 + h λ) = 1 + z = y 1 (z ). b) Implicit Euler method c) Implicit trapezoidal rule y 1 = y 0 + h λ y 1 = y 1 = 1 1 z = y 1 0 (z ). y 1 = y 0 + h 2 λ (y 1 + y 0 ) = y 1 = 1 + z/2 1 z/2 = y 1 = 1 (z ).

10 General implicit one-step methods Implicit one-step methods lead to rational functions: where R lm (z) is an approximation of exp(z). y 1 = R lm (z) y 0 = P l (z) Q m (z) y 0, Definition 4.5 Padé approximation of the exponential function Let l,m ln 0 and P l, Q m polynomials of degree l resp. m. If the rational function exp(z) Q m (z) P l (z) = O( z l+m+1 (z 0), R lm (z) = P l (z) Q m (z) is called a Padé approximation of exp(z) of index (m, l). The stability region of an implicit one-step method with R = R lm is given by G := { z C R(z) 1 }.

11 Stability regions for numerical integrators The stability region (in the sense y 0 as z ) of the analytical solution y = exp(z) of the test equation is the complex hyperplane G A = C := { z C Re z 0 }. Natural requirement for the stability region of a numerical integrator: ( ) G = C. Consequences of ( ) with regard to Padé approximations: Since the imaginary axis Re z = 0 corresponds to the sphere R(z) = 1, we must have ( ) R(z) = 1 for Re z = 0. Since ( ) must be satisfied for Im z + as well, R(z) = P l (z) Q l (z) (diagonal Padé approximation).

12 Since z = z for Rez = 0, it follows that 1 = R(z) 2 = R(z) R(z) = R(z) R( z) = R(z) R( z). In view of R(z) = P l (z)/q l (z) this implies P l (z) P l ( z) = Q l (z) Q l ( z) = P l ( z) = Q l (z). Example: Implicit trapezoidal rule P 1 (z) = 1 + z 2, Q 1(z) = 1 z 2 = P 1( z) = R( ) = 1. In general: Oscillatory behavior due to R( ) = ( 1) l.

13 A-stability, L-stability and super stability Dahlquist s condition [Dahlquist (1963)]: If the analytical solution is decreasing, this should be reflected by the numerical approximation. Definition 4.6 A-stability A one-step method with Padé approximation R = R(z) is called A-stable, if C G. Lemma 4.7 A-stability of diagonal and subdiagonal Padé approximations ( Ehle s conjecture ) [Hairer, Norsett, Wanner (1978)] One-step methods with Padé approximations of index (m, l), l m l + 2, are A-stable. The implicit trapezoidal rule is A-stable, but R(z) 1 as z. This motivates: Definition 4.8 L-stability An A-stable one-step method is called L-stable, if R(z) 0 as Rez. Lemma 4.9 L-stability of subdiagonal Padé approximations One-step methods with Padé approximations of index (l + 1, l) are L-stable.

14 Definition 4.10 Super stability An L-stable one-step method is called super stable, if C G, i.e., G \ C. Example: Implicit Euler method Stability region: G := { z C z 1 > 1}. Definition 4.11 A(α)-stability [Widlund (1967)] A one-step method with Padé approximation R = R(z) is called A(α)-stable, if G = G(α) = { z C arg z π α }. Example: BDF methods (see below)

15 4.3 Implicit and semi-implicit Runge-Kutta methods Implicit s-stage Runge-Kutta method: Setting c i := s j=1 a ij, 1 i s: k 1 = h f(x k + c 1 h, y k + s j=1 a 1j k j ), c 1 a 11 a 1s,, k s = h f(x k + c s h, y k + y k+1 = y k + s j=1 s j=1 a sj k j ), c s a s1 a ss b j k j, b 1 b s Butcher scheme

16 Implicit Runge-Kutta methods require the solution of a nonlinear system. Setting k i = h f(x k + c i h,g i ), it follows that Linear stability theory: g i = y k + h s a ij f(x k + c j h, g j ), 1 i s. Application to the scalar test equation yields (with A := (a ij ) s i,j=1): g 1 g s }{{} =:g = 1 1 }{{} =:e If (I s za) is non singular: j=1 y k + h λ }{{} =:z A g 1 g s = (I s z A) g=e y k k=z g y k+1 = y k + b T k = [ 1 + z b T (I s z A) 1 e ] y k. =

17 The representation y k+1 = y k + b T k = [ 1 + z b T (I s z A) 1 e ] y k. gives rise to the stability function: R s (z) = 1 + b T ( 1 z I s A) 1 e. If A is non singular: R s ( ) = 1 b T A 1 e. L-stability: R s ( ) = 0 Example: Fehlberg-trick for implicit Runge-Kutta methods a sj = b j, 1 j s = c s = s j=1 a sj = s j=1 b j = 1 = b T = e T s A, where e s := (0,...,0,1) T = R s ( ) = 1 e T s A A 1 e = 0.

18 Solution of the nonlinear system by a simplified Newton method g 1 y k h s a 1j f(x k + c 1 h, g j ) j=1 G(g 1,...,g s ) = g s y k h s a sj f(x k + c s h, g j ) j=1 = 0. For the Jacobi matrix at g i = y k, we obtain: G i g g = δ l l =y k il I d h a il f y(x k + c i h, g l ) g l = δ =y k il I d h a il f y(x k, y k ) }{{}}{{} =:A =: J It follows that I d ha 11 A ha 12 A ha 1s A ha 21 A I d ha 22 A ha 2s A J = ha s1 A ha s2 A I d ha ss A Since J h=0 = I, we find that J is regular for sufficiently small h > O(h 2 ).

19 Simplified Newton method: Choose g (0) = (g (0) 1,...,g s (0) ) T with g (0) i = y k, 1 i s. Then, for k = 0,1,2,... compute: J g (k) = G(g (k) ), g (k+1) = g (k) + g (k).

20 Simplifications: a) DIRK (Diagonally Implicit Runge - Kutta) LR decomposition of s matrices of the form c 1 a c 2 a 21 a c s a s1 a s2 a s3 a ss b 1 b 2 b 3 b s I d h a ii A = L i R i, 1 i s.

21 Simplifications: b) SDIRK (Singly Diagonally Implicit Runge - Kutta) LR decomposition of only one matrix: c 1 γ c 2 a 21 γ 0 0 c s a s1 a s2 a s3 γ b 1 b 2 b 3 b s I d h γ A = L R.

22 Semi-implicit Runge-Kutta methods: Implementation of only one Newton iteration: J g (0) = G(g (0) ), where g (0) = (g (0) 1,...,g (0) s ) T with g (0) i = y k, 1 i s. g (1) = g (0) + g (0), Rosenbrock methods: Construction for the example of an autonomous system: Idea: Additional consideration of f y (y k ) in the order conditions k i = h f(y k + y k+1 = y k + s j=1 s j=1 b j k j. a ij k j ) + h f y (y k ) s j=1 ā ij k j, 1 i s, Embedded Rosenbrock methods of type (3,4) with step size control: GRK4T [Kaps/Rentrop (1979)]

23 W methods [Wolfbrandt/Wanner] where A := f y (y k ). k i = f(y k + h i 1 j=1 y k+1 = y k + h s b j k j, j=1 a ij k j ) + h A i 1 j=1 ā ij k j + h A γ k i, 1 i s, Interpretation as an SDIRK method with only one Newton iteration (close relationship with semi-implicit Runge-Kutta methods)

24 4.4 Multi-step methods for stiff systems of differential equations Linear stability theory Consider the linear m-step method (LMSV) with the characteristic polynomials ρ(z) = m k=0 m k=0 α k y j+k = h m k=0 α k z k, σ(z) = m β k f(x j+k,y j+k ) k=0 β k z k. Application to the scalar test equation y (x) = λ y(x), x > 0, y(0) = 1 results in (set z := λh C): m k=0 (α k β k z) y j+k = 0. The ansatz y l = z l leads to characteristic equation ρ(z) z σ(z) = 0.

25 Lemma 4.12 Stability region of linear multi-step methods Assume that ξ i = ξ i (z), 1 i m, are the roots of the characteristic equation (CG). Then, the stability region of (LMSV), applied to the scalar test equation, is given by G = { z C ξ i (z) 1, 1 i m, and ξ i (z) simple, if ξ i (z) = 1 }. Definition 4.13 Root locus Parameterizing G according to the resulting curve is called root locus. Remark 4.14 Stability region and root locus ξ = 1 ξ = exp(iϕ), ϕ [0,2π), Γ := { z C z = ρ(exp(iϕ)) σ(exp(iϕ)), ϕ [0,2π) } Since G only contains simple roots, there holds G Γ.

26 Study of A-stability Example 4.15 Explicit midpoint rule y k+2 = y k + 2 h λ y k+1 = y k + 2 z y k+1 = ρ(ξ) = ξ 2 1, σ(ξ) = 2 ξ = characteristic equation: ξ 2 2 z ξ 1 = 0 = ξ 1,2 = z ± 1 + z 2. The root locus is given as follows: z = ρ(exp(iϕ)) σ(exp(iϕ)) = exp(2iϕ) 1 2 exp(iϕ) = 1 2 [ exp(iϕ) exp( iϕ) ] = i sinϕ = Γ = { z C z = iτ, τ [ 1, +1] }. Multiple roots: Stability region: ξ 1 = ξ z 2 = 0 z = ± i. G = G = { z C z = iτ, τ ( 1, +1) }. Since C / G = no A-stability.

27 Theorem 4.16 Second Dahlquist barrier [Dahlquist (1963)] A consistent, A-stable linear multi-step method necessarily is implicit and has an order of consistency p 2 with normalized error constant C := C/σ(1) The implicit trapezoidal rule is the only A-stable method with p = 2, C = 1 12 and α m = BDF methods Stability properties: m k=1 1 k k y j+m = h f(x j+m,y j+m ), 0 j N m. (i) A-stability for m = 1, 2 (m = 1 : implicit Euler) (ii) A(α)-stability for 3 m 6 (iii) Instability for m 6. m α 86 o 76 o 50 o 16 o

28 4.5 Semi-implicit extrapolation methods Implicit Euler method (h-extrapolation) ( ) y k+1 = y k + h f(x k+1,y k+1 ), k 0, y 0 = α. ( ) requires the solution of a nonlinear system of equations: F(y k+1 ) = y k+1 y k h f(x k+1,y k+1 ). Newton s method: F (y k+1) (i) = I h f y (x k+1,y (i) k+1) }{{} Given y (0) k+1, for i = 0,1,2,... compute: =:A i, A i = f 1 y 1 (x k+1,y (i) f 1 y (x k+1,y (i) d k+1) k+1) f d y 1 (x k+1,y k+1) (i) (I h A i ) y (i) k+1 = (y (i) k+1 y k h f(x k+1,y k+1) (i), y (i+1) k+1 = y (i) k+1 + y (i) k+1. f d y (x k+1,y (i) d k+1).

29 Idea [Deuflhard (1985)]: Implementation of only one Newton iteration with y (0) k+1 = y k = Semi-implicit Euler method: where A := f y (x k+1,y k ). (I h A) y k = h f(x k+1,y k ), y k+1 = y k + y k, Order and step size control as for the explicit Euler method using the following modification of the sequence for the work units: A 1 = C J + C LR + n 1 (C Subst + C f ), A i = A i 1 + C J + C LR + n i C Subst + (n i 1) C f C J : Evaluation of the Jacobi matrix A := f y (x k+1,y k ) C LR : LR decomposition of I h i A C Subst : Forward and backward substitution in Gauss elimination C f : Evaluation of the right-hand side Code: EULSIM

30 4.5.2 Semi-implicit midpoint rule (h 2 -extrapolation) ([Bader/Deuflhard (1983)]) y A y = f(x,y) A y mit A := f y (x,y), 1 2h (y k+1 y k ) 1 2 A (y k+1 + y k ) = f(x k,y k ) A y k. Initial step: Semi-implicit Euler method Loop: For 1 k l compute Bader s final step: Instead of y l use Code: METAN (I h A) y 0 = h f(y 0 ), y 1 = y 0 + y 0. (I h A) y k+1 = (I + h A) y k h [f(x k,y k ) A y k ]. ŷ l := 1 2 (y l+1 + y l 1 ).

31 4.6 Differential-algebraic equations Linear implicit systems Definition 4.17 Linear implicit system Let A,B lr d d, f : I lr d, I := [a,b] lr, and α lr d. Then, A y (x) = B y(x) + f(x), x I, y(a) = α is called an initial value problem for a linear system of first order ordinary differential equations in implicit form. We distinguish the following cases: (i) A is regular Reduction to a linear system of first order ordinary differential equations in explicit form y (x) = A 1 B y(x) + A 1 f(x), x I. (ii) A is singular, B is regular Multiplication by B 1 gives ( ) B 1 A y (x) = y(x) + B 1 f(x), x I.

32 Let J be the Jordan normal form of the singular matrix B 1 A, i.e., B 1 A = T R 0 0 N T 1 with a non singular matrix T lr d d, where R corresponds to the non zero eigenvalues of A and N to the eigenvalues 0 of A. N is nilpotent. Assume that N is nilpotent of index k d, i.e., N k = 0. Using the similarity transformation T, the system ( ) is transformed to R 0 0 N T 1 y (x) }{{} = u (x) w (x) = T 1 y(x) }{{} = u(x) w(x) Setting T 1 α = (uα,wα) T, we obtain the decoupled system: + T 1 B 1 f(x) }{{} = r(x) s(x) ( ) 1 R u (x) = u(x) + r(x), x I, u(a) = uα, ( ) 2 N w (x) = w(x) + s(x), x I, w(a) = wα..

33 We study the solution of the system ( ) 1 R u (x) = u(x) + r(x), x I, u(a) = uα, ( ) 2 N w (x) = w(x) + s(x), x I, w(a) = wα. The initial value problem ( ) 1 has a unique solution. The solution of the initial value problem ( ) 2 is subject to restrictions: Definition 4.18 Index of a matrix Let C lr d d. Then, k := min { l ln 0 rank C l = rank C l+1 } is called the index of the matrix C and is denoted by Ind C. Lemma 4.19 Nilpotent matrices and index If N is nilpotent of index k, there holds Ind (B 1 A) = k.

34 We consider the initial value problem ( ) 2 N w (x) = w(x) + s(x), x I, w(a) = wα. Under the assumption s C k 1 (I), by differentiation it follows that w(x) = s(x) + N w (x) w (x) = s (x) + N w = w(x) = s(x) N s (x) + N 2 w (x) (x) w (x) = s (x) + N w (x) = Hence, we obtain w(x) = s(x) N s (x) N 2 s (x) + N 3 w (x), = w(x) = k 1 N j s (j) (x) + N k w (k) (x). }{{} j=0 =0 w a := w(a) = k 1 Definition 4.20 Consistency of initial data j=0 N j s (j) (a). The initial data α lr d is said to be consistent, if w a = k 1 j=0 Nj s (j) (a).

35 Remark 4.21 Non differentiable components of the solution The derivation of the consistency condition does not require the differentiability of all components of w. In view of for instance, the first component of w is not effected by the computation of Nw, N 2 w etc. Indeed, it may occur that there are non differentiable components of the solution.,

36 (iii) A and B are arbitrary matrices Application of regular matrix bundles (cf. [Gantmacher]): If det (λb A) 0, the linear-implicit system is equivalent to (λ B A) 1 B }{{} =:ˆB y = (λ B A) 1 A }{{} =:Â y + (λ B A) 1 f} } {{ } =:ˆf Characterization of the solution by Drazin s inverse ˆB D of ˆB (cf. [Wilkinson (1982)]). As in case (ii), a regularity condition on f and consistency of the initial data are required.

37 4.6.2 Index of implicit systems of ordinary differential equations Definition 4.22 Implicit system of first order ordinary differential equations Assume that F : D 1 D 2 I lr d, D i lr d, I := [a,b]n lr, and α lr d. Then, ( ) F(y (x),y(x),x) = 0, x I, y(a) = α is called an initial value problem for an implicit system of first order ordinary differential equations. Definition 4.23 Index of an implicit system [Gear (1988)] Consider the system obtained by differentiation of ( ): ( ) F(y,y,x) = 0, d dx F(y,y,x) = F y + F y y y + F x = 0,, d µ dx µ F(y,y,x) = F y (µ+1) +... = 0. y The smallest number µ ln 0, for which ( ) can be solved for y explicitly, is called the index of ( ) and is denoted by ν.

38 Definition 4.24 Consistency of the initial data Assume that ( ) is of index ν Then, the initial data y a are called consistent, if F(y,y,x) y=y(a),x=a = 0, =, d ν dx ν F(y,y,x) y=y(a),x=a = 0 Remark 4.25 Special case of linear implicit systems For linear implicit systems and regular A, we have that ν = Ind(A 1 B). Definition 4.26 Differential-algebraic system Assume that I := [a,b] lr and D i lr d, 1 i 3, as well as F 1 : D 1 D 2 D 3 I lr d, F 2 : D 2 D 3 I lr d. Then, ( ) 1 F 1 (y (x),y(x),z(x),x) = 0, x I, ( ) 2 F 2 (y(x),z(x),x) = 0, x I is called a semi-implicit system of first order ordinary differential equations in separated form. The characteristic feature is an a priori separation into the differential variable y and the algebraic variable z. Therefore, it is also referred to as an differential-algebraic system.

39 Computation of the index of differential-algebraic systems Idea: Differentiation of the algebraic part F 2. Example 4.27 Systems of index 1 ( ) 1 y = f(y,z), ( ) 2 0 = g(y,z). Assumption: g/ z has a bounded inverse in a neighborhood of the solution. Differentiation of ( ) 2 yields 0 = g y y z + g z z = = ( g g ) 1 z y y = ( g g ) 1 z y f(y,z) = ( ) 1, ( ) 2 is of index 1. The initial data (y(a),z(a)) T are consistent, if g(y(a),z(a)) = 0.

40 Example 4.28 Systems of index 2 ( ) 1 y = f(y,z), ( ) 2 0 = g(y). Assumption: g f y z has a bounded inverse in a neighborhood of the solution. Differentiation of ( ) 2 results in ( ) 3 0 = g y y = g y f(y,z) The system ( ) 1, ( ) 3 is of index 1. Consequently, ( ) 1, ( ) 2 is of index 2. The initial data (y(a),z(a)) T are consistent, if g(y(a)) = 0, y (g(y) f(y,z)) y=y(a),z=z(a) = 0.

41 Example 4.29 Systems of index 3 Assumption: g y f z k u Differentiating in ( ) 3 twice, we obtain ( ) 4 0 = g y f(y,z), ( ) 1 y = f(y,z), ( ) 2 z = k(y,z,u), ( ) 3 0 = g(y). has a bounded inverse in a neighborhood of the solution. ( ) 5 0 = 2 g y 2 f(y,z)t f(y,z) + g y [ f f f(y,z) + y z k(y,z,u)] The system ( ) 1, ( ) 2, ( 5) is of index 1. Consequently, ( ) 1, ( ) 2, ) 3 is of index 3. The initial data (y(a),z(a),u(a)) T are consistent, if g(y(a)) = 0, g y f(y,z)) y=y(a),z=z(a) = 0, 2 g y 2 ft f + g y [ f y f + f z k] y=y(a),z=z(a),u=u(a) = 0.

42 4.6.3 Adaptation of stiff integrators (i) BDF-Verfahren [Gear (1971), Petzold (1981)] Idea: Replace y (x j+m ) by the backward difference quotient D m y j+m := 1 h m k=0 α k y j+k and, given an iterate y (0) j+m, solve the nonlinear system F(D m y j+m,y j+m,x j+m ) = 0, 0 j N m by a Newton or Newton-like method. Codes: LSODE [Hindmarsh (1980)] DASSL [Petzold (1981)]

43 (ii) Semi-implicit extrapolation methods [Deuflhard/Hairer/Zugck (1987)] Application of the semi-implicit Euler discretization to quasi-linear ordinary differential equations of index 1 Construction: ( ) B(y) y = f(y). B(y k+1 ) (y k+1 y k ) = h f(y k+1 ) B(y k+1 ) =. B(y k ) + B y (y k ) (y k+1 y k ) }{{} f(y k+1 ) h B y (y) y y(a) =. f(y k ) + f y (y k ) (y k+1 y k ) }{{} f y (y) y(a) [ B(y k ) h A ] (y k+1 y k ) = h f(y k ), where A := y [ f(y) B(y) y ] y(a). If y (a) is not known: Set A a := f y (y(a)) and compute y (a) later by extrapolation from h 1 (y l y l 1 ), l = n 1,n 2,... =

44 Special case: Semi-explicit ordinary differential equation of index 1 ( ) 1 y = f(y,z), ( ) 2 0 = g(y,z). Idea: Application of the semi-implicit Euler discretization to the singularly perturbed system ( ) 1 y = f(y,z), ( ) 2 ε z = g(y,z) and setting ε = 0 afterwards. Code: LIMEX [Deuflhard/Nowak (1985)]

45 (iii) Implicit Runge-Kutta methods We restrict ourselves to Fehlberg -type methods, i.e., a sj = b j, 1 j s. α) Application to semi-explicit systems of index 1: Y i = y(a) + h s (i) a ij f(y j,z j ), 1 i s, j=1 g(y i,z i ) = 0, 1 i s, (ii) y 1 := Y s, z 1 := Z s. β) Application to quasi-linear systems (i) Y i = y(a) + h s a ij U j, 1 i s, j=1 (ii) B(Y i ) U i = f(y i ), 1 i s. Since A := (a ij ) s i,j=1 is invertible, elimination of U i from (ii) by (i). Pay attention to Newton solution of the nonlinear system (ii). Code: RADAU5 [Hairer/Wanner (1988)]

46 4.7 Differential-algebraic systems in device simulation Fundamental electric devices R C U U am Resistor, capacity, amplifier U + A linear resistor R between two knots is characterized by a linear relationship between the currents and the voltages according to R = U/I. For a linear capacity C between two knots we have C = Q/U, I = dq/dt = C du/dt, i.e., there is a linear relationship between the charges and the voltages. An amplifier amplifies an input signal U + U according to U am = A (U + U ).

47 4.7.2 Kirchhoff s laws for electric networks 1. Junction rule In a junction with a total of n entering resp. leaving currents, the sum of all currents is zero: n k=1 I k = Closed loop rule Along a closed loop with m elements, the sum of the voltages is zero: m k=1 U m = 0.

48 4.7.3 Double amplifier Kirchhoff s laws in the knots 1 4 yield U in R C 1 R 1 C 2 2 I 1 U = 0 0 Double amplifier I 2 C 1 ( U 1 U in ) + 1 R 1 (U 1 U 2 ) = 0, 1 R 1 (U 2 U 1 ) + C 2 ( U 2 U 3 ) I 1 = 0, C 2 ( U 3 U 2 ) + 1 R 2 (U 3 U 4 ) = 0, 1 R 2 (U 4 U 3 ) I 2 = 0. This has to be completed by the two equations: U 2 = A (U 1 U 0 ), U 4 = A (U 3 U 0 ).

49 The equations result in the differential-algebraic system: C Ẋ + B X = f, X := (U 1,U 2,U 3,U 4,I 1,I 2 ) T, f := (C 1 U in,0,0,0,0,0) T, where C = C C 2 C C 2 C , B = R 1 R 1 1 R R R 2 1 R R 2 R A A

50 The differential index is given by Ind(B 1 C). For Ĉ := B 1 C we obtain Ĉ = C 1R 1 A C 1AR 1 A C 2 R 2 A 1 C 2R 2 A C 2 AR 2 A 1 C 2AR 2 A C 1 C 2 C C 2 C , Ĉ 2 = ( C 1R 1 A 1 ) ( C 1AR 1 A 1 )2 A C 1C 2 AR 1 R 2 (A 1) 2 ( C 2R 2 A 1 )2 ( C 2R 2 A 1 ) C 1C 2 A 2 R 1 R 2 (A 1) 2 ( C 2R 2 A 1 )2 A ( C 2R 2 A 1 )2 A C 2 1 R 1+C 1 C 2 AR 1 A 1 C 1C 2 AR 1 A 1 C 2R 2 A 1 C 2 C 2 R 2 A 1 C 2 C 2R 2 A 1 C C 2 R 2 A 1 C Since Ker Ĉ = Ker Ĉ 2, we get Ind Ĉ = 1.

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

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

Exam in TMA4215 December 7th 2012

Exam in TMA4215 December 7th 2012 Norwegian University of Science and Technology Department of Mathematical Sciences Page of 9 Contact during the exam: Elena Celledoni, tlf. 7359354, cell phone 48238584 Exam in TMA425 December 7th 22 Allowed

More information

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005 3 Numerical Solution of Nonlinear Equations and Systems 3.1 Fixed point iteration Reamrk 3.1 Problem Given a function F : lr n lr n, compute x lr n such that ( ) F(x ) = 0. In this chapter, we consider

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

Explicit One-Step Methods

Explicit One-Step Methods Chapter 1 Explicit One-Step Methods Remark 11 Contents This class presents methods for the numerical solution of explicit systems of initial value problems for ordinary differential equations of first

More information

Implicit-explicit exponential integrators

Implicit-explicit exponential integrators Implicit-explicit exponential integrators Bawfeh Kingsley Kometa joint work with Elena Celledoni MaGIC 2011 Finse, March 1-4 1 Introduction Motivation 2 semi-lagrangian Runge-Kutta exponential integrators

More information

Parallel Methods for ODEs

Parallel Methods for ODEs Parallel Methods for ODEs Levels of parallelism There are a number of levels of parallelism that are possible within a program to numerically solve ODEs. An obvious place to start is with manual code restructuring

More information

Advanced methods for ODEs and DAEs. Lecture 9: Multistep methods/ Differential algebraic equations

Advanced methods for ODEs and DAEs. Lecture 9: Multistep methods/ Differential algebraic equations Advanced methods for ODEs and DAEs Lecture 9: Multistep methods/ Differential algebraic equations Bojana Rosic, 22. Juni 2016 PART I: MULTISTEP METHODS 22. Juni 2016 Bojana Rosić Advanced methods for ODEs

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 9 Initial Value Problems for Ordinary Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign

More information

Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot. Department U2IS ENSTA ParisTech SCAN Uppsala

Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot. Department U2IS ENSTA ParisTech SCAN Uppsala Runge-Kutta Theory and Constraint Programming Julien Alexandre dit Sandretto Alexandre Chapoutot Department U2IS ENSTA ParisTech SCAN 2016 - Uppsala Contents Numerical integration Runge-Kutta with interval

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

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

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

Advanced methods for ODEs and DAEs

Advanced methods for ODEs and DAEs Advanced methods for ODEs and DAEs Lecture 8: Dirk and Rosenbrock Wanner methods Bojana Rosic, 14 Juni 2016 General implicit Runge Kutta method Runge Kutta method is presented by Butcher table: c1 a11

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

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

Introduction to the Numerical Solution of IVP for ODE

Introduction to the Numerical Solution of IVP for ODE Introduction to the Numerical Solution of IVP for ODE 45 Introduction to the Numerical Solution of IVP for ODE Consider the IVP: DE x = f(t, x), IC x(a) = x a. For simplicity, we will assume here that

More information

Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3

Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3 Improved Starting Methods for Two-Step Runge Kutta Methods of Stage-Order p 3 J.H. Verner August 3, 2004 Abstract. In [5], Jackiewicz and Verner derived formulas for, and tested the implementation of two-step

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations CHAPTER 5 Numerical Methods for Differential Equations In this chapter we will discuss a few of the many numerical methods which can be used to solve initial value problems and one-dimensional boundary

More information

8.1 Introduction. Consider the initial value problem (IVP):

8.1 Introduction. Consider the initial value problem (IVP): 8.1 Introduction Consider the initial value problem (IVP): y dy dt = f(t, y), y(t 0)=y 0, t 0 t T. Geometrically: solutions are a one parameter family of curves y = y(t) in(t, y)-plane. Assume solution

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 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

Efficient numerical methods for the solution of stiff initial-value problems and differential algebraic equations

Efficient numerical methods for the solution of stiff initial-value problems and differential algebraic equations 10.1098/rspa.2003.1130 R EVIEW PAPER Efficient numerical methods for the solution of stiff initial-value problems and differential algebraic equations By J. R. Cash Department of Mathematics, Imperial

More information

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005 4 Interpolation 4.1 Polynomial interpolation Problem: LetP n (I), n ln, I := [a,b] lr, be the linear space of polynomials of degree n on I, P n (I) := { p n : I lr p n (x) = n i=0 a i x i, a i lr, 0 i

More information

16. Local theory of regular singular points and applications

16. Local theory of regular singular points and applications 16. Local theory of regular singular points and applications 265 16. Local theory of regular singular points and applications In this section we consider linear systems defined by the germs of meromorphic

More information

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

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

More information

Numerical solution of stiff ODEs using second derivative general linear methods

Numerical solution of stiff ODEs using second derivative general linear methods Numerical solution of stiff ODEs using second derivative general linear methods A. Abdi and G. Hojjati University of Tabriz, Tabriz, Iran SciCADE 2011, Toronto 0 5 10 15 20 25 30 35 40 1 Contents 1 Introduction

More information

Chapter 5 Exercises. (a) Determine the best possible Lipschitz constant for this function over 2 u <. u (t) = log(u(t)), u(0) = 2.

Chapter 5 Exercises. (a) Determine the best possible Lipschitz constant for this function over 2 u <. u (t) = log(u(t)), u(0) = 2. Chapter 5 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rjl/fdmbook Exercise 5. (Uniqueness for

More information

MATH 205C: STATIONARY PHASE LEMMA

MATH 205C: STATIONARY PHASE LEMMA MATH 205C: STATIONARY PHASE LEMMA For ω, consider an integral of the form I(ω) = e iωf(x) u(x) dx, where u Cc (R n ) complex valued, with support in a compact set K, and f C (R n ) real valued. Thus, I(ω)

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

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

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

ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA

ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA ALGEBRA QUALIFYING EXAM PROBLEMS LINEAR ALGEBRA Kent State University Department of Mathematical Sciences Compiled and Maintained by Donald L. White Version: August 29, 2017 CONTENTS LINEAR ALGEBRA AND

More information

Advanced methods for ODEs and DAEs

Advanced methods for ODEs and DAEs Advanced methods for ODEs and DAEs Lecture 13: Overview Bojana Rosic, 13. Juli 2016 Dynamical system is a system that evolves over time possibly under external excitations: river flow, car, etc. The dynamics

More information

Mathematics for chemical engineers. Numerical solution of ordinary differential equations

Mathematics for chemical engineers. Numerical solution of ordinary differential equations Mathematics for chemical engineers Drahoslava Janovská Numerical solution of ordinary differential equations Initial value problem Winter Semester 2015-2016 Outline 1 Introduction 2 One step methods Euler

More information

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0 Numerical Analysis 1 1. Nonlinear Equations This lecture note excerpted parts from Michael Heath and Max Gunzburger. Given function f, we seek value x for which where f : D R n R n is nonlinear. f(x) =

More information

CS 257: Numerical Methods

CS 257: Numerical Methods CS 57: Numerical Methods Final Exam Study Guide Version 1.00 Created by Charles Feng http://www.fenguin.net CS 57: Numerical Methods Final Exam Study Guide 1 Contents 1 Introductory Matter 3 1.1 Calculus

More information

forms Christopher Engström November 14, 2014 MAA704: Matrix factorization and canonical forms Matrix properties Matrix factorization Canonical forms

forms Christopher Engström November 14, 2014 MAA704: Matrix factorization and canonical forms Matrix properties Matrix factorization Canonical forms Christopher Engström November 14, 2014 Hermitian LU QR echelon Contents of todays lecture Some interesting / useful / important of matrices Hermitian LU QR echelon Rewriting a as a product of several matrices.

More information

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING C. Pozrikidis University of California, San Diego New York Oxford OXFORD UNIVERSITY PRESS 1998 CONTENTS Preface ix Pseudocode Language Commands xi 1 Numerical

More information

Modified Defect Correction Algorithms for ODEs. Part II: Stiff Initial Value Problems

Modified Defect Correction Algorithms for ODEs. Part II: Stiff Initial Value Problems Modified Defect Correction Algorithms for ODEs. Part II: Stiff Initial Value Problems Winfried Auzinger Harald Hofstätter Wolfgang Kreuzer Ewa Weinmüller to appear in Numerical Algorithms ANUM Preprint

More information

2 Two-Point Boundary Value Problems

2 Two-Point Boundary Value Problems 2 Two-Point Boundary Value Problems Another fundamental equation, in addition to the heat eq. and the wave eq., is Poisson s equation: n j=1 2 u x 2 j The unknown is the function u = u(x 1, x 2,..., x

More information

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS ERNST HAIRER AND PIERRE LEONE Abstract. We prove that to every rational function R(z) satisfying R( z)r(z) = 1, there exists a symplectic Runge-Kutta method

More information

Zeros and zero dynamics

Zeros and zero dynamics CHAPTER 4 Zeros and zero dynamics 41 Zero dynamics for SISO systems Consider a linear system defined by a strictly proper scalar transfer function that does not have any common zero and pole: g(s) =α p(s)

More information

1 Ordinary differential equations

1 Ordinary differential equations Numerical Analysis Seminar Frühjahrssemester 08 Lecturers: Prof. M. Torrilhon, Prof. D. Kressner The Störmer-Verlet method F. Crivelli (flcrivel@student.ethz.ch May 8, 2008 Introduction During this talk

More information

Nonlinear Programming Algorithms Handout

Nonlinear Programming Algorithms Handout Nonlinear Programming Algorithms Handout Michael C. Ferris Computer Sciences Department University of Wisconsin Madison, Wisconsin 5376 September 9 1 Eigenvalues The eigenvalues of a matrix A C n n are

More information

Numerical Differential Equations. An Undergraduate Course. Ronald H.W. Hoppe

Numerical Differential Equations. An Undergraduate Course. Ronald H.W. Hoppe Numerical Differential Equations An Undergraduate Course Ronald H.W. Hoppe Contents 1. Ordinary Differential Equations 1 1.1 Initial-value Problems: Theoretical foundations and preliminaries 1 1.1.1 Basic

More information

Numerical Differential Equations: IVP

Numerical Differential Equations: IVP Chapter 11 Numerical Differential Equations: IVP **** 4/16/13 EC (Incomplete) 11.1 Initial Value Problem for Ordinary Differential Equations We consider the problem of numerically solving a differential

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

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS BIT 0006-3835/00/4004-0726 $15.00 2000, Vol. 40, No. 4, pp. 726 734 c Swets & Zeitlinger SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS E. HAIRER Section de mathématiques, Université

More information

Numerical Integration of Equations of Motion

Numerical Integration of Equations of Motion GraSMech course 2009-2010 Computer-aided analysis of rigid and flexible multibody systems Numerical Integration of Equations of Motion Prof. Olivier Verlinden (FPMs) Olivier.Verlinden@fpms.ac.be Prof.

More information

First order Partial Differential equations

First order Partial Differential equations First order Partial Differential equations 0.1 Introduction Definition 0.1.1 A Partial Deferential equation is called linear if the dependent variable and all its derivatives have degree one and not multiple

More information

Numerical Methods for Differential Equations Mathematical and Computational Tools

Numerical Methods for Differential Equations Mathematical and Computational Tools Numerical Methods for Differential Equations Mathematical and Computational Tools Gustaf Söderlind Numerical Analysis, Lund University Contents V4.16 Part 1. Vector norms, matrix norms and logarithmic

More information

NATIONAL UNIVERSITY OF SINGAPORE DEPARTMENT OF MATHEMATICS SEMESTER 2 EXAMINATION, AY 2010/2011. Linear Algebra II. May 2011 Time allowed :

NATIONAL UNIVERSITY OF SINGAPORE DEPARTMENT OF MATHEMATICS SEMESTER 2 EXAMINATION, AY 2010/2011. Linear Algebra II. May 2011 Time allowed : NATIONAL UNIVERSITY OF SINGAPORE DEPARTMENT OF MATHEMATICS SEMESTER 2 EXAMINATION, AY 2010/2011 Linear Algebra II May 2011 Time allowed : 2 hours INSTRUCTIONS TO CANDIDATES 1. This examination paper contains

More information

Math 411 Preliminaries

Math 411 Preliminaries Math 411 Preliminaries Provide a list of preliminary vocabulary and concepts Preliminary Basic Netwon's method, Taylor series expansion (for single and multiple variables), Eigenvalue, Eigenvector, Vector

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

More information

LINEAR ALGEBRA: NUMERICAL METHODS. Version: August 12,

LINEAR ALGEBRA: NUMERICAL METHODS. Version: August 12, LINEAR ALGEBRA: NUMERICAL METHODS. Version: August 12, 2000 74 6 Summary Here we summarize the most important information about theoretical and numerical linear algebra. MORALS OF THE STORY: I. Theoretically

More information

Ordinary Differential Equations

Ordinary Differential Equations Chapter 13 Ordinary Differential Equations We motivated the problem of interpolation in Chapter 11 by transitioning from analzying to finding functions. That is, in problems like interpolation and regression,

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

G1110 & 852G1 Numerical Linear Algebra

G1110 & 852G1 Numerical Linear Algebra The University of Sussex Department of Mathematics G & 85G Numerical Linear Algebra Lecture Notes Autumn Term Kerstin Hesse (w aw S w a w w (w aw H(wa = (w aw + w Figure : Geometric explanation of the

More information

CHAPTER 7. An Introduction to Numerical Methods for. Linear and Nonlinear ODE s

CHAPTER 7. An Introduction to Numerical Methods for. Linear and Nonlinear ODE s A SERIES OF CLASS NOTES FOR 2005-2006 TO INTRODUCE LINEAR AND NONLINEAR PROBLEMS TO ENGINEERS, SCIENTISTS, AND APPLIED MATHEMATICIANS DE CLASS NOTES 1 A COLLECTION OF HANDOUTS ON FIRST ORDER ORDINARY DIFFERENTIAL

More information

Lecture Notes 6: Dynamic Equations Part C: Linear Difference Equation Systems

Lecture Notes 6: Dynamic Equations Part C: Linear Difference Equation Systems University of Warwick, EC9A0 Maths for Economists Peter J. Hammond 1 of 45 Lecture Notes 6: Dynamic Equations Part C: Linear Difference Equation Systems Peter J. Hammond latest revision 2017 September

More information

Solving Ordinary Differential equations

Solving Ordinary Differential equations Solving Ordinary Differential equations Taylor methods can be used to build explicit methods with higher order of convergence than Euler s method. The main difficult of these methods is the computation

More information

Quadratic SDIRK pair for treating chemical reaction problems.

Quadratic SDIRK pair for treating chemical reaction problems. Quadratic SDIRK pair for treating chemical reaction problems. Ch. Tsitouras TEI of Chalkis, Dept. of Applied Sciences, GR 34400 Psahna, Greece. I. Th. Famelis TEI of Athens, Dept. of Mathematics, GR 12210

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

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

The matrix sign function

The matrix sign function The matrix sign function 1 Re x > 0, sign(x) = 1 Re x < 0, undefined Re x = 0. Suppose the Jordan form of A is reblocked as A = [ V 1 V 2 ] [ J 1 J 2 ] [ V 1 V 2 ] 1, where J 1 contains all eigenvalues

More information

Numerical Analysis Comprehensive Exam Questions

Numerical Analysis Comprehensive Exam Questions Numerical Analysis Comprehensive Exam Questions 1. Let f(x) = (x α) m g(x) where m is an integer and g(x) C (R), g(α). Write down the Newton s method for finding the root α of f(x), and study the order

More information

Stability of generalized Runge Kutta methods for stiff kinetics coupled differential equations

Stability of generalized Runge Kutta methods for stiff kinetics coupled differential equations INSTITUTE OF PHYSICS PUBLISHING JOURNAL OF PHYSICS A: MATHEMATICAL AND GENERAL J Phys A: Math Gen 39 (2006) 859 876 doi:0088/0305-4470/39/8/006 Stability of generalized Runge Kutta methods for stiff kinetics

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

Matrix Theory. A.Holst, V.Ufnarovski

Matrix Theory. A.Holst, V.Ufnarovski Matrix Theory AHolst, VUfnarovski 55 HINTS AND ANSWERS 9 55 Hints and answers There are two different approaches In the first one write A as a block of rows and note that in B = E ij A all rows different

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

Efficient Simulation of Physical System Models Using Inlined Implicit Runge Kutta Algorithms

Efficient Simulation of Physical System Models Using Inlined Implicit Runge Kutta Algorithms Efficient Simulation of Physical System Models Using Inlined Implicit Runge Kutta Algorithms by Vicha Treeaporn A Thesis Submitted to the Faculty of the Department of Electrical and Computer Engineering

More information

Solutions Preliminary Examination in Numerical Analysis January, 2017

Solutions Preliminary Examination in Numerical Analysis January, 2017 Solutions Preliminary Examination in Numerical Analysis January, 07 Root Finding The roots are -,0, a) First consider x 0 > Let x n+ = + ε and x n = + δ with δ > 0 The iteration gives 0 < ε δ < 3, which

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Jordan Canonical Form

Jordan Canonical Form Jordan Canonical Form Massoud Malek Jordan normal form or Jordan canonical form (named in honor of Camille Jordan) shows that by changing the basis, a given square matrix M can be transformed into a certain

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS

MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS MATH 425-Spring 2010 HOMEWORK ASSIGNMENTS Instructor: Shmuel Friedland Department of Mathematics, Statistics and Computer Science email: friedlan@uic.edu Last update April 18, 2010 1 HOMEWORK ASSIGNMENT

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

Ordinary Differential Equation Theory

Ordinary Differential Equation Theory Part I Ordinary Differential Equation Theory 1 Introductory Theory An n th order ODE for y = y(t) has the form Usually it can be written F (t, y, y,.., y (n) ) = y (n) = f(t, y, y,.., y (n 1) ) (Implicit

More information

Linear Algebra Practice Problems

Linear Algebra Practice Problems Linear Algebra Practice Problems Math 24 Calculus III Summer 25, Session II. Determine whether the given set is a vector space. If not, give at least one axiom that is not satisfied. Unless otherwise stated,

More information

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T

The goal of this chapter is to study linear systems of ordinary differential equations: dt,..., dx ) T 1 1 Linear Systems The goal of this chapter is to study linear systems of ordinary differential equations: ẋ = Ax, x(0) = x 0, (1) where x R n, A is an n n matrix and ẋ = dx ( dt = dx1 dt,..., dx ) T n.

More information

27. Topological classification of complex linear foliations

27. Topological classification of complex linear foliations 27. Topological classification of complex linear foliations 545 H. Find the expression of the corresponding element [Γ ε ] H 1 (L ε, Z) through [Γ 1 ε], [Γ 2 ε], [δ ε ]. Problem 26.24. Prove that for any

More information

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1 Chapter 01.01 Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 Chapter 01.02 Measuring errors 11 True error 11 Relative

More information

Applied Math for Engineers

Applied Math for Engineers Applied Math for Engineers Ming Zhong Lecture 15 March 28, 2018 Ming Zhong (JHU) AMS Spring 2018 1 / 28 Recap Table of Contents 1 Recap 2 Numerical ODEs: Single Step Methods 3 Multistep Methods 4 Method

More information

Lecture 6: Contraction mapping, inverse and implicit function theorems

Lecture 6: Contraction mapping, inverse and implicit function theorems Lecture 6: Contraction mapping, inverse and implicit function theorems 1 The contraction mapping theorem De nition 11 Let X be a metric space, with metric d If f : X! X and if there is a number 2 (0; 1)

More information

The Definition and Numerical Method of Final Value Problem and Arbitrary Value Problem Shixiong Wang 1*, Jianhua He 1, Chen Wang 2, Xitong Li 1

The Definition and Numerical Method of Final Value Problem and Arbitrary Value Problem Shixiong Wang 1*, Jianhua He 1, Chen Wang 2, Xitong Li 1 The Definition and Numerical Method of Final Value Problem and Arbitrary Value Problem Shixiong Wang 1*, Jianhua He 1, Chen Wang 2, Xitong Li 1 1 School of Electronics and Information, Northwestern Polytechnical

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2017/18 Part 2: Direct Methods PD Dr.

More information

you expect to encounter difficulties when trying to solve A x = b? 4. A composite quadrature rule has error associated with it in the following form

you expect to encounter difficulties when trying to solve A x = b? 4. A composite quadrature rule has error associated with it in the following form Qualifying exam for numerical analysis (Spring 2017) Show your work for full credit. If you are unable to solve some part, attempt the subsequent parts. 1. Consider the following finite difference: f (0)

More information

Course Summary Math 211

Course Summary Math 211 Course Summary Math 211 table of contents I. Functions of several variables. II. R n. III. Derivatives. IV. Taylor s Theorem. V. Differential Geometry. VI. Applications. 1. Best affine approximations.

More information

The Initial Value Problem for Ordinary Differential Equations

The Initial Value Problem for Ordinary Differential Equations Chapter 5 The Initial Value Problem for Ordinary Differential Equations In this chapter we begin a study of time-dependent differential equations, beginning with the initial value problem (IVP) for a time-dependent

More information

ON THE IMPLEMENTATION OF SINGLY IMPLICIT RUNGE-KUTTA METHODS

ON THE IMPLEMENTATION OF SINGLY IMPLICIT RUNGE-KUTTA METHODS MATHEMATICS OF COMPUTATION VOLUME 57, NUMBER 196 OCTOBER 1991, PAGES 663-672 ON THE IMPLEMENTATION OF SINGLY IMPLICIT RUNGE-KUTTA METHODS G. J. COOPER Abstract. A modified Newton method is often used to

More information

DEN: Linear algebra numerical view (GEM: Gauss elimination method for reducing a full rank matrix to upper-triangular

DEN: Linear algebra numerical view (GEM: Gauss elimination method for reducing a full rank matrix to upper-triangular form) Given: matrix C = (c i,j ) n,m i,j=1 ODE and num math: Linear algebra (N) [lectures] c phabala 2016 DEN: Linear algebra numerical view (GEM: Gauss elimination method for reducing a full rank matrix

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 29 Almost Done! No

More information

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

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

More information

Optimal Implicit Strong Stability Preserving Runge Kutta Methods

Optimal Implicit Strong Stability Preserving Runge Kutta Methods Optimal Implicit Strong Stability Preserving Runge Kutta Methods David I. Ketcheson, Colin B. Macdonald, Sigal Gottlieb. August 3, 2007 Abstract Strong stability preserving (SSP) time discretizations were

More information