ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs

Size: px
Start display at page:

Download "ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs"

Transcription

1 ENERGY PRESERVATION (DISSIPATION) IN NUMERICAL ODEs and PDEs E. CELLEDONI Department of Mathematical Sciences, NTNU 749 Trondheim, Norway. Abstract This note considers energy-preservation properties of Runge-Kutta and other one-step methods for ordinary and partial differential equations. Average vector field method, Hamiltonian ODEs, time integration, discrete gradients, Runge- Kutta mehtods. Introduction Consider the ordinary differential equation (ODE) ẏ = f(y), y() = y R n, we have seen the the following definition of first integral (or invariant) of the ODE: Definition.. A function I : R m R is a first integral (or invariant) of the ODE if and only if I(y) T f(y) =, y. () This implies that I is constant along solutions of the differential equations i.e. d I(y(t)) dt = I(y(t)) T f(y(t)) =, t >. We distinguish between linear, quadratic and polynomial invariants of degree higher than 2. Linear invariants are of the type Quadratic invariants are of the type I(y) = d T y, d R n. Q(y) = y T Cy, C = C T.

2 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 2 An example of a polynomial invariant of degree higher than 2 is the determinant of a matrix valued solution of a matricial ODE of the type ẏ = A(y)y, y() = I, trace(a) =, det(y) =, and A n n, n 3. We have seen that all Runge-Kutta methods preserve all linear invariants, and that a special class of Runge-Kutta methods preserve all quadratic invariants. We will next show that no (consistent) Runge-Kutta method can preserve all polynomial invariants of degree greater than or equal to 3. To this aim we will provide a counter example. For the counter example we need two preliminary lemmas. Lemma.2. If ẏ = By, y() = y with B an m m matrix not depending on y and on t, y R m, then using a Runge-Kutta method on this system of equations gives y n+ = R(hB)y n where R(z) is a rational function (the stability function of the Runge- Kutta method. ) Proof. Consider simply the scalar ode u = λu, u() = u, applying the Runge-Kutta method gives u n+ = u n + h s b i K i i= K i = λ ( u n + h s ) a i,j K j, i =,..., s. j= Consider the vector K T := [K,..., K s ]. The stages solve the linear algebraic equation (I hλa) K = λu n with the vector in R s with components equal to. Then and u n+ = u n + hb T K u n+ = u n ( + hλb T (I hλa) ). The expression in the parenthesis is the determinant of the rank one perturbation of the identity I + hλ(i hλa) b T which, since I + hλ(i hλa) b T = (I hλa) (I hλa + λhb T ), See note in lecture 2, section 5.

3 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 3 can be written as a quotient of determinants so det(i hλa + hλb T ) u n+ = u n. det(i hλa) Which shows that u n+ = R(hλ)u n with R a rational function (a quotient of two polynomials). The generalization to linear systems of ODEs involves the use of Kroneker tensor products of the matrix B and the Runge-Kutta matrix A and some extra linear algebra. Lemma.3. R(z) is an analytic function s.t. R() = and R () = and satisfying R(z) 2 R( 2z) if and only if. R(z) = e z Proof. By taking logarithms we have ψ(z) := log(r(z)) = ψ k z k, k= so R(z) = e ψ(z). By the properties of logarithms we have log(r(z) 2 R( 2z)) = 2 log(r(z)) + log(r( 2z)) = 2ψ(z) + ψ( 2z) =. So expanding the series and collecting terms we get 2ψ(z) + ψ( 2z) = ψ k z k (2 2 k ) =, k= since (2 2 k ) for k 2, ψ k must be zero for k 2. Also since R() = = e ψ() ψ = and ψ(z) = ψ z, finally R () = ψ e ψ z z= = gives ψ = so R(z) = e z. Remark: As from Lemma.2 the stability function of a Runge-Kutta method is a rational function, no Runge-Kutta method can have the exponential function as a stability function.

4 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 4 Example.4. [8] We consider the following simple ODE ẋ = x ẏ = y ż = 2z with initial value x() = x, y() = y, z() = z. We observe that x(t)y(t)z(t) = e t x e t y e 2t z = x y z is a cubic invariant of the flow. The equation can be written in the form ẋ = B x, x() = x, where B is the diagonal matrix with diagonal entries,, 2. Runge-Kutta method to this problem amounts to compute x = R(hB)x, Applying a consistent where R(z) is the stability function of the Runge-Kutta method, R() = and R () = (because of consistency), and R(z) is a rational function. In particular multiplying together the components of x we obtain x y z = R(h) 2 R( 2h)x y z. The invariant is preserved by the Runge-Kutta method if and only if R(h) 2 R( 2h) =, Now since from the Lemma.3 this can happen only if R(z) = e z, and since no Runge- Kutta method has e z as stability function, the preservation of this cubic invariant cannot be achieved with Runge-Kutta methods. 2 Discrete Gradients We consider a general ODE problem with an invariant I. It is always possible to write the ODE in the following form h. ẏ = f(y) = S(y) I(y), y() = y, (2) where S(y) is a skew-symmetric matrix. A choice for S(y), under the assumption that I(y) does not vanish, is S(y) = I 2 (f(y) I(y) T I(y)f(y) T ), [4], see the same reference for a discussion on the boundedness of S(y) defined above around non degenerate fixed points of I(y). For problems reformulated in the form (2) it is is always possible to build an energypreserving method by approximating I by a so called discrete gradient.

5 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 5 Definition 2.. (Gonzalez 96, [9]). If I is differentiable then I : R n R n R n is a discrete gradient if I is continuous and { I(u, v) T (v u) = I(v) I(u) I(u, u) = I(u) Example 2.2. Examples of discrete gradients. 2. I(u, v) = is the average vector field discrete gradient; I(u, v) = I( u + v ) + 2 this discrete gradient is due to Gonzalez. I (( ξ)u + ξv) dξ u+v I(v) I(u) I( 2 v u 2 T (v u) (v u), Theorem 2.3. A numerical integrator having the format y n+ = y n + h S(y n, y n+ ) I(y n, y n+ ), where S(y n, y n+ ) S(y) is a skew-symmetric matrix and neighborhood of y n, is an energy-preserving integrator. I(y n, y n+ ) I in a Proof. Using the definition of discrete gradient and the skew-symmetry of S(y n, y n+ ) we get I(y n+ ) I(y n ) = I(y n, y n+ ) T (y n+ y n ) = h I(y n, y n+ ) T S(yn, y n+ ) I(y n, y n+ ) =. Example 2.4. The method y n+ = y n + hs( y n + y n+ ) 2 I (( ξ)u + ξv) dξ, fits the framework of the previous theorem and is an energy preserving method. By using Taylor expansion it is possible to show that this method has order 2. 3 Preservation of the energy of Hamiltonian systems in the form ẏ = J H(y). Consider the ODE ẏ = f(y), y() = y, we call the integration method y n+ y n t = f(( ξ)y n + ξy n+ ) dξ, (3)

6 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 6 Avegrage Vector Field method, [9]. Consider Hamiltonian systems ẏ = f(y) = J H(y), y() = y. (4) Theorem 3.. Let y n be the solution of the average vector field (AVF) method (8) applied to equation (4). Then the energy H is preserved exactly : Proof H is preserved since H(y n+ ) = H(y n ). Ḣ = ( H) T J H =. (5) It is possible to prove that this method has order 2 by usual Taylor expansion. Corollary 3.2. Given b,..., b s and c,..., c s defining a quadrature formula of polynomial order m. Consider an ODE of the type (4) where H is a polynomial of degree m. Then the s-stages Runge-Kutta method y n+ = y n + h preserves H and has order min (m, 2). s b i f(y n + (y n+ y n )c i ) i= Proof. For polynomial Hamiltonians of degree m, f = J H has polynomial components of degree at most m and h s b i f(y n + (y n+ y n )c i ) = i= f(( ξ)y n + ξy n+ ) dξ. So the given quadrature formula coincides with the exact integral, and the given method coincides with the AVF method. 4 Hamiltonian PDEs and preservation of energy This part is taken from [6]. We consider evolutionary PDEs with independent variables (x, t) R d R, functions u belonging to a Banach space B with values 2 u(x, t) R m, and PDEs of the form u = D δh δu, (6) 2 Although it is generally real-valued, the function u may also be complex-valued, for example, the nonlinear Schrödinger equation.

7 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 7 where D is a constant linear differential operator, the dot denotes t, and H[u] = H(x; u (n) ) dx (7) Ω where Ω is a subset of R d R, and dx = dx dx 2... dx d. δh δu is the variational derivative of H in the sense that d dɛ H[u + ɛv] δh ɛ= = v dx, (8) Ω δu for all u, v B (cf. [8]). For example, if d = m =, H[u] = H(x; u, u x, u xx,... ) dx, (9) then Ω δh δu = H ( ) ( ) H H u x + x 2, () u x u xx when the boundary terms are zero. Similarly, for general d and m, we obtain δh δu l = H u l d k= x k ( H u l,k ) +..., l =,..., m. () We consider Hamiltonian systems of the form (6), where D is a constant skew symmetric operator (cf. [8]) and H the energy (Hamiltonian). In this case, we prefer to designate the differential operator in (6) with S instead of D. The PDE preserves the energy because S is skew-adjoint with respect to the L 2 inner product, i.e. usu dx =, u B. (2) Ω The system (6) has I : B R as an integral if İ = δi Ω δu S δh δu dx =. Integrals C with D δc δu = are called Casimirs. Besides PDEs of type (6) where D is skew-adjoint, we also consider PDEs of type (6) where D is a constant negative (semi)definite operator with respect to the L 2 inner product, i.e. udu dx, u B. (3) Ω In this case, we prefer to designate the differential operator D with N and the function H is a Lyapunov function, since then the system (6), i.e. u = N δh δu, (4) δh δu N δh has H as a Lyapunov function, i.e. Ḣ = Ω δu dx. We will refer to systems (6) with a skew-adjoint S and an energy H as conservative and to systems (6) with a negative (semi)definite operator N and a Lyapunov function H as dissipative.

8 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 8 Conservative PDEs (6) can be semi-discretised in skew-gradient form u = S H(u), S T = S, (5) when D = S is skew-adjoint. u R k, and here, and in the following, we will always denote the discretisations with bars. H is chosen in such a way that H x is an approximation to H. Lemma 4.. Let H[u] = Ω H(x; u (n) )dx, (6) and let H x be any consistent (finite difference) approximation to H (where x := x x 2... x d ). Then the discrete analogue of the variational derivative δh is given δu by H. Proof. For the proof see [6]. It is worth noting that the above lemma also applies directly when the approximation to H is obtained by a spectral discretization, since such an approximation can be viewed as a finite difference approximation where the finite difference stencil has the same number of entries as the number of grid points on which it is defined. The operator is the standard gradient, which replaces the variational derivative because we are now working in a finite (although large) number of dimensions (cf. e.g. ()). When dealing with (semi-)discrete systems we use the notation u j,n where the index j corresponds to increments in space and n to increments in time. That is, the point u j,n is the discrete equivalent of u(a + j x, t + n t) where x [a, b] and where t is the initial time. In most of the equations we present, one of the indices is held constant, in which case, for simplicity, we drop it from the notation. For example, we use u j to refer to the values of u at different points in space and at a fixed time level. Theorem 4.2. Let S (resp. N ) be any consistent constant skew (resp. negative-definite) matrix approximation to S (resp. N ). Let H x be any consistent (finite difference) approximation to H. Finally, let f(u) := S H(u) (resp. f(u) := N H(u)), (7) and let u n be the solution of the average vector field (AVF) method u n+ u n t = f(( ξ)u n + ξu n+ ) dξ, (8) applied to equation (7). Then the semidiscrete energy H is preserved exactly (resp. dissipated monotonically): H(u n+ ) = H(u n ) (resp H(u n+ ) H(u n )).

9 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 9 H is preserved since H = ( H ) T S H =. (9) Discretisations of this type can be given for pseudospectral, finite-element, Galerkin and finite-difference methods (cf. [6, 7]); for simplicity s sake, we will concentrate on finitedifference methods, though we include one example of a pseudospectral method for good measure. The AVF method was recently [9] shown to preserve the energy H exactly for any vector field f of the form f(u) = S H(u), where H is an arbitrary function, and S is any constant skew matrix 3. The AVF method is related to discrete gradient methods (cf. [4]). If D is a constant negative-definite operator, then the dissipative PDE (6) can be discretized in the form u = N H(u), (2) where N is a negative (semi)definite matrix and H is a discretisation as above. That is, H is a Lyapunov-function for the semi-discretized system, since H = ( H ) T N H. (2) The AVF method (8) again preserves this structure, i.e. we have H(u n+ ) H(u n ), (22) and H is a Lyapunov function for the discrete system. Taking the scalar product of (8) with H(( ξ)u n + ξu n+ ) dξ on both sides of the equation yields i.e. and therefore t (u n+ u n ) H(( ξ)u n + ξu n+ ) dξ, (23) d t dξ H(( ξ)u n + ξu n+ ) dξ, (24) t (H(u n+) H(u n )). (25) Our purpose is to show that the procedure described above, namely. Discretize the energy functional H using any (consistent) approximation H x 2. Discretize D by a constant skew-symmetric (resp. negative (semi)definite) matrix 3. Apply the AVF method can be generally applied and leads, in a systematic way, to energy-preserving methods for conservative PDEs and energy-dissipating methods for dissipative PDEs. We shall demonstrate the procedure by going through several well-known nonlinear and linear PDEs step by step. In particular we give examples of how to discretise nonlinear conservative PDEs (in subsection 2.), linear conservative PDEs (in subsection 2.2), nonlinear dissipative PDEs (in subsection 3.), and linear dissipative PDEs (in subsection 3.2). 3 The relationship of (8) to Runge-Kutta methods was explored in [5].

10 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 5 Conservative PDEs Example 5.. Sine-Gordon equation: Continuous: 2 ϕ t 2 The Sine-Gordon equation is of type (6) with where u := ( ϕ π H = ) and [ 2 π2 + 2 S = = 2 ϕ α sin ϕ. (26) x2 ( ) ϕ 2 + α ( cos ϕ)] dx, (27) x ( (Note that it follows that π = ϕ t.) Boundary conditions: periodic, u( 2, t) = u(2, t). Semi-discrete: finite differences 4 H fd = j ). (28) [ ] 2 π2 j + 2( x) 2 (ϕ j+ ϕ j ) 2 + α ( cos ϕ j ). (29) S = ( id id The resulting system of ordinary differential equations is [ ] [ ϕ π = S H π fd = Lϕ α sin ϕ x 2 where L is the circulant matrix 2. L = ). (3) ], (3) We have used the bold variables ϕ and π for the finite dimensional vectors [ϕ, ϕ 2,..., ϕ N ], et cetera, which replace the functions π and ϕ in the (semi-) discrete case. Where necessary, we will write ϕ n, et cetera to denote the vector ϕ at time t + n t. 4 Summations of the form j mean N j= unless stated otherwise.

11 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS The integral in the AVF method can be calculated exactly to give 5 [ ] ϕn+ ϕ n = (32) t π n+ π n [ ] (π n+ + π n )/2. L(ϕ n+ + ϕ n )/2 α(cos ϕ n+ cos ϕ n )/(ϕ n+ ϕ n ) Semi-discrete: spectral discretization Instead of using finite differences for the discretization of the spatial derivative in (27), one may use a spectral discretization. This can be thought of as replacing ϕ with its Fourier series, truncated after N terms, where N is the number of spatial intervals, and differentiating the Fourier series. This can be calculated, using the discrete Fourier transform 6 (DFT), as F N d NF N ϕ where F N is the matrix of DFT coefficients with entries given by [F N ] n,k = ωn nk, ω N = e θ and θ = i2π/l where l = b a is the extent of the spatial domain; that is l/n = x. Additionally, [F N ] n,k = ω nk N and d N is a diagonal matrix whose (non-zero) entries are the wave-numbers θ k = i2πk/l, k =,..., N, i.e., [d N ] k,k = θ k. (For more details on properties of the DFT and its application to spectral methods see [2] and [2].) [ 2 π2 j + [ F N 2 d NF N ϕ ] ] 2 j + α( cos ϕ j), (33) H sp = j S = ( id id ). (34) The resulting system of ODEs is then given by [ ] [ ] ϕ π = S H π sp = (F N D NF N ) (F N d, (35) NF N ϕ) α sin ϕ where [D N ] n,k = θ k. Again, the integral in the AVF method can be calculated exactly to give ϕ n+ ϕ n = (π n+ + π n )/2, (36) t π n+ π n t = (F N D NF N ) (F N d NF N )(ϕ n+ + ϕ n )/2 α(cos ϕ n+ cos ϕ n )/(ϕ n+ ϕ n ). (37) Initial conditions and numerical data for both discretizations: Spatial domain, number N of spatial intervals, and time-step size t used were 7 x [ 2, 2], N = 2, t =., parameter: α =. 5 For numerical computations, care must be taken to avoid problems when the difference ϕ n+ ϕ n in the denominator of (32) becomes small. We used the sum-to-product identity cos a cos b = 2 sin((a + b)/2) sin((a b)/2) to give a more numerically amenable expression. 6 In practice, one uses the fast Fourier transform algorithm to calculate the DFTs in O(N log N) operations. 7 Here and below, if x [a, b], then x = b a, and xj = a + j x, j =,,..., N. N

12 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 2 x 4 SG equation, Nspace= 2, Δt =. avf2 Midpoint 2 SG equation, Nspace= 2, Δt =. avf2 Midpoint Energy Error Global Error time time Figure : Sine-Gordon equation with finite differences semi-discretization: Energy error (left) and global error (right) vs time, for AVF and implicit midpoint integrators. Initial conditions: ϕ(x, ) =, π(x, ) = 8 cosh(2x). Right-moving kink and leftmoving anti-kink solution. Numerical comparisons of the AVF method with the well known (symplectic) implicit midpoint integrator 8 are given in figure for the finite differences discretization. Example 5.2. Korteweg-de Vries equation: Continuous: (38) u t = 6u u x 3 u x 3, (39) [ ] H = 2 (u x) 2 u 3 dx, (4) S = x. (4) Boundary conditions: periodic, u( 2, t) = u(2, t). Semi-discrete: H = j S = 2 x [ 2( x) 2 (u j+ u j ) 2 u 3 j Recall that the implicit midpoint integrator is given by u n+ u n t ], (42). (43) = f ( ) un+un+. 2

13 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 3 2 x 3 KdV equation, Nspace= 4, Δt =..8 KdV equation, Nspace= 4, Δt =..6 Energy Error avf2 Midpoint Global Error avf2 Midpoint time time Figure 2: Korteweg-de Vries equation: Energy error (left) and global error (right) vs time, for AVF and implicit midpoint integrators. Initial conditions and numerical data: x [ 2, 2], N = 4, t =.. 6 Dissipative PDEs Example 6.. Heat equation: Continuous: The heat equation u t = u xx, (44) is a dissipative PDE and can be written in the form (6), i.e. u t = N δh δu, u t = N δh 2 2 δu, (45) with the Lyapunov functions H (u) = 2 u2 x dx and H 2 (u) = 2 u2 dx and the operators N = and N 2 = x, 2 respectively. Boundary conditions: u(, t) = u(, t) =. Semi-discrete: N H = u 2 2( x) 2 + (u j u j ) 2 + u 2 N (46) j=2 and H 2 = N j= 2 (u j) 2, (47)

14 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS First Lyapunov function Second Lyapunov function time time Figure 3: Heat equation: plots of Lyapunov functions H x (left) and H 2 x (right) vs time, AVF integrator. as well as N 2 = ( x) and the obvious discretisation of N. With these choices, both discretisations yield identical semi-discrete equations of motion and therefore H and H 2 are simultaneously Lyapunov functions of the semi-discrete system and therefore, the AVF integrator preserves both Lyapunov functions. Initial conditions and numerical data: (48) x [, ], N = 5, t =.25. (49) Initial condition: u(x, ) = x( x). This system is numerically illustrated in Figure 3, where the monotonic decrease of the Lyapunov functions for the heat equation in (46) and (47) is shown.

15 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 5 7 Conservation laws in partial differential equations 7. Conservation laws for partial differential equations Given a PDE with solution u = u(x, t), x Ω R, t [, T ], belonging to suitable function-space X, we say that we have a conservation law for the PDE if there exist two functions E : R R and F : R R such that E(u(x, t)) t + F (u(x, t)) x =. (5) The function E is called local density and F is called local flux of the conserved quantity. Integrating the conservation law on the space domain we obtain E(u(x, t)) dx + F (u(x, t)) t Γ =, where Γ is the boundary of Ω. Example 7.. Consider the inviscid Burgers equation Ω u t + x ( 2 u2 ) =, x [, ], t, with homogeneous Dirichlet boundary conditions. By taking E(u(x, t)) = u(x, t) and F (u(x, t)) = 2 u2 (x, t) we can write the equation in the form (5). The conserved quantity is u(x, t) dx = t 2 u2 =. 8 Discrete gradient methods have an energy conservation law This topic is discussed in [5]. References [] U. M. Ascher, R.I. McLachlan, On symplectic and multisymplectic schemes for the KdV equation. J. Sci. Comput. 25 (25), no. -2, [2] W.L. Briggs and V.E. Henson, The DFT: An Owner s Manual for the Discrete Fourier Transform, SIAM, 995. [3] L. Brugnano, F. Iavernaro, and D. Trigiante, Hamiltonian boundary value methods (energy preserving discrete line integral methods). JNAIAM. J. Numer. Anal. Ind. Appl. Math., 5(-2):7-37, 2. [4] T. J. Bridges and S. Reich, Multi-symplectic integrators: numerical schemes for Hamiltonian PDEs that conserve symplecticity, Phys. Lett. A 284 (2), no. 4-5,

16 ENERGY PRESERVATION IN NUMERICAL INTEGRATORS 6 [5] E. Celledoni, R.I. McLachlan, D.I. McLaren, B. Owren, G.R.W. Quispel, and W.M. Wright, Energy-preserving Runge-Kutta methods, M2AN, vol 43 (4), [6] E. Celledoni, F. Grimm, R.I. McLachlan, D.I. McLaren, D.R.J. O Neale, B. Owren, G.R.W. Quispel, Preserving energy resp. dissipation in numerical PDEs, using the average vector field method. NTNU Reports nr. 7/29. Submitted. [7] M. Dahlby, B. Owren, T. Yaguchi, Preserving multiple first integrals by discrete gradients. Journal of Physics A: Mathematical and Theoretical. vol. 44 (3), 2. [8] K. Feng and Z. Shang, Volume-preserving algorithms for source-free dynamical systems, Numer. Math. 7 (995) 45?463. [9] O. Gonzalez, Time integration and discrete Hamiltonian systems, J. Nonlinear Science, vol 6:pp , 996. [] E. Hairer, Energy-preserving variant of collocation methods, JNAIAM. J. Numer. Anal. Ind. Appl. Math., 5(-2):73-84, 2. [] E. Hairer, C. Lubich and G. Wanner, Geometric Numerical Integration, Springer, II edition. [2] B. Leimkuhler and S. Reich, Simulating Hamiltonian dynamics. Cambridge Monographs on Applied and Computational Mathematics, 4. Cambridge University Press. [3] T. Matsuo. New conservative schemes with discrete variational derivatives for nonlinear wave equations, J. Comput. Appl. Math., 23 (27), pp [4] R.I. McLachlan, G.R.W. Quispel, and N. Robidoux. Geometric integration using discrete gradients, Phil. Trans. Roy. Soc. A, 357 (999), pp [5] R I McLachlan and G R W Quispel, Discrete gradient methods have an energy conservation law, Disc. Cont. Dyn. S. A, 34(3) (24), doi:.3934/dcds [6] R.I. McLachlan and N. Robidoux. Antisymmetry, pseudospectral methods, weighted residual discretizations, and energy conserving partial differential equations, Preprint, 2. [7] R.I. McLachlan and N. Robidoux. Antisymmetry, pseudospectral methods, and conservative PDEs, in International Conference on Differential Equations, Vol., 2 (Berlin, 999), World Sci. Publ., River Edge, NJ, 2, pp [8] P. Olver, Applications of Lie Groups to Differential Equations, Second Edition, Springer- Verlag, New York, 993. [9] G.R.W. Quispel and D.I. McLaren. A new class of energy-preserving numerical integration methods, J. Phys. A: Math. Theor., 4 (28), 4526 (7pp). [2] B.N. Ryland, Multisymplectic integration PhD thesis, Massey University, Palmerston North, New Zealand, available online [2] L.N. Trefethen, Spectral Methods in MATLAB, SIAM, 2.

norges teknisk-naturvitenskapelige universitet Preserving energy resp. dissipation in numerical PDEs, using the Average Vector Field method

norges teknisk-naturvitenskapelige universitet Preserving energy resp. dissipation in numerical PDEs, using the Average Vector Field method norges teknisk-naturvitenskapelige universitet Preserving energy resp dissipation in numerical PDEs, using the Average Vector Field method by E Celledoni,V Grimm, RI McLachlan, DI McLaren, DRJ O Neale,

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

On the construction of discrete gradients

On the construction of discrete gradients On the construction of discrete gradients Elizabeth L. Mansfield School of Mathematics, Statistics and Actuarial Science, University of Kent, Canterbury, CT2 7NF, U.K. G. Reinout W. Quispel Department

More information

arxiv: v1 [math.na] 21 Feb 2012

arxiv: v1 [math.na] 21 Feb 2012 Preserving energy resp. dissipation in numerical PDEs using the Average Vector Field method E. Celledoni a, V. Grimm b, R. I. McLachlan c, D. I. McLaren d, D. O Neale d,e, B. Owren a, G. R. W. Quispel

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

ENERGY PRESERVING METHODS FOR VOLTERRA LATTICE EQUATION

ENERGY PRESERVING METHODS FOR VOLTERRA LATTICE EQUATION TWMS J. App. Eng. Math. V., N.,, pp. 9- ENERGY PRESERVING METHODS FOR VOLTERRA LATTICE EQUATION B. KARASÖZEN, Ö. ERDEM, Abstract. We investigate linear energy preserving methods for the Volterra lattice

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

ENERGY PRESERVING INTEGRATION OF BI-HAMILTONIAN PARTIAL DIFFERENTIAL EQUATIONS

ENERGY PRESERVING INTEGRATION OF BI-HAMILTONIAN PARTIAL DIFFERENTIAL EQUATIONS TWMS J. App. Eng. Math. V., N.,, pp. 75-86 ENERGY PRESERVING INTEGRATION OF BI-HAMILTONIAN PARTIAL DIFFERENTIAL EQUATIONS B. KARASÖZEN, G. ŞİMŞEK Abstract. The energy preserving average vector field (AVF

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

A SIXTH ORDER AVERAGED VECTOR FIELD METHOD *

A SIXTH ORDER AVERAGED VECTOR FIELD METHOD * Journal of Computational Mathematics Vol.34, No.5, 6, 479 498. http://www.global-sci.org/jcm doi:.48/jcm.6-m5-65 A SIXTH ORDER AVERAGED VECTOR FIELD METHOD * Haochen Li Jiangsu Key Laboratory for NSLSCS,

More information

GEOMETRIC INTEGRATION METHODS THAT PRESERVE LYAPUNOV FUNCTIONS

GEOMETRIC INTEGRATION METHODS THAT PRESERVE LYAPUNOV FUNCTIONS BIT Numerical Mathematics 25, Vol. 45, No., pp. 79 723 c Springer GEOMETRIC INTEGRATION METHODS THAT PRESERVE LYAPUNOV FUNCTIONS V. GRIMM and G.R.W. QUISPEL Department of Mathematics, and Centre for Mathematics

More information

SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS

SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS G.R.W. QUISPEL 1,2 and H.W. CAPEL 3 Abstract. Using Discrete Gradient Methods (Quispel & Turner, J. Phys. A29 (1996) L341-L349) we construct

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

1. Introduction. We consider canonical Hamiltonian systems in the form 0 I y(t 0 ) = y 0 R 2m J = I 0

1. Introduction. We consider canonical Hamiltonian systems in the form 0 I y(t 0 ) = y 0 R 2m J = I 0 ENERGY AND QUADRATIC INVARIANTS PRESERVING INTEGRATORS BASED UPON GAUSS COLLOCATION FORMULAE LUIGI BRUGNANO, FELICE IAVERNARO, AND DONATO TRIGIANTE Abstract. We introduce a new family of symplectic integrators

More information

Diagonalization of the Coupled-Mode System.

Diagonalization of the Coupled-Mode System. Diagonalization of the Coupled-Mode System. Marina Chugunova joint work with Dmitry Pelinovsky Department of Mathematics, McMaster University, Canada Collaborators: Mason A. Porter, California Institute

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

Reducing round-off errors in symmetric multistep methods

Reducing round-off errors in symmetric multistep methods Reducing round-off errors in symmetric multistep methods Paola Console a, Ernst Hairer a a Section de Mathématiques, Université de Genève, 2-4 rue du Lièvre, CH-1211 Genève 4, Switzerland. (Paola.Console@unige.ch,

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

Multiple invariants conserving Runge-Kutta type methods for Hamiltonian problems

Multiple invariants conserving Runge-Kutta type methods for Hamiltonian problems Multiple invariants conserving Runge-Kutta type methods for Hamiltonian problems arxiv:132.1678v2 [math.na] 6 Sep 213 Luigi Brugnano Yajuan Sun Warmly dedicated to celebrate the 8-th birthday of John Butcher

More information

Sufficient conditions for functions to form Riesz bases in L 2 and applications to nonlinear boundary-value problems

Sufficient conditions for functions to form Riesz bases in L 2 and applications to nonlinear boundary-value problems Electronic Journal of Differential Equations, Vol. 200(200), No. 74, pp. 0. ISSN: 072-669. URL: http://ejde.math.swt.edu or http://ejde.math.unt.edu ftp ejde.math.swt.edu (login: ftp) Sufficient conditions

More information

Hamiltonian partial differential equations and Painlevé transcendents

Hamiltonian partial differential equations and Painlevé transcendents The 6th TIMS-OCAMI-WASEDA Joint International Workshop on Integrable Systems and Mathematical Physics March 22-26, 2014 Hamiltonian partial differential equations and Painlevé transcendents Boris DUBROVIN

More information

Some recent results on controllability of coupled parabolic systems: Towards a Kalman condition

Some recent results on controllability of coupled parabolic systems: Towards a Kalman condition Some recent results on controllability of coupled parabolic systems: Towards a Kalman condition F. Ammar Khodja Clermont-Ferrand, June 2011 GOAL: 1 Show the important differences between scalar and non

More information

High-order Symmetric Schemes for the Energy Conservation of Polynomial Hamiltonian Problems 1 2

High-order Symmetric Schemes for the Energy Conservation of Polynomial Hamiltonian Problems 1 2 European Society of Computational Methods in Sciences and Engineering (ESCMSE) Journal of Numerical Analysis, Industrial and Applied Mathematics (JNAIAM) vol 4, no -2, 29, pp 87- ISSN 79 84 High-order

More information

Definition 5.1. A vector field v on a manifold M is map M T M such that for all x M, v(x) T x M.

Definition 5.1. A vector field v on a manifold M is map M T M such that for all x M, v(x) T x M. 5 Vector fields Last updated: March 12, 2012. 5.1 Definition and general properties We first need to define what a vector field is. Definition 5.1. A vector field v on a manifold M is map M T M such that

More information

THE Hamilton equations of motion constitute a system

THE Hamilton equations of motion constitute a system Proceedings of the World Congress on Engineering 0 Vol I WCE 0, July 4-6, 0, London, U.K. Systematic Improvement of Splitting Methods for the Hamilton Equations Asif Mushtaq, Anne Kværnø, and Kåre Olaussen

More information

Energy-preserving Pseudo-spectral Methods for Klein-Gordon-Schrödinger Equations

Energy-preserving Pseudo-spectral Methods for Klein-Gordon-Schrödinger Equations .. Energy-preserving Pseudo-spectral Methods for Klein-Gordon-Schrödinger Equations Jingjing Zhang Henan Polytechnic University December 9, 211 Outline.1 Background.2 Aim, Methodology And Motivation.3

More information

High-order time-splitting methods for Schrödinger equations

High-order time-splitting methods for Schrödinger equations High-order time-splitting methods for Schrödinger equations and M. Thalhammer Department of Mathematics, University of Innsbruck Conference on Scientific Computing 2009 Geneva, Switzerland Nonlinear Schrödinger

More information

The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations

The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations Jason Fran CWI P.O. Box 94079, 1090 GB Amsterdam, The Netherlands Sebastian Reich Department of Mathematics, Imperial College

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

YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL

YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL Journal of Comput. & Applied Mathematics 139(2001), 197 213 DIRECT APPROACH TO CALCULUS OF VARIATIONS VIA NEWTON-RAPHSON METHOD YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL Abstract. Consider m functions

More information

On universality of critical behaviour in Hamiltonian PDEs

On universality of critical behaviour in Hamiltonian PDEs Riemann - Hilbert Problems, Integrability and Asymptotics Trieste, September 23, 2005 On universality of critical behaviour in Hamiltonian PDEs Boris DUBROVIN SISSA (Trieste) 1 Main subject: Hamiltonian

More information

Modified Equations for Variational Integrators

Modified Equations for Variational Integrators Modified Equations for Variational Integrators Mats Vermeeren Technische Universität Berlin Groningen December 18, 2018 Mats Vermeeren (TU Berlin) Modified equations for variational integrators December

More information

Rational Chebyshev pseudospectral method for long-short wave equations

Rational Chebyshev pseudospectral method for long-short wave equations Journal of Physics: Conference Series PAPER OPE ACCESS Rational Chebyshev pseudospectral method for long-short wave equations To cite this article: Zeting Liu and Shujuan Lv 07 J. Phys.: Conf. Ser. 84

More information

Discrete Variational Derivative Method

Discrete Variational Derivative Method .... Discrete Variational Derivative Method one of structure preserving methods for PDEs Daisue Furihata Osaa Univ. 211.7.12 furihata@cmc.osaa-u.ac.jp (Osaa Univ.)Discrete Variational Derivative Method

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

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators MATEMATIKA, 8, Volume 3, Number, c Penerbit UTM Press. All rights reserved Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators Annie Gorgey and Nor Azian Aini Mat Department of Mathematics,

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Spatial discretization of partial differential equations with integrals

Spatial discretization of partial differential equations with integrals Spatial discretization of partial differential equations with integrals Robert I. McLachlan IFS, Massey University, Palmerston North, New Zealand E-mail: r.mclachlan@massey.ac.nz We consider the problem

More information

Copyright is owned by the Author of the thesis. Permission is given for a copy to be downloaded by an individual for the purpose of research and

Copyright is owned by the Author of the thesis. Permission is given for a copy to be downloaded by an individual for the purpose of research and Copyright is owned by the Author of the thesis. Permission is given for a copy to be downloaded by an individual for the purpose of research and private study only. The thesis may not be reproduced elsewhere

More information

The Higher Dimensional Bateman Equation and Painlevé Analysis of Nonintegrable Wave Equations

The Higher Dimensional Bateman Equation and Painlevé Analysis of Nonintegrable Wave Equations Symmetry in Nonlinear Mathematical Physics 1997, V.1, 185 192. The Higher Dimensional Bateman Equation and Painlevé Analysis of Nonintegrable Wave Equations Norbert EULER, Ove LINDBLOM, Marianna EULER

More information

High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems.

High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems. High-order symmetric schemes for the energy conservation of polynomial Hamiltonian problems. Felice Iavernaro and Donato Trigiante Abstract We define a class of arbitrary high order symmetric one-step

More information

Symmetry reductions and travelling wave solutions for a new integrable equation

Symmetry reductions and travelling wave solutions for a new integrable equation Symmetry reductions and travelling wave solutions for a new integrable equation MARIA LUZ GANDARIAS University of Cádiz Department of Mathematics PO.BOX 0, 50 Puerto Real, Cádiz SPAIN marialuz.gandarias@uca.es

More information

Symmetry Reductions of (2+1) dimensional Equal Width. Wave Equation

Symmetry Reductions of (2+1) dimensional Equal Width. Wave Equation Authors: Symmetry Reductions of (2+1) dimensional Equal Width 1. Dr. S. Padmasekaran Wave Equation Asst. Professor, Department of Mathematics Periyar University, Salem 2. M.G. RANI Periyar University,

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

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

7. Baker-Campbell-Hausdorff formula

7. Baker-Campbell-Hausdorff formula 7. Baker-Campbell-Hausdorff formula 7.1. Formulation. Let G GL(n,R) be a matrix Lie group and let g = Lie(G). The exponential map is an analytic diffeomorphim of a neighborhood of 0 in g with a neighborhood

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

A fast and well-conditioned spectral method: The US method

A fast and well-conditioned spectral method: The US method A fast and well-conditioned spectral method: The US method Alex Townsend University of Oxford Leslie Fox Prize, 24th of June 23 Partially based on: S. Olver & T., A fast and well-conditioned spectral method,

More information

A new integrable system: The interacting soliton of the BO

A new integrable system: The interacting soliton of the BO Phys. Lett., A 204, p.336-342, 1995 A new integrable system: The interacting soliton of the BO Benno Fuchssteiner and Thorsten Schulze Automath Institute University of Paderborn Paderborn & Germany Abstract

More information

GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS

GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS BIT 0006-3835/01/4105-0996 $16.00 2001, Vol. 41, No. 5, pp. 996 1007 c Swets & Zeitlinger GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS E. HAIRER Section de mathématiques, Université

More information

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning Int. J. Contemp. Math. Sciences, Vol. 2, 2007, no. 22, 1097-1106 A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning M. T. Darvishi a,, S.

More information

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems Bob Peeters Joint work with Onno Bokhove & Jason Frank TW, University of Twente, Enschede CWI, Amsterdam PhD-TW colloquium, 9th

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

Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials

Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials Representations of Sp(6,R) and SU(3) carried by homogeneous polynomials Govindan Rangarajan a) Department of Mathematics and Centre for Theoretical Studies, Indian Institute of Science, Bangalore 560 012,

More information

SANGRADO PAGINA 17CMX24CM. PhD Thesis. Splitting methods for autonomous and non-autonomous perturbed equations LOMO A AJUSTAR (AHORA 4CM)

SANGRADO PAGINA 17CMX24CM. PhD Thesis. Splitting methods for autonomous and non-autonomous perturbed equations LOMO A AJUSTAR (AHORA 4CM) SANGRADO A3 PAGINA 17CMX24CM LOMO A AJUSTAR (AHORA 4CM) We have considered the numerical integration of non-autonomous separable parabolic equations using high order splitting methods with complex coefficients.

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED ALAN DEMLOW Abstract. Recent results of Schatz show that standard Galerkin finite element methods employing piecewise polynomial elements of degree

More information

2.20 Fall 2018 Math Review

2.20 Fall 2018 Math Review 2.20 Fall 2018 Math Review September 10, 2018 These notes are to help you through the math used in this class. This is just a refresher, so if you never learned one of these topics you should look more

More information

Exact solutions through symmetry reductions for a new integrable equation

Exact solutions through symmetry reductions for a new integrable equation Exact solutions through symmetry reductions for a new integrable equation MARIA LUZ GANDARIAS University of Cádiz Department of Mathematics PO.BOX, 1151 Puerto Real, Cádiz SPAIN marialuz.gandarias@uca.es

More information

The L p -dissipativity of first order partial differential operators

The L p -dissipativity of first order partial differential operators The L p -dissipativity of first order partial differential operators A. Cialdea V. Maz ya n Memory of Vladimir. Smirnov Abstract. We find necessary and sufficient conditions for the L p -dissipativity

More information

c 2012 Society for Industrial and Applied Mathematics

c 2012 Society for Industrial and Applied Mathematics SIAM J. NUMER. ANAL. Vol. 50, No. 4, pp. 849 860 c 0 Society for Industrial and Applied Mathematics TWO RESULTS CONCERNING THE STABILITY OF STAGGERED MULTISTEP METHODS MICHELLE GHRIST AND BENGT FORNBERG

More information

An Efficient Multiscale Runge-Kutta Galerkin Method for Generalized Burgers-Huxley Equation

An Efficient Multiscale Runge-Kutta Galerkin Method for Generalized Burgers-Huxley Equation Applied Mathematical Sciences, Vol. 11, 2017, no. 30, 1467-1479 HIKARI Ltd, www.m-hikari.com https://doi.org/10.12988/ams.2017.7141 An Efficient Multiscale Runge-Kutta Galerkin Method for Generalized Burgers-Huxley

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

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

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.)

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.) 4 Vector fields Last updated: November 26, 2009. (Under construction.) 4.1 Tangent vectors as derivations After we have introduced topological notions, we can come back to analysis on manifolds. Let M

More information

On the simplest expression of the perturbed Moore Penrose metric generalized inverse

On the simplest expression of the perturbed Moore Penrose metric generalized inverse Annals of the University of Bucharest (mathematical series) 4 (LXII) (2013), 433 446 On the simplest expression of the perturbed Moore Penrose metric generalized inverse Jianbing Cao and Yifeng Xue Communicated

More information

The elliptic sinh-gordon equation in the half plane

The elliptic sinh-gordon equation in the half plane Available online at www.tjnsa.com J. Nonlinear Sci. Appl. 8 25), 63 73 Research Article The elliptic sinh-gordon equation in the half plane Guenbo Hwang Department of Mathematics, Daegu University, Gyeongsan

More information

Numerical simulation for a nonlinear partial differential equation with variable coefficients by means of the discrete variational derivative method

Numerical simulation for a nonlinear partial differential equation with variable coefficients by means of the discrete variational derivative method Journal of Computational and Applied Mathematics 94 (6) 45 459 www.elsevier.com/locate/cam Numerical simulation for a nonlinear partial differential equation with variable coefficients by means of the

More information

Scientific Computing I

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

More information

LECTURE 3: REPRESENTATION THEORY OF SL 2 (C) AND sl 2 (C)

LECTURE 3: REPRESENTATION THEORY OF SL 2 (C) AND sl 2 (C) LECTURE 3: REPRESENTATION THEORY OF SL 2 (C) AND sl 2 (C) IVAN LOSEV Introduction We proceed to studying the representation theory of algebraic groups and Lie algebras. Algebraic groups are the groups

More information

An introduction to Birkhoff normal form

An introduction to Birkhoff normal form An introduction to Birkhoff normal form Dario Bambusi Dipartimento di Matematica, Universitá di Milano via Saldini 50, 0133 Milano (Italy) 19.11.14 1 Introduction The aim of this note is to present an

More information

A Model of Evolutionary Dynamics with Quasiperiodic Forcing

A Model of Evolutionary Dynamics with Quasiperiodic Forcing paper presented at Society for Experimental Mechanics (SEM) IMAC XXXIII Conference on Structural Dynamics February 2-5, 205, Orlando FL A Model of Evolutionary Dynamics with Quasiperiodic Forcing Elizabeth

More information

About Integrable Non-Abelian Laurent ODEs

About Integrable Non-Abelian Laurent ODEs About Integrable Non-Abelian Laurent ODEs T. Wolf, Brock University September 12, 2013 Outline Non-commutative ODEs First Integrals and Lax Pairs Symmetries Pre-Hamiltonian Operators Recursion Operators

More information

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Y. Azari Keywords: Local RBF-based finite difference (LRBF-FD), Global RBF collocation, sine-gordon

More information

An Inverse Problem for the Matrix Schrödinger Equation

An Inverse Problem for the Matrix Schrödinger Equation Journal of Mathematical Analysis and Applications 267, 564 575 (22) doi:1.16/jmaa.21.7792, available online at http://www.idealibrary.com on An Inverse Problem for the Matrix Schrödinger Equation Robert

More information

LINEAR ALGEBRA BOOT CAMP WEEK 4: THE SPECTRAL THEOREM

LINEAR ALGEBRA BOOT CAMP WEEK 4: THE SPECTRAL THEOREM LINEAR ALGEBRA BOOT CAMP WEEK 4: THE SPECTRAL THEOREM Unless otherwise stated, all vector spaces in this worksheet are finite dimensional and the scalar field F is R or C. Definition 1. A linear operator

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

ON THE HÖLDER CONTINUITY OF MATRIX FUNCTIONS FOR NORMAL MATRICES

ON THE HÖLDER CONTINUITY OF MATRIX FUNCTIONS FOR NORMAL MATRICES Volume 10 (2009), Issue 4, Article 91, 5 pp. ON THE HÖLDER CONTINUITY O MATRIX UNCTIONS OR NORMAL MATRICES THOMAS P. WIHLER MATHEMATICS INSTITUTE UNIVERSITY O BERN SIDLERSTRASSE 5, CH-3012 BERN SWITZERLAND.

More information

Symmetric multistep methods for charged-particle dynamics

Symmetric multistep methods for charged-particle dynamics Version of 12 September 2017 Symmetric multistep methods for charged-particle dynamics Ernst Hairer 1, Christian Lubich 2 Abstract A class of explicit symmetric multistep methods is proposed for integrating

More information

AVERAGING THEORY AT ANY ORDER FOR COMPUTING PERIODIC ORBITS

AVERAGING THEORY AT ANY ORDER FOR COMPUTING PERIODIC ORBITS This is a preprint of: Averaging theory at any order for computing periodic orbits, Jaume Giné, Maite Grau, Jaume Llibre, Phys. D, vol. 25, 58 65, 213. DOI: [1.116/j.physd.213.1.15] AVERAGING THEORY AT

More information

Period function for Perturbed Isochronous Centres

Period function for Perturbed Isochronous Centres QUALITATIE THEORY OF DYNAMICAL SYSTEMS 3, 275?? (22) ARTICLE NO. 39 Period function for Perturbed Isochronous Centres Emilio Freire * E. S. Ingenieros, Universidad de Sevilla, Camino de los Descubrimientos

More information

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems.

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. Printed Name: Signature: Applied Math Qualifying Exam 11 October 2014 Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. 2 Part 1 (1) Let Ω be an open subset of R

More information

Kink, singular soliton and periodic solutions to class of nonlinear equations

Kink, singular soliton and periodic solutions to class of nonlinear equations Available at http://pvamu.edu/aam Appl. Appl. Math. ISSN: 193-9466 Vol. 10 Issue 1 (June 015 pp. 1 - Applications and Applied Mathematics: An International Journal (AAM Kink singular soliton and periodic

More information

THE METHOD OF LINES FOR PARABOLIC PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS

THE METHOD OF LINES FOR PARABOLIC PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS JOURNAL OF INTEGRAL EQUATIONS AND APPLICATIONS Volume 4, Number 1, Winter 1992 THE METHOD OF LINES FOR PARABOLIC PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS J.-P. KAUTHEN ABSTRACT. We present a method of lines

More information

Chap. 1. Some Differential Geometric Tools

Chap. 1. Some Differential Geometric Tools Chap. 1. Some Differential Geometric Tools 1. Manifold, Diffeomorphism 1.1. The Implicit Function Theorem ϕ : U R n R n p (0 p < n), of class C k (k 1) x 0 U such that ϕ(x 0 ) = 0 rank Dϕ(x) = n p x U

More information

Memoirs on Differential Equations and Mathematical Physics

Memoirs on Differential Equations and Mathematical Physics Memoirs on Differential Equations and Mathematical Physics Volume 51, 010, 93 108 Said Kouachi and Belgacem Rebiai INVARIANT REGIONS AND THE GLOBAL EXISTENCE FOR REACTION-DIFFUSION SYSTEMS WITH A TRIDIAGONAL

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

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 The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators.

MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. MATH 423 Linear Algebra II Lecture 33: Diagonalization of normal operators. Adjoint operator and adjoint matrix Given a linear operator L on an inner product space V, the adjoint of L is a transformation

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

Exact Solutions of The Regularized Long-Wave Equation: The Hirota Direct Method Approach to Partially Integrable Equations

Exact Solutions of The Regularized Long-Wave Equation: The Hirota Direct Method Approach to Partially Integrable Equations Thai Journal of Mathematics Volume 5(2007) Number 2 : 273 279 www.math.science.cmu.ac.th/thaijournal Exact Solutions of The Regularized Long-Wave Equation: The Hirota Direct Method Approach to Partially

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

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

More information

An analogue of Rionero s functional for reaction-diffusion equations and an application thereof

An analogue of Rionero s functional for reaction-diffusion equations and an application thereof Note di Matematica 7, n., 007, 95 105. An analogue of Rionero s functional for reaction-diffusion equations and an application thereof James N. Flavin Department of Mathematical Physics, National University

More information

On the local existence for an active scalar equation in critical regularity setting

On the local existence for an active scalar equation in critical regularity setting On the local existence for an active scalar equation in critical regularity setting Walter Rusin Department of Mathematics, Oklahoma State University, Stillwater, OK 7478 Fei Wang Department of Mathematics,

More information

Exact Solutions for the Nonlinear (2+1)-Dimensional Davey-Stewartson Equation Using the Generalized ( G. )-Expansion Method

Exact Solutions for the Nonlinear (2+1)-Dimensional Davey-Stewartson Equation Using the Generalized ( G. )-Expansion Method Journal of Mathematics Research; Vol. 6, No. ; 04 ISSN 96-9795 E-ISSN 96-9809 Published by Canadian Center of Science and Education Exact Solutions for the Nonlinear +-Dimensional Davey-Stewartson Equation

More information

PARTIAL DIFFERENTIAL EQUATIONS

PARTIAL DIFFERENTIAL EQUATIONS MATHEMATICAL METHODS PARTIAL DIFFERENTIAL EQUATIONS I YEAR B.Tech By Mr. Y. Prabhaker Reddy Asst. Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad. SYLLABUS OF MATHEMATICAL

More information

THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS. Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands

THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS. Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands THE θ-methods IN THE NUMERICAL SOLUTION OF DELAY DIFFERENTIAL EQUATIONS Karel J. in t Hout, Marc N. Spijker Leiden, The Netherlands 1. Introduction This paper deals with initial value problems for delay

More information

Splittings, commutators and the linear Schrödinger equation

Splittings, commutators and the linear Schrödinger equation UNIVERSITY OF CAMBRIDGE CENTRE FOR MATHEMATICAL SCIENCES DEPARTMENT OF APPLIED MATHEMATICS & THEORETICAL PHYSICS Splittings, commutators and the linear Schrödinger equation Philipp Bader, Arieh Iserles,

More information

Hamiltonian partial differential equations and Painlevé transcendents

Hamiltonian partial differential equations and Painlevé transcendents Winter School on PDEs St Etienne de Tinée February 2-6, 2015 Hamiltonian partial differential equations and Painlevé transcendents Boris DUBROVIN SISSA, Trieste Cauchy problem for evolutionary PDEs with

More information