Numerical solution of General Rosenau-RLW Equation using Quintic B-splines Collocation Method

Size: px
Start display at page:

Download "Numerical solution of General Rosenau-RLW Equation using Quintic B-splines Collocation Method"

Transcription

1 Available online at Volume 2012, Year 2012 Article ID cna-00129, 16 pages doi: /2012/cna Research Article Numerical solution of General Rosenau-RLW Equation using Quintic B-splines Collocation Method R.C. Mittal 1, R.K. Jain 2 (1) Department of Mathematics, Indian Institute of Technology Roorkee, Roorkee , Uttarakhand, India (2) Department of Mathematics, Indian Institute of Technology Roorkee, Roorkee , Uttarakhand, India Copyright 2012 c R.C. Mittal and R.K. Jain. This is an open access article distributed under the Creative Commons Attribution License, which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited. Abstract In this paper a numerical method is proposed to approximate the solution of the nonlinear general Rosenau-RLW Equation. The method is based on collocation of quintic B-splines over finite elements so that we have continuity of the dependent variable and its first four derivatives throughout the solution range. We apply quintic B-splines for spatial variable and derivatives which produce a system of first order ordinary differential equations. We solve this system by using SSP-RK54 scheme. This method needs less storage space that causes to less accumulation of numerical errors. The numerical approximate solutions to the nonlinear general Rosenau-RLW Equation have been computed without transforming the equation and without using the linearization. Illustrative example is included for different value of p = 2, 3 and 6, to demonstrate the validity and applicability of the technique. Easy and economical implementation is the strength of this method. Keywords: general Rosenau-RLW Equation; quintic B-splines basis functions; SSP-RK54 scheme; Thomas algorithm. Corresponding author. address: rkjain 2000@rediffmail.com Tel:

2 1 Introduction In this paper, we consider the following initial-boundary value problem of the general Rosenau-RLW equation: u t u xxt + u xxxxt + u x + (u p ) x = 0, a < x < b, 0 < t < T (1.1) with an initial condition and boundary conditions u(x, 0) = u 0 (x) (1.2) u(a, t) = u(b, t) = 0, u xx (a, t) = u xx (b, t) = 0, 0 < t < T. (1.3) where p 2 is an integer and u 0 (x) is a known smooth function. When p = 2, equation (1.1) is called as usual Rosenau-RLW equation. When p = 3, it is called as modified Rosenau-RLW (MRosenau-RLW) equation. The initial boundary value problem (1.1) - (1.3) possesses the following conservative quantities: I 2 = 1 2 I 1 = 1 2 b a b a udx (1.4) (u 2 + u 2 x + u 2 xx)dx (1.5) related to mass and energy. We know that the ability to preserve some invariant properties of the original differential equation is a criterion to judge the success of a numerical simulation. The quantities I 1 and I 2 are applied to measure the conservation properties of the present method, calculated by trapezoidal rule for Rosenau-RLW equation. Some of the previous works on the GRLW equation are inclusive of an implicit secondorder accurate and stable energy preserving finite difference method based on the use of central difference equations for the time and space derivatives [23], the method of lines based on the discretization of the spatial derivatives by means of Fourier pseudo-spectral approximations [11], the Fourier spectral method for the initial value problem of the GRLW equation [12] and a linearized implicit pseudo-spectral method [4]. For p = 1, this equation reduces to the regularized long wave (RLW) equation as an important equation in physics media describing phenomena with weak nonlinearity and dispersion waves. Various numerical techniques such as the finite element methods based on least square principle [1, 2, 9], finite element methods based on Galerkin and collocation principles [5, 7, 20, 22, 3, 24, 18, 8], Petrov-Galerkin method [6] and Reduced Differential Transform Method [15] have been devised to find numerical solutions of the RLW equation. RBF collocation method has been developed for numerical simulation of GEW equation in [17]. The other special case of the GRLW equation is the modified regularized long wave (MRLW) equation for p = 2. MRLW equation was solved numerically by the collocation method with quintic B-splines [10, 19] and cubic B-splines [11] finite element method. 2 ISPACS GmbH

3 Recently, Zuo et al. [24], developed a numerical scheme for solving (1.1) - (1.3) using conservative finite difference method. Existence of its difference solutions have proved by Brouwer fixed point theorem. They have shown that general Rosenau-RLW Equation possesses conservative quantities. They have also proved by the discrete energy method that the scheme is uniquely solvable, unconditionally stable, and second-order convergent. Pan et al. [16] developed a three level finite difference scheme for usual Rosenau-RLW equation. They have discussed the second order convergence of their scheme by discrete energy method. In this paper, we present a new method to the solution of Rosenau-RLW equation. The method is based on quintic B-splines basis functions for solving equation (1.1) - (1.3).We knows that B-splines have some special features which are useful in numerical work. One feature is that the continuity conditions are inherent, other special feature of B-splines is that they have small local support, i.e. each B-spline function is only non-zero over a few mesh subintervals, so that the resulting matrix for the discretization equation is tightly banded. Due to their smoothness and capability to handle local phenomena, B-splines offer distinct advantages. In combination with collocation, this significantly simplifies the solution procedure of differential equations. There is a great reduction of the numerical effort, because there is no need to calculate the integrals (like in variational methods) in order to form the final set of algebraic equations, which substitutes the given set of nonlinear differential equations. Unlike some previous techniques using various transformations to reduce the equation into more simple equation, the current method does not require extra effort to deal with the nonlinear terms. Therefore the equations are solved easily and elegantly using the present method. This method has also additional advantages over some rival techniques, ease in use and computational cost effectiveness in order to find solutions of the given nonlinear evolution equations. In the present method, the combination of the quintic B-spline collocation method in space with the low-storage fourth-order total variation diminishing SSP-RK54 scheme in time provides an efficient explicit solution with high accuracy and minimal computational effort for the problems represented by (1.1) - (1.3). This paper is organized as follows. In Section 2, description of quintic B-splines collocation method is explained. In Section 3, procedure for implementation of present method is described for equation (1.1) - (1.3). In Section 4, procedure to obtain initial vector which is required to start our method is explained. We present numerical example for different values of p to establish the adaptability of the present method computationally in Section 5. Conclusion is given in Section 6 that briefly summarizes the numerical outcomes. 2 Description of Method In quintic B-splines collocation method the approximate solution can be written as a linear combination of basis functions which constitute a basis for the approximation space under consideration. We consider a mesh a = x 0 < x 1,..., x N 1 < x N = b as a uniform partition of the solution domain a x b by the knots x j with h = x j x j 1, j = 1,... N. Our numerical treatment for solving equation (1.1) using the collocation method with quintic B-spline is to find an approximate solution U N (x, t) to the exact solution u(x, t) in the form: 3 ISPACS GmbH

4 U N (x, t) = N+2 j= 2 c j (t)b j (x) (2.6) where c j (t) are time dependent quantities to be determined from the boundary conditions and collocation from the differential equation. The quintic B-spline B j (x) at the knots is given by [13]. (x x j 3 ) 5, x [x j 3, x j 2 ) (x x j 3 ) 5 6(x x j 2 ) 5, x [x j 2, x j 1 ) B j (x) = 1 (x x j 3 ) 5 6(x x j 2 ) (x x j 1 ) 5, x [x j 1, x j ) h 5 (x j+3 x) 5 6(x j+2 x) (x j+1 x) 5, x [x j, x j+1 ) (x j+3 x) 5 6(x j+2 x) 5, x [x j+1, x j+2 ) (x j+3 x) 5, x [x j+2, x j+3 ) 0, otherwise (2.7) Where B 2, B 1, B 0, B 1,...,B N 1, B N, B N+1, B N+2 forms a basis over the region of solution domain a x b. Each quintic B-spline cover six elements so that each element is covered by six quintic B-splines. The values of B j (x) and its derivative may be tabulated as in Table- 1. TABLE-1 Coefficient of quintic B-splines and derivatives at nodes x j x x j 3 x j 2 x j 1 x j x j+1 x j+2 x j+3 B j (x) B j (x) 0 5 h B j (x) h 2 h 2 B j (x) 0 60 h 3 B iv j (x) h h 0 h h 2 h h 3 h h 4 h h h 0 h h 3 0 h 4 Using approximate function (2.6) and quintic B-spline functions (2.7), the approximate values of U N (x, t) and its four derivatives at the knots are determined in terms of the time parameters c j as follows: U j = c j c j c j + 26c j+1 + c j+2 hu j = 5(c j c j+1 10c j 1 c j 2 ) h 2 U j = 20(c j 2 + 2c j 1 6c j + 2c j+1 + c j+2 ) h 3 U j = 60(c j+2 2c j+1 + 2c j 1 c j 2 ) h 4 U iv j = 120(c j 2 4c j 1 + 6c j 4c j+1 + c j+2 ) (2.8) 3 Implementation of Method Our numerical treatment for solving equation (1.1) using the collocation method with quintic B-splines is to find an approximate solution U N (x, t) to the exact solution u(x, t) 4 ISPACS GmbH

5 is given in (2.6), where c j (t) are time dependent quantities to be determined from the boundary conditions and collocation from the differential equation. From equation (1.1), we have Now, using (2.6) in (3.9), we get u t u xxt + u xxxxt = u x pu p 1 u x (3.9) N+2 j= 2 N+2 j= 2 N+2 c j B j (x) j= 2 N+2 c j B j(x) p{ j= 2 c j B j (x) + N+2 j= 2 N+2 c j B j (x)} p 1 j= 2 c j B iv j (x) = c j B j(x)} (3.10) Using approximates function (2.6) and quintic B-splines functions (2.7), the approximate values of Ut N (x) and its four derivatives at the knots/nodes are determined in terms of the time parameters c j as follows: (U j ) t = ċ j ċ j ċ j + 26ċ j+1 + ċ j+2 h(u j) t = 5(ċ j ċ j+1 10ċ j 1 ċ j 2 ) h 2 (U j ) t = 20(ċ j 2 + 2ċ j 1 6ċ j + 2ċ j+1 + ċ j+2 ) h 3 (U j ) t = 60(ċ j+2 2ċ j+1 + 2ċ j 1 ċ j 2 ) h 4 (U iv j ) t = 120(ċ j 2 4ċ j 1 + 6ċ j 4ċ j+1 + ċ j+2 ) (3.11) Using (2.7),(2.8) and (3.11) in (3.10) we get a system of ordinary differential equations as follows: (ċ j ċ j ċ j + 26ċ j+1 + ċ j+2 ) 20 h 2 (ċ j 2 + 2ċ j 1 6ċ j + 2ċ j+1 + ċ j+2 ) h 4 (ċ j 2 4ċ j 1 + 6ċ j 4ċ j+1 + ċ j+2 ) = 5 h (c j c j+1 10c j 1 c j 2 ) p(c j c j c j + 26c j+1 + c j+2 ) p 1 5 h (c j c j+1 10c j 1 c j 2 ) On L.H.S. of (3.12) we substitute x = 1 20 h ; y = 26 h4 h ; z = 66 + h4 h h 4, and R.H.S. = ψ j, then equation (3.12) is written as, 0 j N (3.12) xċ j 2 + yċ j 1 + zċ j + yċ j+1 + xċ j+2 = ψ j (3.13) To eliminate ċ 2, ċ 1, ċ N+1, ċ N+2, c 2, c 1, c N+1 and c N+2, we consider boundary condition for collocation as follows: u(a, t) = 0, u(b, t) = 0, u xx (a, t) = 0, u xx (b, t) = 0 (3.14) 5 ISPACS GmbH

6 From (2.8), (3.11) and (3.14) we get ċ 2 = 12ċ 0 ċ 2, ċ 1 = 3ċ 0 ċ 1, ċ N+1 = 3ċ N ċ N 1, ċ N+2 = 12ċ N ċ N 2, c 2 = 12c 0 c 2, c 1 = 3c 0 c 2, c N+1 = 3c N c N 1, c N+2 = 12c N c N 2. (3.15) We eliminate ċ 2, ċ 1, ċ N+1, ċ N+2, c 2, c 1, c N+1 and c N+2 in (3.13) by using (3.7) then the system of first order differential equation can be written in compact form as where a 0 b 0 c 0 d 1 a 1 b 1 x A = x y z y x x y z y x x d N 1 a N 1 b N 1 e N d N a N AĊ = ψ (3.16), Ċ = a 0 = 12x 3y + z, b 0 = 0, c 0 = 0, ċ 0 ċ 1 ċ 2 ċ N 2 ċ N 1 ċ N, ψ = ψ 0 ψ 1 ψ 2 ψ N 2 ψ N 1 ψ N d 1 = 3x + y, a 1 = x + z, b 1 = y, d N 1 = 3x + y, a N 1 = x + z, b N 1 = y, ψ 0 = 5 h (18c c 1 + 2c 2 ); a N = 12x 3y + z, d N = 0, e N = 0, ψ 1 = 5 h ( 7c 0 +c 1 +10c 2 +c 3 ) p(23c 0 +65c 1 +26c 2 +c 3 ) p 1 ( 5 h )( 7c 0 +c 1 +10c 2 +c 3 ); ψ j = ( 5 h )(c j c j+1 10c j 1 c j 2 ) p(c j c j c j + 26c j+1 + c j+2 ) p 1 ( 5 h )(c j c j+1 10c j 1 c j 2 );for j = 2 to N 2 ψ N 1 = 5 h (7c N c N 1 10c N 2 c N 3 ) p(23c N +65c N 1 +26c N 2 +c N 3 ) p 1 ( 5 h )(7c N c N 1 10c N 2 c N 3 ); 6 ISPACS GmbH

7 ψ N = 5 h ( 18c N 20c N 1 2c N 2 ); Here A is (N + 1) (N + 1) penta-diagonal matrix Ċ and ψ are (N + 1) order vectors which depend on the boundary conditions. Now, we solve the first order ordinary differential equation system (3.8) by using SSP-RK54 scheme [21]. Once the parameter C 0 has been determined at a specified time level, we can compute the solution at the required knots. In (3.8), first we solve this system for vector Ċ by using a variant of Thomas algorithm only once at each time level t > 0 then we get a first order system of ordinary differential equations which can be solved for vector C by using SSP-RK54 scheme and consequently the solution U N (x, t) is completely known. 4 The initial vector C 0 The initial vector C 0 can be obtained from the initial condition and boundary values of the derivatives of the initial condition as the following expressions: U x (a, 0) = 0; U x (b, 0) = 0, U(x j, 0) = u 0 (x j ), forj = 2, N 2 U xx (a, 0) = 0; U xx (b, 0) = 0. This yields a (N + 1) (N + 1) system of equations, of the form where A = AC 0 = b (4.17) The solution of (4.17) can be found by Thomas algorithm., C 0 = 5 Numerical Experiments and Discussion c 0 0 c 0 1 c 0 2 c 0 N 2 c 0 N 1 c 0 N u 0 (x 0 ) u 0 (x 1 ) u 0 (x 2 ), b = u 0 (x N 2 ) u 0 (x N 1 ) u 0 (x N ) In order to show the utility and adaptability of the method, it is tested on the following test problem. In this section the proposed method is apply for different values of p. The accuracy of the scheme is measured by using the following error norms: L 2 = N h( 0 u exact j U num j 2 ) (5.18) 7 ISPACS GmbH

8 L = max u exact j U num j, 1 j N (5.19) Where u and U represent the exact and approximate solutions respectively and h is the minimum distance between any two points of set of points for which the errors are evaluated. Example: We consider Rosenau-RLW equation (1.1) whose exact solution is given as (p+3)(3p+1)(p+1) ln 2(p u(x, t) = exp[ 2 +3)(p 2 +4p+7) (p 1) ]sech 4 where c = p4 +4p 3 +14p 2 +20p+25 p 4 +4p 3 +10p 2 +12p+21. (p 1) p 1 [ (4p 2 +8p+20) (x ct)] Initial condition is extract from exact solution and boundary conditions are taken as u( 30, t) = 0, u(120, t) = 0, u xx ( 30, t) = 0, u xx (120, t) = 0. CASE-1 In first numerical simulation, we take p = 2, h = t = 0.1. We compute L and L 2 errors for different time levels and results are reported in Table- 2. We compare our results with Pan et. al. It is clearly seen that our results are much better than [16]. We also compute CPU time (in seconds) for different time levels. TABLE-2 : The errors of numerical solutions and CPU time for t 10 (p = 2, h = t = 0.1) Present Method Pan et al. [16] t L L 2 CPU time (in seconds) L [16] E E E E E E E E E E E E E E E 04 CASE-2 In second numerical simulation, we compute L and L 2 errors for different values of h with p = 2, t = 0.1 at t = 10 and calculate order of convergence using these error norms. The results are reported in Table- 3. We observe that present method is nearly of second order of convergence with respect to these error norms. We compare L errors with Pan et al. [16] and found that our results are much better. TABLE-3 : The errors of numerical solutions and order of convergence at t = 10 (p = 2, t = 0.1) Present Method Pan et al. [16] h L Order of Conv. L 2 Order of Conv. L [16] E E E E E E E E E E E E E E 06 8 ISPACS GmbH

9 CASE-3 In third numerical simulation, we compute L and L 2 errors for different values of h with p = 4, t = 0.1 at t = 60 and calculate order of convergence using these error norms. The results are reported in Table- 4.It is clearly seen that present method is of second order of convergence with respect to L error norm during simulation. TABLE-4 : The errors of numerical solutions and order of convergence at t = 60 (p = 4, t = 0.1) Present Method h L Order of Conv. L 2 Order of Conv E E E E E E E E E E CASE-4 In fourth numerical simulation, we compute L and L 2 errors and invariants for different time levels with p = 2 and h= t = 0.1. The results are reported in Table- 5. It is clearly seen that the invariants I 1 and I 2 remains constant during simulation. We also depicted numerical approximate and exact solutions at t = 0, 30 and 60 in Figure- 1 and 2 respectively. We also show the CPU time (in seconds) for present method. It is clearly seen that numerical solutions are in good agreement with exact solutions. We compare our results and figures with Zuo et. al [24]. TABLE-5 : The errors of numerical solutions, invariants and CPU time for t 60 (p = 2 and h = t = 0.1) t L L 2 I 1 I 2 CPU time (in seconds) E E E E E E E E E E E E [24] t = CASE-5 In fifth numerical simulation, we compute L and L 2 errors and invariants for different time levels with p = 3 and h= t = 0.1. The results are reported in Table- 6. It is clearly seen that the invariants I 1 and I 2 remains constant during simulation. We also depicted numerical approximate and exact solutions at t = 0, 30 and 60 in Figure- 3 and 4 respectively. We also show the CPU time (in seconds) for present method. It is clearly seen that numerical solutions are in good agreement with exact solutions. We compare our results and figures with Zuo et. al [24]. 9 ISPACS GmbH

10 TABLE-6 : The errors of numerical solutions, invariants and CPU time for t 60 (p = 3 and h = t = 0.1) t L L 2 I 1 I 2 CPU time (in seconds) E E E E E E E E E E E E Zuo et al. [24] t = CASE-6 In sixth numerical simulation, we compute L and L 2 errors and invariants for different time levels with p = 6 and h= t = 0.1. The results are reported in Table- 7. It is clearly seen that the invariants I 1 and I 2 remains constant during simulation. We also depicted numerical approximate and exact solutions at t = 0, 30 and 60 in Figure- 5 and 6 respectively. We also show the CPU time (in seconds) for present method. It is clearly seen that numerical solutions are in good agreement with exact solutions. We compare our results and figures with Zuo et. al [24]. TABLE-7 : The errors of numerical solutions, invariants and CPU time for t 60 (p = 6 and h = t = 0.1) t L L 2 I 1 I 2 CPU time (in seconds) E E E E E E E E E E E E [24] t = E Conclusion In this paper, we develop a collocation method for solving nonlinear general Rosenau-RLW equation with Dirichlet boundary conditions using quintic B-splines basis functions. In the present method we apply quintic B-splines for spatial variable and derivatives which produce a system of first order ordinary differential equations. The resulting systems of ordinary differential equations are solved by using SSP-RK54 scheme. The numerical approximate solutions to nonlinear general Rosenau-RLW equation have been computed without transforming the equation and without using the linearization. This method is tested for different values of p = 2, 3 and 6 and the numerical results obtained are quite satisfactory and comparable with the existing solutions found in literature. Easy and economical implementation is the strength of this method. The computed results justify the advantage of this method. 10 ISPACS GmbH

11 11 ISPACS GmbH

12 12 ISPACS GmbH

13 13 ISPACS GmbH

14 Acknowledgment One of the authors R.K. Jain thankfully acknowledges the sponsorship under QIP, provided by Technical Education and Training Department, Bhopal (M.P.), India. The authors are very thankful to the reviewers for their valuable suggestions to improve the quality of the paper. References [1] I. Dag, Approximation of the RLW equation by the least square cubic B-spline finite element method, Appl. Math. Model. 25 (2001) [2] I. Dag, A. Dogan and B. Saka, B-spline collocation methods for numerical solutions of the RLW equation, Int. J. Comput. Math. 80 (2003) [3] I. Dag, B. Saka and D. Irk, Galerkin method for the numerical solution of the RLW equation using quintic B-splines, J. Comput. Appl. Math. 190 (2006) [4] K. Djidjeli, W.G. Price, E.H. Twizell and Q. Cao, A linearized implicit pseudospectral method for some model equations: the regularized long wave equations, Comm. Numer. Methods Engrg. 19 (2003) [5] A. Dogan, Numerical solution of RLW equation using linear finite elements within Galerkin method, Appl. Math. Model. 26 (2002) [6] A. Dogan, Numerical solution of regularized long wave equation using Petrov-Galerkin method, Comm. Numer. Methods Engrg. 17 (2001) [7] A. Esen and S. Kutluay, Application of a lumped Galerkin method to the regularized long wave equation, Appl. Math. Comput. 174 (2006) [8] L. R. T. Gardner, G. A. Gardner and I. Dag, A B-spline finite element method for the regularized long wave equation, Comm. Numer. Methods Engrg. 11 (1995) [9] L. R. T. Gardner, G. A. Gardner and A. Dogan, A least-square finite element method for the RLW equation, Comm. Numer. Methods Engrg. 12 (1996) ::AID- CNM CO;2-O [10] L. R. T. Gardner, G. A. Gardner, F. A. Ayoub and N. K. Amein, Approximations of solitary waves of the MRLW equation by B-spline finite element, Arab. J. Sci. Eng. 22 (1997) ISPACS GmbH

15 [11] A. K. Khalifa, K. R. Raslan and H. M. Alzubaidi, A collocation method with cubic Bsplines for solving the MRLW equation, Comput. Appl. Math. 212 (2008) [12] A.K. Khalifa, K.R. Raslan and H.M. Alzubaidi, A finite difference scheme for the MRLW and solitary wave interactions, Appl. Math. Comput. 189 (2007) [13] R.C. Mittal and Geeta Arora, Quintic B-Spline Collocation Method for Numerical Solution of the Extended Fisher-Kolmogrov Equation, Int. J. of Appl. Math and Mech. 6 (1) (2010) [14] R. Mokhtari and M. Mohammadi, Numerical solution of GRLW equation using Sinccollocation method, Computer Physics Communications 181 (2010) [15] R. Mokhtari and M. Mohammadi, Solving the generalized regularized long wave equation on the basis of a reproducing kernel space, Journal of Computational and Applied Mathematics 235 (2011) [16] X. Pan, Tingchun Wang, Luming Zhang and Boling Guo, On the convergence of a conservative numerical scheme for the usual Rosenau-RLW equation, Applied Mathematical Modelling. [17] H. Panahipour, Numerical Simulation of GEW equation using RBF collocation method, 2012 (2012). [18] K. R. Raslan, A computational method for the regularized long wave equation, Appl. Math. Comput. 167 (2005) [19] K. R. Raslan, Numerical study of the Modified Regularized Long Wave (MRLW) equation, Chaos Solitons Fractals 42 (2009) [20] B. Saka, I. Dag and A. Dogan, Galerkin method for the numerical solution of the RLW equation using quadratic B-spline, Int. J. Comput. Math. 81 (2004) [21] R.J. Spiteri and S.J. Ruuth, A new class of optimal high-order strong-stabilitypreserving time-stepping schemes, SIAM J. Numer. Anal. 40 (2002) [22] B. Saka and I. Dag, A Collocation method for the numerical solution of the RLW equation using cubic B-spline basis, Arab. J. Sci. Eng. 30 (2005) [23] L. Zhang, A finite difference scheme for generalized regularized long-wave equation, Appl. Math. Comput. 168 (2005) ISPACS GmbH

16 [24] J.M. Zuo, Y.M. Zhang, Tian-De Zhang, and Feng Chang, A New Conservative Difference Scheme for the General Rosenau-RLW Equation, Boundary Value Problems, Hindawi Publishing Corporation, Volume 2010, Article ID ISPACS GmbH

B-splines Collocation Algorithms for Solving Numerically the MRLW Equation

B-splines Collocation Algorithms for Solving Numerically the MRLW Equation ISSN 1749-889 (print), 1749-897 (online) International Journal of Nonlinear Science Vol.8(2009) No.2,pp.11-140 B-splines Collocation Algorithms for Solving Numerically the MRLW Equation Saleh M. Hassan,

More information

Application of Quintic B-splines Collocation Method on Some Rosenau Type Nonlinear Higher Order Evolution Equations.

Application of Quintic B-splines Collocation Method on Some Rosenau Type Nonlinear Higher Order Evolution Equations. ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.13(2012) No.2,pp.142-152 Application of Quintic B-splines Collocation Metod on Some Rosenau Type Nonlinear Higer

More information

Galerkin method for the numerical solution of the RLW equation using quintic B-splines

Galerkin method for the numerical solution of the RLW equation using quintic B-splines Journal of Computational and Applied Mathematics 19 (26) 532 547 www.elsevier.com/locate/cam Galerkin method for the numerical solution of the RLW equation using quintic B-splines İdris Dağ a,, Bülent

More information

A Good Numerical Method for the Solution of Generalized Regularized Long Wave Equation

A Good Numerical Method for the Solution of Generalized Regularized Long Wave Equation Modern Applied Science; Vol. 11, No. 6; 2017 ISSN 1913-1844 E-ISSN 1913-1852 Published by Canadian Center of Science and Education A Good Numerical Method for the Solution of Generalized Regularized Long

More information

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

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

More information

A cubic B-spline Galerkin approach for the numerical simulation of the GEW equation

A cubic B-spline Galerkin approach for the numerical simulation of the GEW equation STATISTICS, OPTIMIZATION AND INFORMATION COMPUTING Stat., Optim. Inf. Comput., Vol. 4, March 216, pp 3 41. Published online in International Academic Press (www.iapress.org) A cubic B-spline Galerkin approach

More information

A collocation algorithm based on quintic B-splines for the solitary wave simulation of the GRLW equation

A collocation algorithm based on quintic B-splines for the solitary wave simulation of the GRLW equation A collocation algorithm based on quintic B-splines for the solitary wave simulation of the GRLW equation Halil Zeybek a,, S. Battal Gazi Karakoç b a Department of Applied Mathematics, Faculty of Computer

More information

Numerical Solution of One-dimensional Telegraph Equation using Cubic B-spline Collocation Method

Numerical Solution of One-dimensional Telegraph Equation using Cubic B-spline Collocation Method 2014 (2014) 1-8 Available online at www.ispacs.com/iasc Volume 2014, Year 2014 Article ID iasc-00042, 8 Pages doi:10.5899/2014/iasc-00042 Research Article Numerical Solution of One-dimensional Telegraph

More information

Numerical Solution of the MRLW Equation Using Finite Difference Method. 1 Introduction

Numerical Solution of the MRLW Equation Using Finite Difference Method. 1 Introduction ISSN 1749-3889 print, 1749-3897 online International Journal of Nonlinear Science Vol.1401 No.3,pp.355-361 Nuerical Solution of the MRLW Equation Using Finite Difference Method Pınar Keskin, Dursun Irk

More information

The Trigonometric Cubic B-spline Algorithm for Burgers Equation

The Trigonometric Cubic B-spline Algorithm for Burgers Equation ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.4(017) No., pp.10-18 The Trigonometric Cubic B-spline Algorithm for Burgers Equation Idris Dag 1, Ozlem Ersoy Hepson,

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

An improved collocation method based on deviation of the error for solving BBMB equation

An improved collocation method based on deviation of the error for solving BBMB equation Computational Methods for Differential Equations http://cmde.tabrizu.ac.ir Vol. 6, No. 2, 2018, pp. 238-247 An improved collocation method based on deviation of the error for solving BBMB equation Reza

More information

Chebyshev Collocation Spectral Method for Solving the RLW Equation

Chebyshev Collocation Spectral Method for Solving the RLW Equation ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.7(2009) No.2,pp.131-142 Chebyshev Collocation Spectral Method for Solving the RLW Equation A. H. A. Ali Mathematics

More information

Application of linear combination between cubic B-spline collocation methods with different basis for solving the KdV equation

Application of linear combination between cubic B-spline collocation methods with different basis for solving the KdV equation Computational Methods for Differential Equations http://cmde.tabrizu.ac.ir Vol. 4, No. 3, 016, pp. 191-04 Application of linear combination between cubic B-spline collocation methods with different basis

More information

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

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

More information

Khyber Pakhtunkhwa Agricultural University, Peshawar, Pakistan

Khyber Pakhtunkhwa Agricultural University, Peshawar, Pakistan ttp://www.lifesciencesite.com Septic B-Spline Collocation metod for numerical solution of te Equal Widt Wave (EW) equation 1 Fazal-i-Haq, 2 Inayat Ali sa and 3 Sakeel Amad 1 Department of Matematics, Statistics

More information

Numerical studies of non-local hyperbolic partial differential equations using collocation methods

Numerical studies of non-local hyperbolic partial differential equations using collocation methods Computational Methods for Differential Equations http://cmde.tabrizu.ac.ir Vol. 6, No. 3, 2018, pp. 326-338 Numerical studies of non-local hyperbolic partial differential equations using collocation methods

More information

A fourth-order finite difference scheme for the numerical solution of 1D linear hyperbolic equation

A fourth-order finite difference scheme for the numerical solution of 1D linear hyperbolic equation 203 (203) - Available online at www.ispacs.com/cna Volume 203, Year 203 Article ID cna-0048, Pages doi:0.5899/203/cna-0048 Research Article A fourth-order finite difference scheme for the numerical solution

More information

Research Article Solution of the Porous Media Equation by a Compact Finite Difference Method

Research Article Solution of the Porous Media Equation by a Compact Finite Difference Method Hindawi Publishing Corporation Mathematical Problems in Engineering Volume 2009, Article ID 9254, 3 pages doi:0.55/2009/9254 Research Article Solution of the Porous Media Equation by a Compact Finite Difference

More information

New Exact Travelling Wave Solutions for Regularized Long-wave, Phi-Four and Drinfeld-Sokolov Equations

New Exact Travelling Wave Solutions for Regularized Long-wave, Phi-Four and Drinfeld-Sokolov Equations ISSN 1749-3889 print), 1749-3897 online) International Journal of Nonlinear Science Vol.008) No.1,pp.4-5 New Exact Travelling Wave Solutions for Regularized Long-wave, Phi-Four and Drinfeld-Sokolov Euations

More information

Du Fort Frankel finite difference scheme for Burgers equation

Du Fort Frankel finite difference scheme for Burgers equation Arab J Math (13) :91 11 DOI 1.17/s465-1-5-1 RESEARCH ARTICLE K. Pandey Lajja Verma Amit K. Verma Du Fort Frankel finite difference scheme for Burgers equation Received: 8 February 1 / Accepted: 1 September

More information

Quartic B-spline Differential Quadrature Method

Quartic B-spline Differential Quadrature Method ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.11(2011) No.4,pp.403-411 Quartic B-spline Differential Quadrature Method Alper Korkmaz 1, A. Murat Aksoy 2, İdris

More information

B-SPLINE COLLOCATION METHODS FOR NUMERICAL SOLUTIONS OF THE BURGERS EQUATION

B-SPLINE COLLOCATION METHODS FOR NUMERICAL SOLUTIONS OF THE BURGERS EQUATION B-SPLINE COLLOCATION METHODS FOR NUMERICAL SOLUTIONS OF THE BURGERS EQUATION İDRİS DAĞ, DURSUN IRK, AND ALİŞAHİN Received 25 August 24 and in revised form 22 December 24 Both time- and space-splitted Burgers

More information

A robust uniform B-spline collocation method for solving the generalized PHI-four equation

A robust uniform B-spline collocation method for solving the generalized PHI-four equation Available at http://pvamu.edu/aam Appl. Appl. Math. ISSN: 1932-9466 Vol. 11, Issue 1 (June 2016), pp. 364-376 Applications and Applied Mathematics: An International Journal (AAM) A robust uniform B-spline

More information

Collocation Method with Quintic B-Spline Method for Solving the Hirota equation

Collocation Method with Quintic B-Spline Method for Solving the Hirota equation NTMSCI 1, No. 1, 1-1 (016) 1 Journal of Abstract and Computational Mathematics http://www.ntmsci.com/jacm Collocation Method with Quintic B-Spline Method for Solving the Hirota equation K. R. Raslan 1,

More information

Cubic B-spline Collocation Method for Fourth Order Boundary Value Problems. 1 Introduction

Cubic B-spline Collocation Method for Fourth Order Boundary Value Problems. 1 Introduction ISSN 1749-3889 print, 1749-3897 online International Journal of Nonlinear Science Vol.142012 No.3,pp.336-344 Cubic B-spline Collocation Method for Fourth Order Boundary Value Problems K.N.S. Kasi Viswanadham,

More information

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

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

More information

An explicit exponential finite difference method for the Burgers equation

An explicit exponential finite difference method for the Burgers equation European International Journal of Science and Technology Vol. 2 No. 10 December, 2013 An explicit exponential finite difference method for the Burgers equation BİLGE İNAN*, AHMET REFİK BAHADIR Department

More information

Numerical Solutions of the Combined KdV-MKdV Equation by a Quintic B-spline Collocation Method

Numerical Solutions of the Combined KdV-MKdV Equation by a Quintic B-spline Collocation Method Appl. Math. Inf. Sci. Lett. 4 No. 1 19-24 (2016) 19 Applied Mathematics & Information Sciences Letters An International Journal http://d.doi.org/18576/amisl/040104 Numerical Solutions of the Combined KdV-MKdV

More information

Some New Three Step Iterative Methods for Solving Nonlinear Equation Using Steffensen s and Halley Method

Some New Three Step Iterative Methods for Solving Nonlinear Equation Using Steffensen s and Halley Method British Journal of Mathematics & Computer Science 19(2): 1-9, 2016; Article no.bjmcs.2922 ISSN: 221-081 SCIENCEDOMAIN international www.sciencedomain.org Some New Three Step Iterative Methods for Solving

More information

Linearization of Two Dimensional Complex-Linearizable Systems of Second Order Ordinary Differential Equations

Linearization of Two Dimensional Complex-Linearizable Systems of Second Order Ordinary Differential Equations Applied Mathematical Sciences, Vol. 9, 2015, no. 58, 2889-2900 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2015.4121002 Linearization of Two Dimensional Complex-Linearizable Systems of

More information

HOMOTOPY ANALYSIS METHOD FOR SOLVING KDV EQUATIONS

HOMOTOPY ANALYSIS METHOD FOR SOLVING KDV EQUATIONS Surveys in Mathematics and its Applications ISSN 1842-6298 (electronic), 1843-7265 (print) Volume 5 (21), 89 98 HOMOTOPY ANALYSIS METHOD FOR SOLVING KDV EQUATIONS Hossein Jafari and M. A. Firoozjaee Abstract.

More information

Soliton Solutions of a General Rosenau-Kawahara-RLW Equation

Soliton Solutions of a General Rosenau-Kawahara-RLW Equation Soliton Solutions of a General Rosenau-Kawahara-RLW Equation Jin-ming Zuo 1 1 School of Science, Shandong University of Technology, Zibo 255049, PR China Journal of Mathematics Research; Vol. 7, No. 2;

More information

Research Article The Spectral Method for Solving Sine-Gordon Equation Using a New Orthogonal Polynomial

Research Article The Spectral Method for Solving Sine-Gordon Equation Using a New Orthogonal Polynomial International Scholarly Research Network ISRN Applied Mathematics Volume, Article ID 4673, pages doi:.54//4673 Research Article The Spectral Method for Solving Sine-Gordon Equation Using a New Orthogonal

More information

Differential transformation method for solving one-space-dimensional telegraph equation

Differential transformation method for solving one-space-dimensional telegraph equation Volume 3, N 3, pp 639 653, 2 Copyright 2 SBMAC ISSN -825 wwwscielobr/cam Differential transformation method for solving one-space-dimensional telegraph equation B SOLTANALIZADEH Young Researchers Club,

More information

CHAPTER III HAAR WAVELET METHOD FOR SOLVING FISHER S EQUATION

CHAPTER III HAAR WAVELET METHOD FOR SOLVING FISHER S EQUATION CHAPTER III HAAR WAVELET METHOD FOR SOLVING FISHER S EQUATION A version of this chapter has been published as Haar Wavelet Method for solving Fisher s equation, Appl. Math.Comput.,(ELSEVIER) 211 (2009)

More information

Research Article New Exact Solutions for the 2 1 -Dimensional Broer-Kaup-Kupershmidt Equations

Research Article New Exact Solutions for the 2 1 -Dimensional Broer-Kaup-Kupershmidt Equations Hindawi Publishing Corporation Abstract and Applied Analysis Volume 00, Article ID 549, 9 pages doi:0.55/00/549 Research Article New Exact Solutions for the -Dimensional Broer-Kaup-Kupershmidt Equations

More information

New Exact Solutions of the Modified Benjamin-Bona-Mahony Equation Yun-jie YANG and Li YAO

New Exact Solutions of the Modified Benjamin-Bona-Mahony Equation Yun-jie YANG and Li YAO 06 International Conference on Artificial Intelligence and Computer Science (AICS 06) ISBN: 978--60595-4-0 New Exact Solutions of the Modified Benamin-Bona-Mahony Equation Yun-ie YANG and Li YAO Department

More information

Bifurcations of Traveling Wave Solutions for a Generalized Camassa-Holm Equation

Bifurcations of Traveling Wave Solutions for a Generalized Camassa-Holm Equation Computational and Applied Mathematics Journal 2017; 3(6): 52-59 http://www.aascit.org/journal/camj ISSN: 2381-1218 (Print); ISSN: 2381-1226 (Online) Bifurcations of Traveling Wave Solutions for a Generalized

More information

The Homotopy Perturbation Method (HPM) for Nonlinear Parabolic Equation with Nonlocal Boundary Conditions

The Homotopy Perturbation Method (HPM) for Nonlinear Parabolic Equation with Nonlocal Boundary Conditions Applied Mathematical Sciences, Vol. 5, 211, no. 3, 113-123 The Homotopy Perturbation Method (HPM) for Nonlinear Parabolic Equation with Nonlocal Boundary Conditions M. Ghoreishi School of Mathematical

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

Exact Solutions for a Fifth-Order Two-Mode KdV Equation with Variable Coefficients

Exact Solutions for a Fifth-Order Two-Mode KdV Equation with Variable Coefficients Contemporary Engineering Sciences, Vol. 11, 2018, no. 16, 779-784 HIKARI Ltd, www.m-hikari.com https://doi.org/10.12988/ces.2018.8262 Exact Solutions for a Fifth-Order Two-Mode KdV Equation with Variable

More information

Integral Bifurcation Method and Its Application for Solving the Modified Equal Width Wave Equation and Its Variants

Integral Bifurcation Method and Its Application for Solving the Modified Equal Width Wave Equation and Its Variants Rostock. Math. Kolloq. 62, 87 106 (2007) Subject Classification (AMS) 35Q51, 35Q58, 37K50 Weiguo Rui, Shaolong Xie, Yao Long, Bin He Integral Bifurcation Method Its Application for Solving the Modified

More information

Numerical study of time-fractional hyperbolic partial differential equations

Numerical study of time-fractional hyperbolic partial differential equations Available online at wwwisr-publicationscom/jmcs J Math Computer Sci, 7 7, 53 65 Research Article Journal Homepage: wwwtjmcscom - wwwisr-publicationscom/jmcs Numerical study of time-fractional hyperbolic

More information

Analysis of the equal width wave equation with the mesh-free reproducing kernel particle Ritz method

Analysis of the equal width wave equation with the mesh-free reproducing kernel particle Ritz method Analysis of the equal width wave equation with the mesh-free reproducing kernel particle Ritz method Cheng Rong-Jun( 程荣军 ) a) and Ge Hong-Xia( 葛红霞 ) b) a) Ningbo Institute of Technology, Zhejiang University,

More information

A FOURTH-ORDER ACCURATE FINITE DIFFERENCE SCHEME FOR THE EXTENDED-FISHER-KOLMOGOROV EQUATION. Tlili Kadri and Khaled Omrani

A FOURTH-ORDER ACCURATE FINITE DIFFERENCE SCHEME FOR THE EXTENDED-FISHER-KOLMOGOROV EQUATION. Tlili Kadri and Khaled Omrani Bull. Korean Math. Soc. 0 (0), No. 0, pp. 0 https://doi.org/0.434/bkms.b603 pissn: 05-8634 / eissn: 34-306 A FOURTH-ORDER ACCURATE FINITE DIFFERENCE SCHEME FOR THE EXTENDED-FISHER-KOLMOGOROV EQUATION Tlili

More information

Cubic B-spline collocation method for solving time fractional gas dynamics equation

Cubic B-spline collocation method for solving time fractional gas dynamics equation Cubic B-spline collocation method for solving time fractional gas dynamics equation A. Esen 1 and O. Tasbozan 2 1 Department of Mathematics, Faculty of Science and Art, Inönü University, Malatya, 44280,

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

A semi-lagrangian scheme for advection-diffusion equation

A semi-lagrangian scheme for advection-diffusion equation EPiC Series in Engineering Volume 3, 2018, Pages 162 172 HIC 2018. 13th International Conference on Hydroinformatics Engineering A semi-lagrangian scheme for advection-diffusion equation Ersin Bahar 1,

More information

Research Article A New Method for Riccati Differential Equations Based on Reproducing Kernel and Quasilinearization Methods

Research Article A New Method for Riccati Differential Equations Based on Reproducing Kernel and Quasilinearization Methods Abstract and Applied Analysis Volume 0, Article ID 603748, 8 pages doi:0.55/0/603748 Research Article A New Method for Riccati Differential Equations Based on Reproducing Kernel and Quasilinearization

More information

Solution of Fourth Order Boundary Value Problems by Numerical Algorithms Based on Nonpolynomial Quintic Splines

Solution of Fourth Order Boundary Value Problems by Numerical Algorithms Based on Nonpolynomial Quintic Splines Journal of Numerical Mathematics and Stochastics, 4(1) : 13-25, 2012 http://www.jnmas.org/jnmas4-2.pdf JNM@S Euclidean Press, LLC Online: ISSN 2151-2302 Solution of Fourth Order Boundary Value Problems

More information

of a Two-Operator Product 1

of a Two-Operator Product 1 Applied Mathematical Sciences, Vol. 7, 2013, no. 130, 6465-6474 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2013.39501 Reverse Order Law for {1, 3}-Inverse of a Two-Operator Product 1 XUE

More information

Research Article A Galerkin Solution for Burgers Equation Using Cubic B-Spline Finite Elements

Research Article A Galerkin Solution for Burgers Equation Using Cubic B-Spline Finite Elements Abstract and Applied Analysis Volume 212, Article ID 527467, 15 pages doi:1.1155/212/527467 Research Article A Galerkin Solution for Burgers Equation Using Cubic B-Spline Finite Elements A. A. Soliman

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 APPROACH FOR SOLITON SOLUTIONS OF RLW EQUATION AND (1+2)-DIMENSIONAL NONLINEAR SCHRÖDINGER S EQUATION

A NEW APPROACH FOR SOLITON SOLUTIONS OF RLW EQUATION AND (1+2)-DIMENSIONAL NONLINEAR SCHRÖDINGER S EQUATION A NEW APPROACH FOR SOLITON SOLUTIONS OF RLW EQUATION AND (+2-DIMENSIONAL NONLINEAR SCHRÖDINGER S EQUATION ALI FILIZ ABDULLAH SONMEZOGLU MEHMET EKICI and DURGUN DURAN Communicated by Horia Cornean In this

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

Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media

Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media Mohamed A. Hajji Abstract In this paper we propose a numerical scheme based on finite differences for the

More information

Non-Polynomial Spline Solution of Fourth-Order Obstacle Boundary-Value Problems

Non-Polynomial Spline Solution of Fourth-Order Obstacle Boundary-Value Problems Non-Polynomial Spline Solution of Fourth-Order Obstacle Boundary-Value Problems Jalil Rashidinia Reza Jalilian Abstract In this paper we use quintic non-polynomial spline functions to develop numerical

More information

An efficient algorithm on timefractional. equations with variable coefficients. Research Article OPEN ACCESS. Jamshad Ahmad*, Syed Tauseef Mohyud-Din

An efficient algorithm on timefractional. equations with variable coefficients. Research Article OPEN ACCESS. Jamshad Ahmad*, Syed Tauseef Mohyud-Din OPEN ACCESS Research Article An efficient algorithm on timefractional partial differential equations with variable coefficients Jamshad Ahmad*, Syed Tauseef Mohyud-Din Department of Mathematics, Faculty

More information

Research Article Exact Solutions of φ 4 Equation Using Lie Symmetry Approach along with the Simplest Equation and Exp-Function Methods

Research Article Exact Solutions of φ 4 Equation Using Lie Symmetry Approach along with the Simplest Equation and Exp-Function Methods Abstract and Applied Analysis Volume 2012, Article ID 350287, 7 pages doi:10.1155/2012/350287 Research Article Exact Solutions of φ 4 Equation Using Lie Symmetry Approach along with the Simplest Equation

More information

Finite Difference Method of Fractional Parabolic Partial Differential Equations with Variable Coefficients

Finite Difference Method of Fractional Parabolic Partial Differential Equations with Variable Coefficients International Journal of Contemporary Mathematical Sciences Vol. 9, 014, no. 16, 767-776 HIKARI Ltd, www.m-hiari.com http://dx.doi.org/10.1988/ijcms.014.411118 Finite Difference Method of Fractional Parabolic

More information

2. The generalized Benjamin- Bona-Mahony (BBM) equation with variable coefficients [30]

2. The generalized Benjamin- Bona-Mahony (BBM) equation with variable coefficients [30] ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.12(2011) No.1,pp.95-99 The Modified Sine-Cosine Method and Its Applications to the Generalized K(n,n) and BBM Equations

More information

Research Article Finding Global Minima with a Filled Function Approach for Non-Smooth Global Optimization

Research Article Finding Global Minima with a Filled Function Approach for Non-Smooth Global Optimization Hindawi Publishing Corporation Discrete Dynamics in Nature and Society Volume 00, Article ID 843609, 0 pages doi:0.55/00/843609 Research Article Finding Global Minima with a Filled Function Approach for

More information

A Study on Linear and Nonlinear Stiff Problems. Using Single-Term Haar Wavelet Series Technique

A Study on Linear and Nonlinear Stiff Problems. Using Single-Term Haar Wavelet Series Technique Int. Journal of Math. Analysis, Vol. 7, 3, no. 53, 65-636 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/.988/ijma.3.3894 A Study on Linear and Nonlinear Stiff Problems Using Single-Term Haar Wavelet Series

More information

+ (u u h. ( h ) 0, + (u u I ( I. + (u I. u h 2( ( I. = CB h. ; h. + ( h. + k, ( u k, ch 2(k 2) 2. = c h. + u h. + f 0,T T T h. F h. ,u h ).

+ (u u h. ( h ) 0, + (u u I ( I. + (u I. u h 2( ( I. = CB h. ; h. + ( h. + k, ( u k, ch 2(k 2) 2. = c h. + u h. + f 0,T T T h. F h. ,u h ). The Open Numerical Methods Journal 009-5 Open Access An Adaptive Least-Squares Mixed Finite Element Method for Fourth- Order Elliptic Equations Gu Haiming * Li Hongwei and Xie Bing Department of Mathematics

More information

On the Equation of Fourth Order with. Quadratic Nonlinearity

On the Equation of Fourth Order with. Quadratic Nonlinearity International Journal of Mathematical Analysis Vol. 9, 015, no. 5, 659-666 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.1988/ijma.015.5109 On the Equation of Fourth Order with Quadratic Nonlinearity

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

Approximate solutions of dual fuzzy polynomials by feed-back neural networks

Approximate solutions of dual fuzzy polynomials by feed-back neural networks Available online at wwwispacscom/jsca Volume 2012, Year 2012 Article ID jsca-00005, 16 pages doi:105899/2012/jsca-00005 Research Article Approximate solutions of dual fuzzy polynomials by feed-back neural

More information

An Efficient Computational Technique based on Cubic Trigonometric B-splines for Time Fractional Burgers Equation.

An Efficient Computational Technique based on Cubic Trigonometric B-splines for Time Fractional Burgers Equation. An Efficient Computational Technique based on Cubic Trigonometric B-splines for Time Fractional Burgers Equation. arxiv:1709.016v1 [math.na] 5 Sep 2017 Muhammad Yaseen, Muhammad Abbas Department of Mathematics,

More information

New Approach of ( Ǵ/G ) Expansion Method. Applications to KdV Equation

New Approach of ( Ǵ/G ) Expansion Method. Applications to KdV Equation Journal of Mathematics Research; Vol. 6, No. ; ISSN 96-9795 E-ISSN 96-989 Published by Canadian Center of Science and Education New Approach of Ǵ/G Expansion Method. Applications to KdV Equation Mohammad

More information

1. Introduction We consider the following self-adjoint singularly perturbed boundary value problem: ɛu + p(x)u = q(x), p(x) > 0,

1. Introduction We consider the following self-adjoint singularly perturbed boundary value problem: ɛu + p(x)u = q(x), p(x) > 0, TWMS J. Pure Appl. Math. V., N., 00, pp. 6-5 NON-POLYNOMIAL SPLINE APPROXIMATIONS FOR THE SOLUTION OF SINGULARLY-PERTURBED BOUNDARY VALUE PROBLEMS J. RASHIDINIA, R. MOHAMMADI Abstract. We consider the

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation with Inconsistent Initial and Boundary Conditions

Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation with Inconsistent Initial and Boundary Conditions International Mathematics and Mathematical Sciences Volume 212, Article ID 82197, 13 pages doi:1.1155/212/82197 Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation

More information

Bifurcations of Travelling Wave Solutions for the B(m,n) Equation

Bifurcations of Travelling Wave Solutions for the B(m,n) Equation American Journal of Computational Mathematics 4 4 4-8 Published Online March 4 in SciRes. http://www.scirp.org/journal/ajcm http://dx.doi.org/.436/jasmi.4.4 Bifurcations of Travelling Wave Solutions for

More information

Research Article Soliton Solutions for the Wick-Type Stochastic KP Equation

Research Article Soliton Solutions for the Wick-Type Stochastic KP Equation Abstract and Applied Analysis Volume 212, Article ID 327682, 9 pages doi:1.1155/212/327682 Research Article Soliton Solutions for the Wick-Type Stochastic KP Equation Y. F. Guo, 1, 2 L. M. Ling, 2 and

More information

Fourier spectral methods for solving some nonlinear partial differential equations

Fourier spectral methods for solving some nonlinear partial differential equations Int. J. Open Problems Compt. Math., Vol., No., June ISSN 99-; Copyright ICSRS Publication, www.i-csrs.org Fourier spectral methods for solving some nonlinear partial differential equations Hany N. HASSAN

More information

Solving the One Dimensional Advection Diffusion Equation Using Mixed Discrete Least Squares Meshless Method

Solving the One Dimensional Advection Diffusion Equation Using Mixed Discrete Least Squares Meshless Method Proceedings of the International Conference on Civil, Structural and Transportation Engineering Ottawa, Ontario, Canada, May 4 5, 2015 Paper No. 292 Solving the One Dimensional Advection Diffusion Equation

More information

Row Reduced Echelon Form for Solving Fully Fuzzy System with Unknown Coefficients

Row Reduced Echelon Form for Solving Fully Fuzzy System with Unknown Coefficients Journal of Fuzzy Set Valued Analysis 2014 2014) 1-18 Available online at www.ispacs.com/jfsva Volume 2014, Year 2014 Article ID jfsva-00193, 18 Pages doi:10.5899/2014/jfsva-00193 Research Article Row Reduced

More information

The Homotopy Perturbation Method for Solving the Kuramoto Sivashinsky Equation

The Homotopy Perturbation Method for Solving the Kuramoto Sivashinsky Equation IOSR Journal of Engineering (IOSRJEN) e-issn: 2250-3021, p-issn: 2278-8719 Vol. 3, Issue 12 (December. 2013), V3 PP 22-27 The Homotopy Perturbation Method for Solving the Kuramoto Sivashinsky Equation

More information

Exact Solutions of Space-time Fractional EW and modified EW equations

Exact Solutions of Space-time Fractional EW and modified EW equations arxiv:1601.01294v1 [nlin.si] 6 Jan 2016 Exact Solutions of Space-time Fractional EW and modified EW equations Alper Korkmaz Department of Mathematics, Çankırı Karatekin University, Çankırı, TURKEY January

More information

A numerical study of the long wave short wave interaction equations

A numerical study of the long wave short wave interaction equations Mathematics and Computers in Simulation 74 007) 113 15 A numerical study of the long wave short wave interaction equations H. Borluk a, G.M. Muslu b, H.A. Erbay a, a Department of Mathematics, Isik University,

More information

A Numerical Study of One-Dimensional Hyperbolic Telegraph Equation

A Numerical Study of One-Dimensional Hyperbolic Telegraph Equation Journal of Mathematics and System Science 7 (2017) 62-72 doi: 10.17265/2159-5291/2017.02.003 D DAVID PUBLISHING A Numerical Study of One-Dimensional Hyperbolic Telegraph Equation Shaheed N. Huseen Thi-Qar

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

Cubic spline Numerov type approach for solution of Helmholtz equation

Cubic spline Numerov type approach for solution of Helmholtz equation Journal of Linear and Topological Algebra Vol. 03, No. 01, 2014, 47-54 Cubic spline Numerov type approach for solution of Helmholtz equation J. Rashidinia a, H. S. Shekarabi a and M. Aghamohamadi a a Department

More information

Potential Symmetries and Differential Forms. for Wave Dissipation Equation

Potential Symmetries and Differential Forms. for Wave Dissipation Equation Int. Journal of Math. Analysis, Vol. 7, 2013, no. 42, 2061-2066 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ijma.2013.36163 Potential Symmetries and Differential Forms for Wave Dissipation

More information

arxiv: v1 [math.na] 20 May 2013

arxiv: v1 [math.na] 20 May 2013 A numerical method based on the reproducing kernel Hilbert space method for the solution of fifth-order boundary-value problems arxiv:1305.4445v1 [math.na] 0 May 013 Mustafa Inc, Ali Akgül and Mehdi Dehghan

More information

Iterated Defect Correction with B-Splines for a Class of Strongly Nonlinear Two-Point Boundary Value Problems

Iterated Defect Correction with B-Splines for a Class of Strongly Nonlinear Two-Point Boundary Value Problems American Review of Mathematics and Statistics June 2016, Vol. 4, No. 1, pp. 31-44 ISSN: 2374-2348 (Print), 2374-2356 (Online) Copyright The Author(s). All Rights Reserved. Published by American Research

More information

Solution of Fourth Order Obstacle Problems Using Quintic B-Splines

Solution of Fourth Order Obstacle Problems Using Quintic B-Splines Applied Mathematical Sciences, Vol. 6, 202, no. 94, 465-4662 Solution of Fourth Order Obstacle Problems Using Quintic B-Splines Shahid S. Siddiqi, Ghazala Akram and Kalsoom Arshad Department of Mathematics

More information

A NEW INTEGRATOR FOR SPECIAL THIRD ORDER DIFFERENTIAL EQUATIONS WITH APPLICATION TO THIN FILM FLOW PROBLEM

A NEW INTEGRATOR FOR SPECIAL THIRD ORDER DIFFERENTIAL EQUATIONS WITH APPLICATION TO THIN FILM FLOW PROBLEM Indian J. Pure Appl. Math., 491): 151-167, March 218 c Indian National Science Academy DOI: 1.17/s13226-18-259-6 A NEW INTEGRATOR FOR SPECIAL THIRD ORDER DIFFERENTIAL EQUATIONS WITH APPLICATION TO THIN

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

Travelling Wave Solutions for the Gilson-Pickering Equation by Using the Simplified G /G-expansion Method

Travelling Wave Solutions for the Gilson-Pickering Equation by Using the Simplified G /G-expansion Method ISSN 1749-3889 (print, 1749-3897 (online International Journal of Nonlinear Science Vol8(009 No3,pp368-373 Travelling Wave Solutions for the ilson-pickering Equation by Using the Simplified /-expansion

More information

Variation of Parameters Method for Solving Fifth-Order. Boundary Value Problems

Variation of Parameters Method for Solving Fifth-Order. Boundary Value Problems Applied Mathematics & Information Sciences 2(2) (28), 135 141 An International Journal c 28 Dixie W Publishing Corporation, U. S. A. Variation of Parameters Method for Solving Fifth-Order Boundary Value

More information

Exact Solutions of the Generalized- Zakharov (GZ) Equation by the Infinite Series Method

Exact Solutions of the Generalized- Zakharov (GZ) Equation by the Infinite Series Method Available at http://pvamu.edu/aam Appl. Appl. Math. ISSN: 193-9466 Vol. 05, Issue (December 010), pp. 61 68 (Previously, Vol. 05, Issue 10, pp. 1718 175) Applications and Applied Mathematics: An International

More information

Presenter: Noriyoshi Fukaya

Presenter: Noriyoshi Fukaya Y. Martel, F. Merle, and T.-P. Tsai, Stability and Asymptotic Stability in the Energy Space of the Sum of N Solitons for Subcritical gkdv Equations, Comm. Math. Phys. 31 (00), 347-373. Presenter: Noriyoshi

More information

Rational Energy Balance Method to Nonlinear Oscillators with Cubic Term

Rational Energy Balance Method to Nonlinear Oscillators with Cubic Term From the SelectedWorks of Hassan Askari 2013 Rational Energy Balance Method to Nonlinear Oscillators with Cubic Term Hassan Askari Available at: https://works.bepress.com/hassan_askari/4/ Asian-European

More information

Numerical Solution of Two-Dimensional Volterra Integral Equations by Spectral Galerkin Method

Numerical Solution of Two-Dimensional Volterra Integral Equations by Spectral Galerkin Method Journal of Applied Mathematics & Bioinformatics, vol.1, no.2, 2011, 159-174 ISSN: 1792-6602 (print), 1792-6939 (online) International Scientific Press, 2011 Numerical Solution of Two-Dimensional Volterra

More information

A Novel Approach with Time-Splitting Spectral Technique for the Coupled Schrödinger Boussinesq Equations Involving Riesz Fractional Derivative

A Novel Approach with Time-Splitting Spectral Technique for the Coupled Schrödinger Boussinesq Equations Involving Riesz Fractional Derivative Commun. Theor. Phys. 68 2017 301 308 Vol. 68, No. 3, September 1, 2017 A Novel Approach with Time-Splitting Spectral Technique for the Coupled Schrödinger Boussinesq Equations Involving Riesz Fractional

More information

The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods

The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods by Hae-Soo Oh Department of Mathematics, University of North Carolina at Charlotte, Charlotte, NC 28223 June

More information

Available online at J. Math. Comput. Sci. 2 (2012), No. 1, ISSN:

Available online at   J. Math. Comput. Sci. 2 (2012), No. 1, ISSN: Available online at http://scik.org J. Math. Comput. Sci. 2 (2012), No. 1, 15-22 ISSN: 1927-5307 BRIGHT AND DARK SOLITON SOLUTIONS TO THE OSTROVSKY-BENJAMIN-BONA-MAHONY (OS-BBM) EQUATION MARWAN ALQURAN

More information

Keywords: Exp-function method; solitary wave solutions; modified Camassa-Holm

Keywords: Exp-function method; solitary wave solutions; modified Camassa-Holm International Journal of Modern Mathematical Sciences, 2012, 4(3): 146-155 International Journal of Modern Mathematical Sciences Journal homepage:www.modernscientificpress.com/journals/ijmms.aspx ISSN:

More information