Exponential time differencing methods for nonlinear PDEs

Size: px
Start display at page:

Download "Exponential time differencing methods for nonlinear PDEs"

Transcription

1 XXI Congreso de Ecuaciones Diferenciales Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, 1- septiembre 9 (pp. 1 8) Exponential time differencing methods for nonlinear PDEs F. de la Hoz 1, F. Vadillo 1 Dpto. de Matemática Aplicada, UPV/EHU. francisco.delahoz@ehu.es Dpto. de Matemática Aplicada, Estadística e I.O., UPV/EHU. fernando.vadillo@ehu.es Kewords: ETD, Nonlinear waves, Schrödinger, Semi-linear diffusion equations, Blow-up Abstract Spectral methods offer ver high spatial resolution for a wide range of nonlinear wave equations. Because of this, it should be desirable, for the best computational efficienc, to use also high-order methods in time, but without ver strict restrictions on the step size, due to numerical instabilit. In this communication, we consider the exponential time differencing fourth-order Runge-Kutta (ETDRK4) method. This scheme was derived b Cox and Matthews in [4] and modified b Kassam and Trefethen in [1]. We have studied its amplification factor and its stabilit region, which gives us an explanation of its good behavior for dissipative and dispersive problems. In [1], we have applied this method to the nonlinear cubic Schrödinger equation in one and two space-variables. Later, in [11], we have simulated the blow-up of semi-linear diffusion equations. 1. Introduction The spectral methods have been shown to be remarkabl successful when solving timedependent partial differential equations (PDEs). The idea is to approximate a solution u(x,t) b a finite sum v(x,t) = N k= a k(t)φ k (x), where the function class φ k (x),k =, 1,..., N, will be trigonometric for x periodic problems and, otherwise, an orthogonal polnomial of Jacobi tpe, with Chebshev polnomials being the most important special case. To determine the expansion coefficients a k (t), we will focus on the pseudo-spectral methods, where it is required that the coefficients make the residual equal to zero at as man (suitabl chosen) spatial points as possible. Three books [6], [] and [16] have been contributed to supplement the classic references [8] and [3]. When a time-dependent PDE is discretized in space with a spectral discretization, the result is a coupled sstem of ordinar differential equations (ODEs) in time; this is the 1

2 F. de la Hoz, F. Vadillo notion of the method of lines (MOL), and the resulting set of ODEs is stiff. The stiffness problem ma be even exacerbated sometimes, for example, when using Chebshev polnomials (see Chapter 1 of [16] and its references). The linear terms are primaril responsible for the stiffness with rapid exponential deca of some modes (as with a dissipative PDE) or a rapid oscillation of some modes (as with a dispersive PDE). Therefore, for a time-dependent PDE which combines low-order nonlinear terms with higher-order linear terms, it is desirable to use a higher-order approximation in space and time. For the sake of space, we onl show a numerical simulation for the blow-up of semilinear diffusion equations, referring to [1] for the nonlinear Schrödinger equation.. Exponential Time Differencing fourth-order Runge-Kutta Method The numerical method considered in this communication is an exponential time differencing (ETD) scheme. These methods arose originall in the field of computational electrodnamics [1]. Later on, the have recentl received attention in [1] and [14], but the most comprehensive treatment, and in particular the ETD with Runge-Kutta time stepping, is in the paper b Cox and Matthews [4]. The idea of the ETD methods is similar to the method of the integrating factor (see for example [] or [16]): we multipl both sides of a differential equation b some integrating factor, then we make a change of variable that allows us to solve the linear part exactl and, finall, we use a numerical method of our choice to solve the transformed nonlinear part. When a time-dependent PDE in the form u t = Lu + N(u,t), (1) where L and N are the linear and nonlinear operators respectivel, is discretized in space with a spectral method, the result is a coupled sstem of ordinar differential equations (ODEs): u t = Lu + N(u,t). () Multipling () b the term e Lt, known as the integrating factor, gives e Lt u t e Lt Lu = e Lt N(u,t). (3) Following [1], we integrate (3) over a single time step of length h, getting h u n+1 = e Lh u n + e Lh e Lτ N(u(t n + τ),t n + τ)dτ. (4) The various ETD methods come from how one approximates the integral in this expression. Cox and Matthews derived in [4] a set of ETD methods based on the Runge-Kutta time stepping, which the called ETDRK methods. In this communication we consider the

3 Exponential time differencing methods for nonlinear PDEs ETDRK4 fourth-order scheme, which has the following expression: a n = e Lh/ u n + L 1 (e Lh/ I)N(u n,t n ), b n = e Lh/ u n + L 1 (e Lh/ I)N(a n,t n + h/), c n = e Lh/ a n + L 1 (e Lh/ I)(N(b n,t n + h/) N(u n,t n )), u n+1 = e Lh u n + h L 3 {[ 4I hl + e Lh (4I 3hL + (hl) )]N(u n,t n ) + [I + hl + e Lh ( I + hl)](n(a n,t n + h/) + N(b n,t n + h/)) + [ 4I 3hL (hl) + e Lh (4I hl)]n(c n,t n + h)}. More detailed derivations of the ETD schemes can be found in [4]. Unfortunatel, in this form ETDRK4 suffers from numerical instabilit when L has eigenvalues close to zero, because disastrous cancellation errors arise. Kassam and Trefethen have studied in [1] those instabilities and have found that the can be removed b evaluating a certain integral on a contour that is separated from zero. The procedure is basicall to change the evaluation of the coefficients, which is mathematicall equivalent to the original ETDRK4 scheme of [4], although in [] it has been shown to have the effect of improving the stabilit of integration in time. Moreover, it can be easil implemented and the impact on the total computing time is small. In fact, we have alwas incorporated this idea in our MATLAB c codes. The stabilit analsis of the ETDRK4 method is as follows (see [1], [7] or [4]). For the nonlinear ODE du = cu + F(u), () dt being F(u) the nonlinear part, we suppose that there exists a fixed point u ; this means that cu +F(u ) =. Linearizing about this fixed point, if u is the perturbation of u and λ = F (u ), then u t = cu + λu (6) and the fixed point u is stable if Re(c + λ) <. The application of the ETDRK4 method to (6) leads to a recurrence relation involving u n and u n+1. Introducing the previous notation x = λh, = ch and using the Mathematica c algebra package, we obtain the following amplification factor: where c = e, c 1 = 4 + 8e u n+1 u n = r(x,) = c + c 1 x + c x + c 3 x 3 + c 4 x 4, (7) c = e 4 e 1 + 4e 8e 3 16e e 3e, + 8e e + 1e 6e + 4e 1e 3 e, + 4e 3 3

4 F. de la Hoz, F. Vadillo c 3 = 4 16e + 16e 4 1e 3 4 c 4 = 8 6 4e 6 + e 1e e + 6e e 6 + 6e + 8e 3 e e 3 6 e e e 4e 6 + 8e + 4 1e 4 + 4e e 3, + 8e e e + 6e 4 e 3 4. It is important to remark that computing c 1,c, c 3 and c 4 b the above expressions suffers from numerical instabilit for close to zero. Because of that, for small, we will use instead their asmptotic expansions: c 1 = O( 6 ), c = O( 6 ), c 3 = O( 6 ), c 4 = O( 6 ). 3. The semi-linear diffusion equations Man mathematical models have the propert to develop singularities in a finite time T: for instance, the formation of shocks in Burgers equation without viscosit. Often, this singularit represents an abrupt change in the properties of the models, so it is extremel important for a chosen numerical method to reproduce that change accuratel. In this section, we consider the semi-linear parabolic equation u t = u + u p, p > 1, x R N,t >, (8) with the initial condition u(x,) = u (x), x R N, (9) where u (x) is continuous, nonnegative and bounded. The local (in time) existence of positive solutions of (8),(9) follows from standard results, but the solution ma develop singularities in finite time. In [13], it is proved that there exists a critical exponent p c (N) = 1+ N, such that for 1 < p < p c(n), an nontrivial solution of (8),(9) blows up at a finite time T. However, if p > p c (N), there exist global solutions if the initial value is sufficientl small. The one-dimensional semi-linear parabolic equation is u t = u xx + u p, p > 1, x R,t >. (1) 4

5 Exponential time differencing methods for nonlinear PDEs The critical exponent is p c = 3 and for 1 < p < 3 the onl nonnegative global (in time) solution is u =. Another question is the asmptotic behavior of the solutions as the blow-up time is approached, for which we refer to [9]. Although problem (1) is not mathematicall periodic, we consider that the solution is close to zero at the ends of the interval [ L,L] for L sufficientl large, so it can be regarded as periodic in practice and we can use the Fourier transform. Hence, in the Fourier space we have û t = ξ û + û p, ξ, (11) where ξ is the Fourier wave-number and the coefficients c = ǫξ < span over a wide range of values when all the Fourier modes are considered. For high values of ξ, the solutions are attracted to the slow manifold quickl because c < and c 1. In figure 1 we displa the boundar stabilit regions in the complex plane x, for =,.9,, 1, 18, which are similar to figures 3., 3.3 and 3.4 of []. When the linear part is zero ( = ), we recognized the stabilit region of the fourth-order Runge- Kutta methods and, as, the region grows. Of course, these regions onl give an indication of the stabilit of the ETDRK4 method Figure 1: Boundar of stabilit regions for several negative In fact, for <, 1, the observed boundaries approach to ellipses whose parameters have been fitted numericall with the following expression: ( ) Im(x) (Re(x)) + =. (1).7 Then, the spectrum of the linear operator increases as ξ, while the eigenvalues of the linearization of the nonlinear part la on the imaginar axis and increase as ξ. On the other hand, according to (1), when Re(x) =, the intersection with the imaginar axis Im(x)

6 F. de la Hoz, F. Vadillo increases as, i.e., as ξ. Since the boundar of stabilit grows faster than x, the ETDRK4 method should have a ver good behavior to solve dissipative equation, which confirms the results of paper [1]. A similar analsis is applicable to other dissipative equations like, for instance, the Kuramoto-Sivashinsk equation or the Allen-Cahn equation of [4] or [1], where h = 1/4. In our first example, we consider p = and the initial condition u (x) = 6.exp( x ), (13) which is smmetric with respect to the origin and has a single maximum at x =, hence satisfing the hpotheses of [9] under which the asmptotic behavior is known. On the left-hand side of figure we have displaed the evolution of this initial condition from t = to t =.9; a bit later, u(,1) The computer time was about 1.83 seconds. On the other hand, on the right-hand side of figure, we have displaed the numerical solution at t =.99 with continuous line and the estimate from [9] with discontinuous line. The resemblances near the origin are evident t x Figure : Numerical solution with u (x) = 6.exp( x ) In the following case, we look for an example where the solution blows up in two points. In figure 3, we represent the numerical solutions for t 3. with the initial condition u (x) = 3exp( (x + 4) ) + exp( (x + 1) ) +.exp( 1(x 4) ). (14) On the right-hand side, we have drawn the solution at t = 3. and the initial condition. In this case we do not know the asmptotic estimates, but in theorem 3 of [9], the have proved an asmptotic behavior close to the Hermite polnomials; in fact, the shape of the plot is similar to that of H 4 (x) (see figure 17.3 of []), although we ignore the scale that should be applied. Bearing in mind the good behavior of our simulation for the one-dimensional problem and the fact that MATLAB c also implements higher dimensional discrete Fourier transforms and their inverses (in two variables, we havefft andifft), we thought that small modifications of our program would allow us to simulate the blow-up for the semi-lineal parabolic equation in two space variables: u t = u xx + u + u p, p > 1, (x,) R,t >. (1) 6

7 Exponential time differencing methods for nonlinear PDEs Figure 3: Numerical solution for initial condition (14) In this case, the critical exponent is p c =, so we have taken p = 1. for our numerical experiments. For the sake of space, we onl displa one numerical example. In figure 4, we can observe the evolution of the initial condition u (x,) = 1exp( 1((x + 1) + ( + 1) ) + 1exp( 1((x 1) + ( 1) ), (16) which is smmetric respect to the origin. Figure 4: Numerical solution for initial condition (16) In the reader can find the movies corresponding to the previous experiments, as well as the original MATLAB c code etdrk4dchoise.m, which offers the option to introduce other initial conditions. 7

8 F. de la Hoz, F. Vadillo Acknowledgments This work was supported b MEC (Spain) with project MTM7-6186, and b the Basque Government with project IT-3-7. References [1] G. Belkin, J.M. Keiser, L. Vozovoi, A New Class of Time Discretization Schemes for the Solution of Nonlinear PDEs, J. Comput. Phs. (1998), 147, [] J.P. Bod, Chebshev and Fourier Spectral Methods. Second Edition (Revised), Dover, 1. [3] C. Canuto, M.Y. Hussain, A. Quarteroni, T.A. Zang, Spectral Methods in Fluid Dnamics, Springer, [4] S.M. Cox, P.C. Matthews, Exponential Time Differencing for Stiff Sstems, J. Comput. Phs. 176 (), pp [] Q. Du, W. Zhu, Analsis and Applications of the Exponential Time Differencing Schemes and their Contour Integration Modifications, BIT Numerical Mathematics (), 4, [6] B. Fornberg, A Practical Guide to Pseudospectral Methods, Cambridge Universit Press, [7] B. Fornberg, T.A. Driscoll, A fast spectral algorithm for nonlinear wave equations with linear dispersion, J. Comput. Phs. (1999), 1, [8] D. Gottlieb, S.A. Orszag, Numerical Analsis of Spectral Methods: Theor and Applications, SIAM, [9] M.A. Herrero, J.J.L. Velázquez, Blow-up behavior of one-dimensional semilinear parabolic equations, Ann. Inst. H. Poincaré (1993), 1, [1] F. de la Hoz, F. Vadillo, An exponential time differencing method for the nonlinear Schrödinger equation, Comput. Phs. Commun. 179 (8), pp [11] F. de la Hoz, F. Vadillo, A numerical simulation for the blow-up of semi-linear diffusion equations, Int. J. Comput. Math. 86 (9), pp [1] A. Kassam, L.N. Trefethen, Fourth-Order Time Stepping for Stiff PDEs, SIAM J. Sci. Comput. 6 (), pp [13] H.A. Levine, The role of critical exponents in blow-up theorems, SIAM Review (199), 3, [14] D.R. Mott, E.S. Oran, B. van Leer, A Quasi-Stead-State Solver for the Stiff Ordinar Differential Equations of Reaction Kinetics, J. Comput. Phs. (), no. 164, [1] A. Taflove, Computational Electrodnamics: The Finite Difference Time-Domain Method, Artech House, Boston, 199. [16] L.N. Trefethen, Spectral Methods in MATLAB, SIAM,. 8

Numerical Study of Oscillatory Regimes in the KP equation

Numerical Study of Oscillatory Regimes in the KP equation Numerical Study of Oscillatory Regimes in the KP equation C. Klein, MPI for Mathematics in the Sciences, Leipzig, with C. Sparber, P. Markowich, Vienna, math-ph/"#"$"%& C. Sparber (generalized KP), personal-homepages.mis.mpg.de/klein/

More information

Exponential integrators and functions of the matrix exponential

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

More information

Spectral Methods for Reaction Diffusion Systems

Spectral Methods for Reaction Diffusion Systems WDS'13 Proceedings of Contributed Papers, Part I, 97 101, 2013. ISBN 978-80-7378-250-4 MATFYZPRESS Spectral Methods for Reaction Diffusion Systems V. Rybář Institute of Mathematics of the Academy of Sciences

More information

Exponential Time Differencing for Stiff Systems

Exponential Time Differencing for Stiff Systems Journal of Computational Physics 176, 43 455 (22) doi:1.16/jcph.22.6995, available online at http://www.idealibrary.com on Exponential Time Differencing for Stiff Systems S. M. Cox and P. C. Matthews School

More information

Numerical Solution of the Generalized Burgers-Huxley Equation by Exponential Time Differencing Scheme

Numerical Solution of the Generalized Burgers-Huxley Equation by Exponential Time Differencing Scheme International Journal of Bioinformatics and Biomedical Engineering Vol., No., 5, pp. 3-5 http://www.aiscience.org/journal/ijbbe Numerical Solution of the Generalized Burgers-Huxley Equation by Exponential

More information

Francisco de la Hoz 1. Introduction

Francisco de la Hoz 1. Introduction ESAIM: PROCEEDINGS, March 212, Vol. 35, p. 216-221 Fédération Denis Poisson Orléans-Tours et E. Trélat UPMC, Editors A MATRIX-BASED NUMERICAL METHOD FOR THE SIMULATION OF THE TWO-DIMENSIONAL SINE-GORDON

More information

Blow-up collocation solutions of nonlinear homogeneous Volterra integral equations

Blow-up collocation solutions of nonlinear homogeneous Volterra integral equations Blow-up collocation solutions of nonlinear homogeneous Volterra integral equations R. Benítez 1,, V. J. Bolós 2, 1 Dpto. Matemáticas, Centro Universitario de Plasencia, Universidad de Extremadura. Avda.

More information

COMPACT IMPLICIT INTEGRATION FACTOR METHODS FOR A FAMILY OF SEMILINEAR FOURTH-ORDER PARABOLIC EQUATIONS. Lili Ju. Xinfeng Liu.

COMPACT IMPLICIT INTEGRATION FACTOR METHODS FOR A FAMILY OF SEMILINEAR FOURTH-ORDER PARABOLIC EQUATIONS. Lili Ju. Xinfeng Liu. DISCRETE AND CONTINUOUS doi:13934/dcdsb214191667 DYNAMICAL SYSTEMS SERIES B Volume 19, Number 6, August 214 pp 1667 1687 COMPACT IMPLICIT INTEGRATION FACTOR METHODS FOR A FAMILY OF SEMILINEAR FOURTH-ORDER

More information

Convex ENO Schemes for Hamilton-Jacobi Equations

Convex ENO Schemes for Hamilton-Jacobi Equations Convex ENO Schemes for Hamilton-Jacobi Equations Chi-Tien Lin Dedicated to our friend, Xu-Dong Liu, notre Xu-Dong. Abstract. In one dimension, viscosit solutions of Hamilton-Jacobi (HJ equations can be

More information

Discontinuous Galerkin method for a class of elliptic multi-scale problems

Discontinuous Galerkin method for a class of elliptic multi-scale problems INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 000; 00: 6 [Version: 00/09/8 v.0] Discontinuous Galerkin method for a class of elliptic multi-scale problems Ling Yuan

More information

Solving Variable-Coefficient Fourth-Order ODEs with Polynomial Nonlinearity by Symmetric Homotopy Method

Solving Variable-Coefficient Fourth-Order ODEs with Polynomial Nonlinearity by Symmetric Homotopy Method Applied and Computational Mathematics 218; 7(2): 58-7 http://www.sciencepublishinggroup.com/j/acm doi: 1.11648/j.acm.21872.14 ISSN: 2328-565 (Print); ISSN: 2328-5613 (Online) Solving Variable-Coefficient

More information

Examples and counterexamples for Markus-Yamabe and LaSalle global asymptotic stability problems Anna Cima, Armengol Gasull and Francesc Mañosas

Examples and counterexamples for Markus-Yamabe and LaSalle global asymptotic stability problems Anna Cima, Armengol Gasull and Francesc Mañosas Proceedings of the International Workshop Future Directions in Difference Equations. June 13-17, 2011, Vigo, Spain. PAGES 89 96 Examples and counterexamples for Markus-Yamabe and LaSalle global asmptotic

More information

Symmetry reductions and exact solutions for the Vakhnenko equation

Symmetry reductions and exact solutions for the Vakhnenko equation XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, 1-5 septiembre 009 (pp. 1 6) Symmetry reductions and exact solutions for the Vakhnenko equation M.L.

More information

ENGI 9420 Engineering Analysis Solutions to Additional Exercises

ENGI 9420 Engineering Analysis Solutions to Additional Exercises ENGI 940 Engineering Analsis Solutions to Additional Exercises 0 Fall [Partial differential equations; Chapter 8] The function ux (, ) satisfies u u u + = 0, subject to the x x u x,0 = u x, =. Classif

More information

Ordinary Differential Equations n

Ordinary Differential Equations n Numerical Analsis MTH63 Ordinar Differential Equations Introduction Talor Series Euler Method Runge-Kutta Method Predictor Corrector Method Introduction Man problems in science and engineering when formulated

More information

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions Applied Mathematical Sciences, Vol. 1, 2007, no. 5, 211-218 Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions M. Javidi a and A. Golbabai b a Department

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

Appendix 2 Complex Analysis

Appendix 2 Complex Analysis Appendix Complex Analsis This section is intended to review several important theorems and definitions from complex analsis. Analtic function Let f be a complex variable function of a complex value, i.e.

More information

Stability Analysis for Linear Systems under State Constraints

Stability Analysis for Linear Systems under State Constraints Stabilit Analsis for Linear Sstems under State Constraints Haijun Fang Abstract This paper revisits the problem of stabilit analsis for linear sstems under state constraints New and less conservative sufficient

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

Krylov Integration Factor Method on Sparse Grids for High Spatial Dimension Convection Diffusion Equations

Krylov Integration Factor Method on Sparse Grids for High Spatial Dimension Convection Diffusion Equations DOI.7/s95-6-6-7 Krlov Integration Factor Method on Sparse Grids for High Spatial Dimension Convection Diffusion Equations Dong Lu Yong-Tao Zhang Received: September 5 / Revised: 9 March 6 / Accepted: 8

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

Efficient time discretization for local discontinuous Galerkin methods

Efficient time discretization for local discontinuous Galerkin methods Efficient time discretization for local discontinuous Galerkin methods Yinhua Xia, Yan Xu and Chi-Wang Shu Abstract In this paper, we explore a few efficient time discretization techniques for the local

More information

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

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

More information

BACKWARD FOKKER-PLANCK EQUATION FOR DETERMINATION OF MODEL PREDICTABILITY WITH UNCERTAIN INITIAL ERRORS

BACKWARD FOKKER-PLANCK EQUATION FOR DETERMINATION OF MODEL PREDICTABILITY WITH UNCERTAIN INITIAL ERRORS BACKWARD FOKKER-PLANCK EQUATION FOR DETERMINATION OF MODEL PREDICTABILITY WITH UNCERTAIN INITIAL ERRORS. INTRODUCTION It is widel recognized that uncertaint in atmospheric and oceanic models can be traced

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

Lecture 2: Separable Ordinary Differential Equations

Lecture 2: Separable Ordinary Differential Equations Lecture : Separable Ordinar Differential Equations Dr. Michael Doughert Januar 8, 00 Some Terminolog: ODE s, PDE s, IVP s The differential equations we have looked at so far are called ordinar differential

More information

arxiv: v1 [math.ap] 29 Sep 2014

arxiv: v1 [math.ap] 29 Sep 2014 GENERIC SELF-SIMILAR BLOWUP FOR EQUIVARIANT WAVE MAPS AND YANG-MILLS FIELDS IN HIGHER DIMENSIONS arxiv:1409.8214v1 [math.ap] 29 Sep 2014 PAWE L BIERNAT AND PIOTR BIZOŃ Abstract. We consider equivariant

More information

Exponential integrators for semilinear parabolic problems

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

More information

Applications of Gauss-Radau and Gauss-Lobatto Numerical Integrations Over a Four Node Quadrilateral Finite Element

Applications of Gauss-Radau and Gauss-Lobatto Numerical Integrations Over a Four Node Quadrilateral Finite Element Avaiable online at www.banglaol.info angladesh J. Sci. Ind. Res. (), 77-86, 008 ANGLADESH JOURNAL OF SCIENTIFIC AND INDUSTRIAL RESEARCH CSIR E-mail: bsir07gmail.com Abstract Applications of Gauss-Radau

More information

Implicit Second Derivative Hybrid Linear Multistep Method with Nested Predictors for Ordinary Differential Equations

Implicit Second Derivative Hybrid Linear Multistep Method with Nested Predictors for Ordinary Differential Equations American Scientiic Research Journal or Engineering, Technolog, and Sciences (ASRJETS) ISSN (Print) -44, ISSN (Online) -44 Global Societ o Scientiic Research and Researchers http://asretsournal.org/ Implicit

More information

BASE VECTORS FOR SOLVING OF PARTIAL DIFFERENTIAL EQUATIONS

BASE VECTORS FOR SOLVING OF PARTIAL DIFFERENTIAL EQUATIONS BASE VECTORS FOR SOLVING OF PARTIAL DIFFERENTIAL EQUATIONS J. Roubal, V. Havlena Department of Control Engineering, Facult of Electrical Engineering, Czech Technical Universit in Prague Abstract The distributed

More information

OPTIMAL CONTROL FOR A PARABOLIC SYSTEM MODELLING CHEMOTAXIS

OPTIMAL CONTROL FOR A PARABOLIC SYSTEM MODELLING CHEMOTAXIS Trends in Mathematics Information Center for Mathematical Sciences Volume 6, Number 1, June, 23, Pages 45 49 OPTIMAL CONTROL FOR A PARABOLIC SYSTEM MODELLING CHEMOTAXIS SANG UK RYU Abstract. We stud the

More information

NONLINEAR DYNAMICS AND CHAOS. Numerical integration. Stability analysis

NONLINEAR DYNAMICS AND CHAOS. Numerical integration. Stability analysis LECTURE 3: FLOWS NONLINEAR DYNAMICS AND CHAOS Patrick E McSharr Sstems Analsis, Modelling & Prediction Group www.eng.o.ac.uk/samp patrick@mcsharr.net Tel: +44 83 74 Numerical integration Stabilit analsis

More information

arxiv: v2 [math.na] 6 Dec 2011

arxiv: v2 [math.na] 6 Dec 2011 FOURTH ORDER TIME-STEPPING FOR KADOMTSEV-PETVIASHVILI AND DAVEY-STEWARTSON EQUATIONS C. KLEIN AND K. ROIDOT arxiv:118.3345v [math.na] 6 Dec 11 Abstract. Purely dispersive partial differential equations

More information

Math 4381 / 6378 Symmetry Analysis

Math 4381 / 6378 Symmetry Analysis Math 438 / 6378 Smmetr Analsis Elementar ODE Review First Order Equations Ordinar differential equations of the form = F(x, ( are called first order ordinar differential equations. There are a variet of

More information

Exponential Integrators

Exponential Integrators Exponential Integrators John C. Bowman (University of Alberta) May 22, 2007 www.math.ualberta.ca/ bowman/talks 1 Exponential Integrators Outline Exponential Euler History Generalizations Stationary Green

More information

Instabilities of coupled density fronts

Instabilities of coupled density fronts and their nonlinear evolution in the two-laer rotating shallow water model. Influence of the lower laer and of the topograph. B. Ribstein and V. Zeitlin Laborator of Dnamical Meteorolog, Univ. P.et M.

More information

FINITE VOLUME METHODS FOR ONE-DIMENSIONAL SCALAR CONSERVATION LAWS

FINITE VOLUME METHODS FOR ONE-DIMENSIONAL SCALAR CONSERVATION LAWS 1.73 - COMPUTATIONAL METHODS FOR FLOW IN POROUS MEDIA Spring 009 FINITE VOLUME METHODS FOR ONE-DIMENSIONAL SCALAR CONSERVATION LAWS Luis Cueto-Felgueroso 1.1. Problem statement Consider the 1D scalar conservation

More information

ON OSCILLATIONS OF SOLUTIONS OF THE FOURTH-ORDER THIN FILM EQUATION NEAR HETEROCLINIC BIFURCATION POINT

ON OSCILLATIONS OF SOLUTIONS OF THE FOURTH-ORDER THIN FILM EQUATION NEAR HETEROCLINIC BIFURCATION POINT ON OSCILLATIONS OF SOLUTIONS OF THE FOURTH-ORDER THIN FILM EQUATION NEAR HETEROCLINIC BIFURCATION POINT V.A. GALAKTIONOV arxiv:3.76v [math.ap] Dec 3 Abstract. The behaviour of solutions of the Cauch problem

More information

Un algorithme numérique pour calculer la stabilité spatiale de modes éventuellement rayonnants : Application aux écoulements supersoniques

Un algorithme numérique pour calculer la stabilité spatiale de modes éventuellement rayonnants : Application aux écoulements supersoniques Un algorithme numérique pour calculer la stabilité spatiale de modes éventuellement raonnants : Application aux écoulements supersoniques R. Sabatini et C. Baill Ecole Centrale de Lon, Centre Acoustique

More information

Initial Value Problems for. Ordinary Differential Equations

Initial Value Problems for. Ordinary Differential Equations Initial Value Problems for Ordinar Differential Equations INTRODUCTION Equations which are composed of an unnown function and its derivatives are called differential equations. It becomes an initial value

More information

3 First order nonlinear equations

3 First order nonlinear equations Separable equations 3 First order nonlinear equations d f dx = where f(x,) is not (in general) a linear function of. ( x, ) The equation is autonomous if there is no explicit dependence on the independent

More information

arxiv:gr-qc/ v1 6 Sep 2006

arxiv:gr-qc/ v1 6 Sep 2006 Introduction to spectral methods Philippe Grandclément Laboratoire Univers et ses Théories, Observatoire de Paris, 5 place J. Janssen, 995 Meudon Cede, France This proceeding is intended to be a first

More information

From bell-shaped solitary wave to W/M-shaped solitary wave solutions in an integrable nonlinear wave equation

From bell-shaped solitary wave to W/M-shaped solitary wave solutions in an integrable nonlinear wave equation PRAMANA c Indian Academ of Sciences Vol. 74, No. journal of Januar 00 phsics pp. 9 6 From bell-shaped solitar wave to W/M-shaped solitar wave solutions in an integrable nonlinear wave equation AIYONG CHEN,,,

More information

METHODS IN Mathematica FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS. Keçiören, Ankara 06010, Turkey.

METHODS IN Mathematica FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS. Keçiören, Ankara 06010, Turkey. Mathematical and Computational Applications, Vol. 16, No. 4, pp. 784-796, 2011. Association for Scientific Research METHODS IN Mathematica FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS Ünal Göktaş 1 and

More information

A Fast Spectral Algorithm for Nonlinear Wave Equations with Linear Dispersion

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

More information

Multigrid finite element methods on semi-structured triangular grids

Multigrid finite element methods on semi-structured triangular grids XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, -5 septiembre 009 (pp. 8) Multigrid finite element methods on semi-structured triangular grids F.J.

More information

FOURTH ORDER TIME-STEPPING FOR KADOMTSEV PETVIASHVILI AND DAVEY STEWARTSON EQUATIONS

FOURTH ORDER TIME-STEPPING FOR KADOMTSEV PETVIASHVILI AND DAVEY STEWARTSON EQUATIONS SIAM J. SCI. COMPUT. Vol. 0, No. 0, pp. 000 000 c 0000 Society for Industrial and Applied Mathematics FOURTH ORDER TIME-STEPPING FOR KADOMTSEV PETVIASHVILI AND DAVEY STEWARTSON EQUATIONS C. KLEIN AND K.

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

* τσ σκ. Supporting Text. A. Stability Analysis of System 2

* τσ σκ. Supporting Text. A. Stability Analysis of System 2 Supporting Tet A. Stabilit Analsis of Sstem In this Appendi, we stud the stabilit of the equilibria of sstem. If we redefine the sstem as, T when -, then there are at most three equilibria: E,, E κ -,,

More information

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations

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

More information

Exponential Integrators

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

More information

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

Solitary Wave Solutions of KP equation, Cylindrical KP Equation and Spherical KP Equation

Solitary Wave Solutions of KP equation, Cylindrical KP Equation and Spherical KP Equation Commun. Theor. Phs. 67 (017) 07 11 Vol. 67 No. Februar 1 017 Solitar Wave Solutions of KP equation Clindrical KP Equation and Spherical KP Equation Xiang-Zheng Li ( 李向正 ) 1 Jin-Liang Zhang ( 张金良 ) 1 and

More information

Adomian Decomposition Method for Solving the Kuramoto Sivashinsky Equation

Adomian Decomposition Method for Solving the Kuramoto Sivashinsky Equation IOSR Journal of Mathematics (IOSR-JM) e-issn: 2278-5728, p-issn:2319-765x. Volume 1, Issue 1Ver. I. (Jan. 214), PP 8-12 Adomian Decomposition Method for Solving the Kuramoto Sivashinsky Equation Saad A.

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 high order Padé ADI method for unsteady convection-diffusion equations

A high order Padé ADI method for unsteady convection-diffusion equations Center for Turbulence Research Annual Research Briefs 2005 85 A high order Padé ADI method for unstead convection-diffusion equations B D. You 1. Motivation and objectives The unstead convection-diffusion

More information

RANGE CONTROL MPC APPROACH FOR TWO-DIMENSIONAL SYSTEM 1

RANGE CONTROL MPC APPROACH FOR TWO-DIMENSIONAL SYSTEM 1 RANGE CONTROL MPC APPROACH FOR TWO-DIMENSIONAL SYSTEM Jirka Roubal Vladimír Havlena Department of Control Engineering, Facult of Electrical Engineering, Czech Technical Universit in Prague Karlovo náměstí

More information

1462. Jacobi pseudo-spectral Galerkin method for second kind Volterra integro-differential equations with a weakly singular kernel

1462. Jacobi pseudo-spectral Galerkin method for second kind Volterra integro-differential equations with a weakly singular kernel 1462. Jacobi pseudo-spectral Galerkin method for second kind Volterra integro-differential equations with a weakly singular kernel Xiaoyong Zhang 1, Junlin Li 2 1 Shanghai Maritime University, Shanghai,

More information

Engineering Mathematics I

Engineering Mathematics I Engineering Mathematics I_ 017 Engineering Mathematics I 1. Introduction to Differential Equations Dr. Rami Zakaria Terminolog Differential Equation Ordinar Differential Equations Partial Differential

More information

Numerical Simulation of Stochastic Differential Equations: Lecture 2, Part 1. Recap: SDE. Euler Maruyama. Lecture 2, Part 1: Euler Maruyama

Numerical Simulation of Stochastic Differential Equations: Lecture 2, Part 1. Recap: SDE. Euler Maruyama. Lecture 2, Part 1: Euler Maruyama Numerical Simulation of Stochastic Differential Equations: Lecture, Part 1 Des Higham Department of Mathematics Universit of Strathclde Lecture, Part 1: Euler Maruama Definition of Euler Maruama Method

More information

Exponential Almost Runge-Kutta Methods for Semilinear Problems

Exponential Almost Runge-Kutta Methods for Semilinear Problems Exponential Almost Runge-Kutta Methods for Semilinear Problems John Carroll Eóin O Callaghan 9 January 3 Abstract We present a new class of one-step, multi-value Exponential Integrator (EI) methods referred

More information

n n. ( t) ( ) = = Ay ( ) a y

n n. ( t) ( ) = = Ay ( ) a y Sstems of ODE Example of sstem with ODE: = a+ a = a + a In general for a sstem of n ODE = a + a + + a n = a + a + + a n = a + a + + a n n n nn n n n Differentiation of matrix: ( t) ( t) t t = = t t ( t)

More information

Spectral Methods and Inverse Problems

Spectral Methods and Inverse Problems Spectral Methods and Inverse Problems Omid Khanmohamadi Department of Mathematics Florida State University Outline Outline 1 Fourier Spectral Methods Fourier Transforms Trigonometric Polynomial Interpolants

More information

A Bernstein-like operator for a mixed algebraic-trigonometric space

A Bernstein-like operator for a mixed algebraic-trigonometric space XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, 21-25 septiembre 2009 (pp. 1 7) A Bernstein-like operator for a mixed algebraic-trigonometric space

More information

Performance Evaluation of Generalized Polynomial Chaos

Performance Evaluation of Generalized Polynomial Chaos Performance Evaluation of Generalized Polynomial Chaos Dongbin Xiu, Didier Lucor, C.-H. Su, and George Em Karniadakis 1 Division of Applied Mathematics, Brown University, Providence, RI 02912, USA, gk@dam.brown.edu

More information

New approach to study the van der Pol equation for large damping

New approach to study the van der Pol equation for large damping Electronic Journal of Qualitative Theor of Differential Equations 2018, No. 8, 1 10; https://doi.org/10.1422/ejqtde.2018.1.8 www.math.u-szeged.hu/ejqtde/ New approach to stud the van der Pol equation for

More information

Two Dimensional Linear Systems of ODEs

Two Dimensional Linear Systems of ODEs 34 CHAPTER 3 Two Dimensional Linear Sstems of ODEs A first-der, autonomous, homogeneous linear sstem of two ODEs has the fm x t ax + b, t cx + d where a, b, c, d are real constants The matrix fm is 31

More information

Experimental Calibration and Head Loss Prediction of Tuned Liquid Column Damper

Experimental Calibration and Head Loss Prediction of Tuned Liquid Column Damper Tamkang Journal of Science and Engineering, Vol. 8, No 4, pp. 319-35 (005) 319 Experimental Calibration and Head Loss Prediction of Tuned Liquid Column Damper Jong-Cheng Wu Department of Civil Engineering,

More information

MEMORIAL UNIVERSITY OF NEWFOUNDLAND

MEMORIAL UNIVERSITY OF NEWFOUNDLAND MEMORIAL UNIVERSITY OF NEWFOUNDLAND DEPARTMENT OF MATHEMATICS AND STATISTICS Volumes Math 11 Winter 17 SOLUTIONS 1. (a) i. The axis of smmetr is a horizontal line, so we integrate with respect to x. The

More information

SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA

SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA Pavel Trojovský Jaroslav Seibert Antonín Slabý ABSTRACT Ever future teacher of mathematics

More information

NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET. Solving the nonlinear Schödinger equation using exponential integrators PREPRINT NUMERICS NO.

NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET. Solving the nonlinear Schödinger equation using exponential integrators PREPRINT NUMERICS NO. NORGES TEKNISK-NATURVITENSKAPELIGE UNIVERSITET Solving the nonlinear Schödinger equation using exponential integrators by Håvard Berland and Bård Skaflestad PREPRINT NUMERICS NO. 5/2005 NORWEGIAN UNIVERSITY

More information

Math 2930 Worksheet Equilibria and Stability

Math 2930 Worksheet Equilibria and Stability Math 2930 Worksheet Equilibria and Stabilit Week 3 September 7, 2017 Question 1. (a) Let C be the temperature (in Fahrenheit) of a cup of coffee that is cooling off to room temperature. Which of the following

More information

On Solving Systems of ODEs Numerically

On Solving Systems of ODEs Numerically On Solving Sstems of ODEs Numericall Temple H. Fa, Stephan V. Joubert, and Andrew Mkolesia Department of Mathematical Technolog Tshwane Universit of Technolog Private Bag x680 Pretoria 0001 SOUTH AFRICA

More information

Elliptic Equations. Chapter Definitions. Contents. 4.2 Properties of Laplace s and Poisson s Equations

Elliptic Equations. Chapter Definitions. Contents. 4.2 Properties of Laplace s and Poisson s Equations 5 4. Properties of Laplace s and Poisson s Equations Chapter 4 Elliptic Equations Contents. Neumann conditions the normal derivative, / = n u is prescribed on the boundar second BP. In this case we have

More information

Lotka Volterra Model with Time Delay

Lotka Volterra Model with Time Delay International Journal of Mathematics Research. ISSN 976-584 Volume 6, Number (4), pp. 5- International Research Publication House http://www.irphouse.com Lotka Volterra Model with Time Dela Tapas Kumar

More information

INTRODUCTION TO DIFFERENTIAL EQUATIONS

INTRODUCTION TO DIFFERENTIAL EQUATIONS INTRODUCTION TO DIFFERENTIAL EQUATIONS. Definitions and Terminolog. Initial-Value Problems.3 Differential Equations as Mathematical Models CHAPTER IN REVIEW The words differential and equations certainl

More information

2 Ordinary Differential Equations: Initial Value Problems

2 Ordinary Differential Equations: Initial Value Problems Ordinar Differential Equations: Initial Value Problems Read sections 9., (9. for information), 9.3, 9.3., 9.3. (up to p. 396), 9.3.6. Review questions 9.3, 9.4, 9.8, 9.9, 9.4 9.6.. Two Examples.. Foxes

More information

Stability of plane Poiseuille Couette flows of a piezo-viscous fluid

Stability of plane Poiseuille Couette flows of a piezo-viscous fluid Stabilit of plane Poiseuille Couette flows of a piezo-viscous fluid Thien Duc Tran a and Serge A. Suslov b, a Computational Engineering and Science Research Centre, Universit of Southern Queensland, Toowoomba,

More information

Fast waves during transient flow in an asymmetric channel

Fast waves during transient flow in an asymmetric channel Int. Conference on Boundar and Interior Laers BAIL 6 G. Lube, G. Rapin (Eds) c Universit of Göttingen, German, 6. Introduction Fast waves during transient flow in an asmmetric channel Dick Kachuma & Ian

More information

An improved ADI-DQM based on Bernstein polynomial for solving two-dimensional convection-diffusion equations

An improved ADI-DQM based on Bernstein polynomial for solving two-dimensional convection-diffusion equations Mathematical Theor and Modeling ISSN -50 (Paper) ISSN 5-05(Online) Vol 3, No.1, 013 An improved ADI-DQM based on Bernstein polnomial for solving two-dimensional convection-diffusion equations A.S.J. Al-

More information

PICONE S IDENTITY FOR A SYSTEM OF FIRST-ORDER NONLINEAR PARTIAL DIFFERENTIAL EQUATIONS

PICONE S IDENTITY FOR A SYSTEM OF FIRST-ORDER NONLINEAR PARTIAL DIFFERENTIAL EQUATIONS Electronic Journal of Differential Equations, Vol. 2013 (2013), No. 143, pp. 1 7. ISSN: 1072-6691. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu ftp ejde.math.txstate.edu PICONE S IDENTITY

More information

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

The Hopf Bifurcation Theorem: Abstract. Introduction. Transversality condition; the eigenvalues cross the imginary axis with non-zero speed

The Hopf Bifurcation Theorem: Abstract. Introduction. Transversality condition; the eigenvalues cross the imginary axis with non-zero speed Supercritical and Subcritical Hopf Bifurcations in Non Linear Maps Tarini Kumar Dutta, Department of Mathematics, Gauhati Universit Pramila Kumari Prajapati, Department of Mathematics, Gauhati Universit

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

A Meshless Simulations for 2D Nonlinear Reaction-diffusion Brusselator System

A Meshless Simulations for 2D Nonlinear Reaction-diffusion Brusselator System Copright 3 Tech Science Press CMES, vol.95, no.4, pp.59-8, 3 A Meshless Simulations for D Nonlinear Reaction-diffusion Brusselator Sstem Ahmad Shirzadi, Vladimir Sladek, Jan Sladek 3 Abstract: This paper

More information

A Numerical Algorithm for Ambrosetti-Prodi Type Operators

A Numerical Algorithm for Ambrosetti-Prodi Type Operators A Numerical Algorithm for Ambrosetti-Prodi Tpe Operators José Teieira Cal Neto and Carlos Tomei March 9, Abstract We consider the numerical solution of the equation u f(u) = g, for the unknown u satisfing

More information

Numerical resolution of discontinuous Galerkin methods for time dependent. wave equations 1. Abstract

Numerical resolution of discontinuous Galerkin methods for time dependent. wave equations 1. Abstract Numerical resolution of discontinuous Galerkin methods for time dependent wave equations Xinghui Zhong 2 and Chi-Wang Shu Abstract The discontinuous Galerkin DG method is known to provide good wave resolution

More information

1. First-order ODE s

1. First-order ODE s 18.03 EXERCISES 1. First-order ODE s 1A. Introduction; Separation of Variables 1A-1. Verif that each of the following ODE s has the indicated solutions (c i,a are constants): a) 2 + = 0, = c 1 e x +c 2

More information

10 Back to planar nonlinear systems

10 Back to planar nonlinear systems 10 Back to planar nonlinear sstems 10.1 Near the equilibria Recall that I started talking about the Lotka Volterra model as a motivation to stud sstems of two first order autonomous equations of the form

More information

Associativity of triangular norms in light of web geometry

Associativity of triangular norms in light of web geometry Associativit of triangular norms in light of web geometr Milan Petrík 1,2 Peter Sarkoci 3 1. Institute of Computer Science, Academ of Sciences of the Czech Republic, Prague, Czech Republic 2. Center for

More information

A NOTE ON THE DYNAMICS AROUND THE L 1,2 LAGRANGE POINTS OF THE EARTH MOON SYSTEM IN A COMPLETE SOLAR SYSTEM MODEL

A NOTE ON THE DYNAMICS AROUND THE L 1,2 LAGRANGE POINTS OF THE EARTH MOON SYSTEM IN A COMPLETE SOLAR SYSTEM MODEL IAA-AAS-DCoSS1-8-8 A NOTE ON THE DYNAMICS AROUND THE L 1,2 LAGRANGE POINTS OF THE EARTH MOON SYSTEM IN A COMPLETE SOLAR SYSTEM MODEL Lian Yijun, Gerard Góme, Josep J. Masdemont, Tang Guojian INTRODUCTION

More information

Dynamics of multiple pendula without gravity

Dynamics of multiple pendula without gravity Chaotic Modeling and Simulation (CMSIM) 1: 57 67, 014 Dnamics of multiple pendula without gravit Wojciech Szumiński Institute of Phsics, Universit of Zielona Góra, Poland (E-mail: uz88szuminski@gmail.com)

More information

Applications of Lie group integrators and exponential schemes

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

More information

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

A New Augmented Singular Transform and its Partial Newton-Correction Method for Finding More Solutions to p-laplacian Differential Equation

A New Augmented Singular Transform and its Partial Newton-Correction Method for Finding More Solutions to p-laplacian Differential Equation A New Augmented Singular Transform and its Partial Newton-Correction Method for Finding More Solutions to p-laplacian Differential Equation Zhaoiang Li, Zhi-Qiang Wang and Jianin Zhou Abstract In this

More information

MAT 1275: Introduction to Mathematical Analysis. Graphs and Simplest Equations for Basic Trigonometric Functions. y=sin( x) Function

MAT 1275: Introduction to Mathematical Analysis. Graphs and Simplest Equations for Basic Trigonometric Functions. y=sin( x) Function MAT 275: Introduction to Mathematical Analsis Dr. A. Rozenblum Graphs and Simplest Equations for Basic Trigonometric Functions We consider here three basic functions: sine, cosine and tangent. For them,

More information

Subband Coding and Wavelets. National Chiao Tung University Chun-Jen Tsai 12/04/2014

Subband Coding and Wavelets. National Chiao Tung University Chun-Jen Tsai 12/04/2014 Subband Coding and Wavelets National Chiao Tung Universit Chun-Jen Tsai /4/4 Concept of Subband Coding In transform coding, we use N (or N N) samples as the data transform unit Transform coefficients are

More information

L O N G I T U D I N A L V O R T I C E S I N G R A N U L A R F L O W S

L O N G I T U D I N A L V O R T I C E S I N G R A N U L A R F L O W S L O N G I T U D I N A L V O R T I C E S I N G R A N U L A R F L O W S Yoël FORTERRE, Olivier POULIQUEN Institut Universitaire des Sstèmes Thermiques et Industriels (UMR 6595 CNRS) 5, rue Enrico Fermi 13453

More information