The dual reciprocity boundary element method for. two-dimensional Burgers equations using MATLAB.

Size: px
Start display at page:

Download "The dual reciprocity boundary element method for. two-dimensional Burgers equations using MATLAB."

Transcription

1 The dual reciprocity boundary element method for two-dimensional Burgers equations using MATLAB. W. Toutip 1, S. Kaennakam 1 and A. Kananthai 2 1 Department of Mathematics, Khon Kaen University, Khon Kaen 40002, THAILAND 2 Department of Mathematics, Chiang Mai University, Chiang Mai 50200, THAILAND Abstract The 2-dimensional Burgers equations is a mathematical model to describe various kind of phenomena such as turbulence and viscous fluid. The traditional methods such as finite difference and finite element method have been used to solve the problem. In this work we introduce the dual reciprocity boundary element method to handle such problem. A new modern language, MATLAB is developed to implement a program applying the method to the problem. Numerical results are compared with those of exact solutions. 1. Introduction 1.1 The Dual Reciprocity Boundary Element Method The Boundary Element Method (BEM) has become an important tool for solving problems in applied science and engineering. Its origins are quite recent compared with those of the Finite Difference Method(FDM) and the Finite Element Method (FEM). The BEM has its beginnings in the early 1960s with the research work of Massonet(1956)[1], Rizzo(1967)[2] and Cruse (1969) in elasticity, Jaswon(1963)[3] and Symm(1963)[4] in potential theory, Hess and Smith(1964)[5] in aerodynamics, Shaw(1970) [6] in acoustics and Rizzo and Shippy(1970)[7] in heat condition, in which the underlying physical processes are expressed as integral equations posed on the boundary of the region of interest.the term boundary element method was first used by Brebbia and Dominguez(1977)[8] who realize the analogy between the discretisation process for the boundary integral method and that for the already established finite element method. Presently, the BEM is a very active field of study especially within the engineering community, and it is experiencing very rapid development in research and applications

2 2 worldwide. The followings are some points of view about the features and the capability of BEM form researchers. One of the most interesting features of the BEM is the much smaller system of equations and the considerable reduction of the data required to run a program. Moreover, the numerical accuracy of the method is generally greater than that the FEM (Brebbia, 1978)[9]. The BEM has emerged as a powerful alternative to the FEM, particularly in case where better accuracy is required due to difficulties such as stress concentration or where the domain extends to infinity (Ciskowski and Brebbia, 1991)[10]. The BEM is well established by now as an accurate and powerful numerical technique in continuum mechanics (Becker,1992)[11]. The most important feature of the BEM is that it requires only the discretisation of the boundary rather than the domain. It is now gaining very considerable popularity and being incorporated into high-speed computer algorithms immediately useful to the practicing analyst (Banerjee, 1994)[12]. The BEM occupies a less prominent role in engineering than its features and capability due to the complexity of the mathematical background (Paris and Canas, 1997)[13]. More introductory discussion on this subject can be founded in Brebbia and Dominguez(1989). Boundary elements are usually associated with direct formulations in which the problem unknowns are the physical variables, for instance potential or fluxes, what is more attractive to users than the indirect formulations, used mainly before 1978, which involve concepts such as sources or dipoles. The direct formulation is somewhat more general, elegant and simple to apply in computer codes. However, there are some difficulties in extending the method to applications such as non-homogeneous, non-linear and time dependent problems. The main drawback in these cases is the need to discretize the domain into a series of internal cells to deal with the terms taken to the boundary by application of the fundamental solution. This additional discretization destroys some of the attraction of the method. A new approach is needed to deal with domain integrals in boundary element. Several methods have been proposed by different authors. The dual reciprocity boundary element method (DRM) is essentially a generalized way of constructing particular solutions that can be used to solve non-linear problems.

3 3 1.2 Burgers Equation In recent years, Burgers equation have received a considerable amount of attention due to the large number of physically important phenomena [14] that can be modeled using these equation. Several studies have been published on the numerical solution of Burgers equations and related problems, and some attention has been given to the convection-dominated case. In this direction, Thomaidis et al. [15] studied a finite difference method using the modified method of characteristics, and Caldwell et al. [16] present a solution based on finite elements with moving nodes. Other studies include those of Christie et al., Staughan et al., Van Niekerk and Van Niekerk, and Saunders et al. [17-20]. All of the above studies concentrate on the one-dimensional Burgers equation, both steady and time-dependent. An extensive comparative study of finite difference and finite element solutions of the two-dimensional problem was performed by Fletcher [21] who used a time split algorithm to obtain steady-state solutions of Burgers equations. The Burgers equation is one of the very few nonlinear partial differential equation which can be solved exactly for a restricted set of initial function φ(x), only. In the context of gas dynamic, Hopf [22] and Cole [23] independently showed that this equation can be transformed to the linear diffusion equation and solved exactly for an arbitrary initial condition. The study of the general properties of the Burgers equation has motivated considerable attention due to its applications in field as diverse as number theory, gas dynamics, heat conduction, elasticity, etc. 1.3 Matlab Computer Program MATLAB is an interactive system for numerical computation. Numerical analyst Cleve Moler wrote the initial Fortran version of MATLAB in the late 1970s as a teaching aid. It became popular for both teaching and research and evolved into a commercial software package written in C. For many years now, MATLAB has been widely used in universities and industry. MATLAB has several advantages over more traditional means of numerical computing (e.g., writing Fortran or C programs can calling numerical libraries): It allows quick and easy coding in a very high-level language.

4 Data structures require minimal attention; in particular, arrays need not be declared before first use An interactive interface allows rapid experimentation and easy debugging High-quality graphics and visualization facilities are available MATLAB M-files are completely portable across a wide range of platforms Toolboxes can be added to extend the system, giving, for example, specialized signal processing facilities and a symbolic manipulation capability A wide rang of user-contributed M-files is freely available on the Internet. Furthermore, MATLAB is a modern programming language and problem solving environment: it has sophisticated data structures, contains built-in debugging and profiling tools, and supports object-oriented programming. These factors make MATLAB an excellent language for teaching and a powerful tool for research and practical problem solving(see more detail in [24]). 2 Formulation of The Dual Reciprocity Method Consider the Poisson equation 2 u = b (1) where b = b(x, y). The solution to above equation can be expressed as the sum of the solution of homogenous and a particular solution as u = u h + û (2) where u h is the solution of the homogeneous equation and û is a particular solution of the Poisson equation such that 2 û = b (3) We approximate b as a linear combination of interpolation functions for each of which we can find a particular solution at points which are situated in the domain and on its boundary. If there are N boundary nodes and L internal nodes, there will be N + L interpolation functions, f j, and consequently N + L particular solution, û j.

5 5 The approximation of b over domain Ω is written in the form b(x, y) N+L j=1 α j f j (x, y) (4) If b i and f ij are the values of b and f j at node i respectively, then we have a matrix equation for the unknown coefficients α j : j = 1, 2,..., N + L as b=fα (5) The particular solutions û j, and the interpolation function, f j are linked through the relation 2 û j = f j (6) The interpolation function is also called radial basis function. In this work we use the linear function f = 1 + r. Substituting equation (6) into (4) gives b N+L j=1 α( 2 û j ) (7) Equation (7) can be substituted into the original equation (1) to give the following expression 2 u = N+L j=1 α( 2 û j ) (8) Multiplying by the fundamental solution and integrating over the domain, we obtain Ω ( 2 u)u dω = N+L j=1 α j Ω ( 2 û j )u dω (9) Note that the same result may be obtained from equation ( 2 u)u dω = bu dω (10) Ω Integrating by parts the Laplacian terms in (9) produce the following integral equation for each source node i (Partridge and Brebbia, 1992): c i u i + Γ q udγ Γ u qdγ = N+L j=1 Ω α j (c i û ij + Γ q û j dγ u ˆq j dγ) (11) Γ

6 6 The term ˆq j in equation (11) is defined as ˆq j = û j, where n is the unit outward normal n to Γ, and can be written as ˆq j = û j x x n + û j y y n Note that equation (11) involves no domain integrals. The next step is to write equation (11) in discretise form, with summations over the boundary elements replacing the integrals. This gives, for a source node i, the expression c i u i + Γ k q udγ Γ k u qdγ = N+L j=1 α j (c i û ij + Γ k q û j dγ (12) u ˆq ) j dγ Γ k After introducing the interpolation function and integrating over each boundary element, the above equation can be written in terms of nodal values as c i u i + H ik u k G ik q k = N+L j=1 α j (c i û ij + H ik û kj ) G ik ˆq kj where the definition of the terms H ik and G ik are defined as in [26]. The index k is used for the boundary nodes which are the field points. After application to all boundary nodes, using a collocation technique, equation (14) can be expressed in matrix form as Hu Gq = N+L j=1 (13) (14) α j (Hû j Gˆq j ) (15) If each of the vectors û j and ˆq j is considered to be one column of the matrices Ûj and ˆQ j respectively, then equation (15) may be written without the summation to produce Hu Gq = (HÛ G ˆQ)α (16) Note that equation (14) contains no domain integrals. The source term b in (1) has been substituted by equivalent boundary integrals. This was done by first approximating b using equation (7), and then expressing both the right and left hand sided of the resulting expression as boundary integrals using the second form of Green s theorem or a reciprocity principle. It is this operation which gives the name to the method: reciprocity has been applied to both side of (9) to take all the terms to the boundary, hence Dual Reciprocity Boundary Element Method.

7 7 From equation (5), α is given as α = F 1 b (17) the right hand side of equation (16) is thus a known vector. It can be written as Hu-Gq=d (18) where the vector d is defined as d = ( HÛ G ˆQ ) α (19) Applying boundary condition to (18), this equation reduces to the form Ax = y (20) where x contain N unknown boundary values of u and q. After equation (20) is solved using standard techniques such as Gaussian elimination, the values at any internal node can be calculated from equation (14), each one involving a separate multiplication of known vectors and matrices. In the case of internal nodes, we have c i = 1 and equation (14) becomes u i = H ik u k + G ik q k + N+L j=1 α j (c i û ij + H ik û kj ) G ik ˆq kj (21) 3 Computer implementation of the DRM for Burgers equation We first substitute equation (17) into equation (16) to get the equation system matrix which expressed as Hu Gq = (HÛ G ˆQ)F 1 b (22) Setting then equation (22) becomes S = (HÛ G ˆQ)F 1 (23) Hu Gq = Sb (24)

8 8 Consider the following system of two-dimensional Burgers equation: subject to the initial condition: u t + u u x + v u y = 1 R ( 2 u) (25) v t + u v x + v v y = 1 R ( 2 v) (26) u(x, y, 0) = φ 1 (x, y), (27) v(x, y, 0) = φ 2 (x, y), (28) where (x, y) D and the boundary condition: u(x, y, t) = ϕ(x, y, t), (29) where x, y D, t > 0 v(x, y, t) = ψ(x, y, t), (30) and D is a domain of the problem, D is its boundary; u(x, y, t) and v(x, y, t) are the velocity components to be determined, φ 1, φ 2, ϕ and ψ are known functions and R is the Reynolds number, which described in [31]. The analytic solution of (25) and (26) was given by Fletcher using the Hopf-Cole transformation [27]. The numerical solutions of this equation system have been studied by several authors. Jain and Holla [28] developed two algorithms based on cubic spline function technique. Fletcher [29] has discussed the comparison of a number of different numerical approaches. As described in [26], u u, u v, v u x y x obtain and and v v y are approximated similarly. Then we u u x = U F x F 1 u (31) v u y = V F y F 1 u (32) u v x = U F x F 1 v (33) v u y = V F y F 1 v (34)

9 9 From equation (22) and (24) we obtain Hu Gq = (HÛ G ˆQ)F 1 b 1 (35) and Hv Gz = (H ˆV GẐ)F 1 b 2 (36) where q = u n, z = v n and b 1 = R( u t + u u x + v u y ) (37) b 2 = R( v t + u v x + v v y ) (38) In the case, if we consider Û, ˆV to be generated by using the same redial basis function, then we get Û = ˆV (39) which yield Setting ˆQ = Ẑ (40) S = (HÛ G ˆQ)F 1 (41) then equation (35) and (36) becomes Hu Gq = Sb 1 (42) and Hv Gz = Sb 2 (43) For the time derivatives, we use the forward difference method to approximate time derivative u t v and. The forward difference is expressed as t u = ut+1 u t t v = vt+1 v t t (44) (45)

10 10 where u = u and v = v t t Substituting equation (31) to (34), (37) and (38) in equation (42) and (43), then Setting then equation (46) and (47) becomes (Hu-Gq) = SR( u + U F x F 1 u + V F y F 1 u) (46) (Hv-Gz) = SR( v + U F x F 1 v + V F y F 1 v) (47) C = U F x F 1 + V F y F 1 (48) (Hu-Gq) = SR( u + Cu) (49) and (Hv-Gz) = SR( v + Cv) (50) respectively. Substituting equation (44) and (45) in above equations. The following expressions are obtained (RSC + SR t H)ut+1 + Gq t+1 = RS t ut (51) (RSC + SR t H)vt+1 + Gz t+1 = RS t vt (52) Note that the element of matrices H, G and S depend only on geometrical data. Thus, they can all be computed once and stored. In computing step using MATLAB we apply the initial condition to the right side of equation (51) and (52), and boundary conditions to the left hand side of the two equations. In each time step, the iteration will be used to get the suitable solution. For the detail of this, we explain step by step as the following. 1. Construct C in equation (48) by setting it be zero for the first iterative loop for both U and V. 2. Set all the values appearing in equation (51) and (52), then apply the initial condition on right side and boundary condition on left side which reduce those equations into equation system Ax = y

11 11 3. After solving this equation system, we get the solutions of U and V. Then the both solutions will be tested by condition of iteration method. If they are considered to be good enough, they will be used to be as the initial condition in next time-step. However, if they are not, they will be used to construct C in next iterative loop and computing in similar way again. 4. This iterative loop is processing continuously until the solutions of U and V satisfy the condition of the method in each time-step. The main parts of this program are shown below C=(Usq*DFX+Vsq*DFY)*Finv; T=R*A*C+(R*A/delt)-HNEW; S=R*A/delt; % Construct matrix to change to be in form Ax=y AAu2=mtAAu2(n,l,T,GNEWL); % can be used in both case of U and V BBu2=mtBBu2(n,l,T,GNEWL); % can be used in both case of U and V bdcu=sfbdu(n,l,xb,yb,delt,t,r);%applying boundary condition for U bdcv=sfbdv(n,l,xb,yb,delt,t,r);%applying boundary condition for v BRU=(S*Urhs-BBu2*bdcU); BRV=(S*Vrhs-BBu2*bdcV); % Construct new matrix containing two systems of U and V LMIUV=mixUVL(n,l,AAu2); % LHS of Ax=B RMIUV=mixUVR(n,l,BRU,BRV); % RHS of Ay=B SolUV=(inv(LMIUV))*RMIUV; % solution % Seperate values of U and V from known values SolUV Uval3=solU3(SolUV,bdcU,n,l);%the value of U at every node in domain Vval3=solV3(SolUV,bdcV,n,l);%the value of V at every node in domain Uval=Uval3; % is the solution of U Vval=Vval3; % is the solution of V

12 12 4 Numerical examples The program using MATLAB has been successfully used in the implementation of the DRM for both linear and non-linear problem. We present here only the Burgers equation as the following examples: Example 1 Burgers equation Consider Burgers equation (Partridge and Brebbia,1992[25]) 2 u = u u x (53) on the elliptical domain in the positive quadrant as shown in Figure 1.1 (3,1) 13 (1,0) 1 9 (5,0) 5 : Boundary node (3,-1) : Internal point Figure 1.1 Discretisation of the boundary into 16 elements in elliptical domain The boundary condition is the Dirichlet condition with u = 2 x on the boundary. The normal derivative agrees well with the exact solution as shown in Figure 1.2. Now the exact is defined as follows q = 1 2 [ (x 3) 2 + 4y 4 2 x ][ (x 3) ] 2 2 The internal solution is compared with those of the method in Partridge and Brebbia (1992) [29] and the exact solution in Table 1.1.

13 13 Table 1.1 Internal solutions for the problem in Example 1 Point This work Partridge Exact (4.50,0.00) (4.20,-0.35) (3.60,-0.45) (3.00,-0.45) (2.40,-0.45) (1.80,-0.35) (1.50,0.00) Normal Derivative on the boundary This work Exact Normal derivative Node figure 1.2 Normal derivative on the boundary Example 2 The 2-dimensional of Burgers equation Consider the two-dimensional Burgers equation with the following conditions u t + u u x + v u y = 1 R ( 2 u) (54) v t + u v x + v v y = 1 R ( 2 v) (55)

14 14 1. Domain of the problem is D = (x, y) : 0 x 1, 0 y 1 2. Both boundary and initial condition are taken from the exact solution given by u(x, y, t) = [1 + exp(( 4x + 4y t)r/32)] v(x, y, t) = [1 + exp(( 4x + 4y t)r/32)] 3. R=100, tolerance ɛ = 10 5 of iteration step The boundary is discretized into 80 nodes with 9 internal nodes. The internal solution values of u and v at time t=0.01 with time step t = 10 5 are compared with those from A.R. Bahadir [31] and the exact solutions as shown in Figure 2.1 and Figure 2.2 Comparision of numerical and exact values of u for R= This work A.R.Bahadir 0.85 Exact 0.8 Values Nodes Figure 2.1 Comparison of solution of u at t=0.01 We can see from Figure 2.1 and Figure 2.2 that the numerical solutions are compared well with those from A.R. Bahadir [31] and the exact solution.

15 15 Comparision of numerical and exact values of v for R= This work A.R.Bahadir 1.05 Exact Values Nodes Figure 2.2 Comparison of solution of v at t= Conclusion We have shown how to apply the dual reciprocity boundary element method using MATLAB to solve Burgers equation. Numerical results for both examples are compared well with those from the exact solutions. The ideas developed above can be applied to any problem which may reduced to a pair of non-linear problems. The following comments may be used to improve the solutions of such problem 1. Using other radial basis functions such as the augmented thin plate spline expressed as f = r 2 log(r) + a + bx + cy. 2. Applying Newton iteration method 3. Using the gradient approach to deal with corner problems References [1] C.E. Massonet, Solution du probleme aux tensions de l elasticite tridimensional, Proc.9th Cong.,Appl Mech.,(1956), [2] F.J. Rizzo, An integral equation approach to boundary value problems of classical elastostatics,quart., Appl.Math.,Vol. 25,(1967),83-95.

16 16 [3] M.A. Jaswan, Integral equation methods in potential theory I, Proceedings of the Royal society, Vol. 275,(1963), [4] G.T. Symm, Integral equation methods in potential theory II, Proceedings of the Royal society, Vol. 275,(1963), [5] J. Hess and A.M.O. Smith, Calculation of non-lifting potential flow about arbitrary three-dimension bodies,journal of Ship Research, Vol. 8, (1964), [6] R.P. Shaw, An integral equation approach to acoustic radiation and scattering, topic in Ocean Engineering II, Houston, Gulf Publishing Co., [7] F.J. Rizzo and D.J. Shippy, A method of solution for certain problems of transient heat conduction, AIAA Journal, Vol. 8, (1970), [8] C.A. Brebbia add J. Dominguez, Boundary element methods for potential problems,applied Mathematical Modelling, Vol. 1, (1970), 7. [9] C.A. Brebbia, The boundary element method for engineers, Pentech Press, [10] R.D. Ciskawski and C.A. Brebbia, Boundary element method in acoustics, Addison-Wesley, [11] A.A. Becker, The boundary element method in engineering, Berkshire:McGraw-Hill, [12] P.K. Benerjee, The boundary element methods in engineering, Cambridge:McGraw-Hill, [13] F. Paris and J. Cañas, Boundary element method:fundamentals and application, Oxford University Press, [14] C.A. Fletcher, Burgers equation: a model for all reasons, in: J. Noye (Ed.), Numerical Solution of Partial Differential Equations, North-Holland, Amsterdam, [15] G. Thomaidis, K. Zygourakis, M. Wheeler, An explicit finite difference scheme based on the modified method of characteristics for solving convection-diffusion problems in one space dimension, Numer. Meth. Partial Differential Equation, Vol. 4, (1988), [16] J. Caldwell, P. Wanless, A.E. Cook, Solution of Burgers equation for large reynolds number using finite elements with moving nodes, Appl. Math. Modelling, Vol. 11, (1987),

17 17 [17] I. Christie et al., Product approximation for non-linear problems in the finite element method, IMA J. Numer. Anal., Vol. 1, (1981), [18] B. Straughan et al., Nonlinear stability for a modified form of Burgers equation Numer. Meth. Partial Differential Equations, Vol. 3, (1987), [19] A. Van Niekerk, The boundary element method for engineers, Pentech Press, [20] R. Saunders, J. Caldwell, P. Wanless, A variational-iterative scheme applied to Burgers equation, IMA J. Numer. Anal., Vol. 4, (1984), [21] C.A. Fletcher, A comparison of finite element and finite difference solution of the, one- and two-dimensional Burgers equations, J. Comput. Phys., Vol. 51, (1983), [22] E. Hopf, The partial differential equation u t + uu x = µu xx,comm. Pure Appl. Math., Vol. 3, (1950, [23] J.D. Cole, On a quaslinear parabolic equations occurring in aerodynamics, Quart. Appl. Math., Vol. 9, (1951), [24] D.J. Higham, A.E. Cook, MATLAB guide, University of Strathclyde Glasgow, Scotland, [25] P.W. Partridge, C.A. Brebbia, L.C. Wrobel, The Dual Reciprocity Boundary, Element Method, Jouthampton Boston, Computational Mechanics Publications, [26] W. Toutip, The dual reciprocity boundary element method for linear and nonlinear, problems, Degree of Doctor, University of Hertfordshire, England: [27] C.A.J. Fletcher, Generating exact solutions of the two-dimensional Burgers, equationint. J. Numer. Meth. Fluids., Vol. 3, (1983), [28] P.C. Jain and D.N. Holla, Numerical solution of coupled Burgers equations, Int. J. Numer. Meth. Eng., Vol. 12, (1978), [29] C.A.J. Fletcher, A comparison of finite element and finite difference solution of the one- and two-dimensional Burgers equations, J. Comput. Phys., Vol. 51, (1983),

18 18 [30] F.W. Wubs and E.D. de Goede, An explicit-implicit method for a class of timedependent partial differential equations, Appl. Numer. Math., Vol. 9, (1992), [31] A. Refik Bahadir, A fully implicit finite-difference scheme for two-dimensional Burgers equations, Applied Mathematics and Computation, Vol. 137, (2003),

University of Hertfordshire Department of Mathematics. Study on the Dual Reciprocity Boundary Element Method

University of Hertfordshire Department of Mathematics. Study on the Dual Reciprocity Boundary Element Method University of Hertfordshire Department of Mathematics Study on the Dual Reciprocity Boundary Element Method Wattana Toutip Technical Report 3 July 999 Preface The boundary Element method (BEM) is now recognised

More information

Australian Journal of Basic and Applied Sciences

Australian Journal of Basic and Applied Sciences AESI Journals Australian Journal of Basic and Applied Sciences ISS:1991-8178 Journal home page: www.ajbasweb.com Optimal Radial Basis Function () for Dual Reciprocity Boundary Element Method (DRBEM) applied

More information

Dual Reciprocity Boundary Element Method for Magma Ocean Simulations

Dual Reciprocity Boundary Element Method for Magma Ocean Simulations Dual Reciprocity Boundary Element Method for Magma Ocean Simulations Tyler W. Drombosky drombosk@math.umd.edu Saswata Hier-Majumder saswata@umd.edu 28 April 2010 Physical Motivation Earth s early history

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

A new meshless method for steady-state heat conduction problems in anisotropic and inhomogeneous media

A new meshless method for steady-state heat conduction problems in anisotropic and inhomogeneous media Archive of Applied Mechanics 74 25 563--579 Springer-Verlag 25 DOI 1.17/s419-5-375-8 A new meshless method for steady-state heat conduction problems in anisotropic and inhomogeneous media H. Wang, Q.-H.

More information

Automatic optimization of the cooling of injection mold based on the boundary element method

Automatic optimization of the cooling of injection mold based on the boundary element method Automatic optimization of the cooling of injection mold based on the boundary element method E. Mathey, L. Penazzi, F.M. Schmidt and F. Rondé-Oustau Research Center on Tools, Materials and Forming Processes,

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

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

Iterative schemes for the solution of systems of equations arising from the DRM in multidomains

Iterative schemes for the solution of systems of equations arising from the DRM in multidomains CHAPTER 7 Iterative schemes for the solution of systems of equations arising from the DRM in multidomains M.I. Portapila 1 &H.Power 2 1 Wessex Institute of Technology, UK. 2 Department of Mechanical Engineering,

More information

UNIVERSITY OF HERTFORDSHIRE DEPARTMENT OF MATHEMATICS

UNIVERSITY OF HERTFORDSHIRE DEPARTMENT OF MATHEMATICS UNIVERSITY OF HERTFORDSHIRE DEPARTMENT OF MATHEMATICS A multiple node method for corners and discontinuous boundary problems in the boundary element method Wattana Toutip Technical Report April 999 Abstract

More information

HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS

HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS ABSTRACT Of The Thesis Entitled HIGH ACCURACY NUMERICAL METHODS FOR THE SOLUTION OF NON-LINEAR BOUNDARY VALUE PROBLEMS Submitted To The University of Delhi In Partial Fulfillment For The Award of The Degree

More information

Fast multipole boundary element method for the analysis of plates with many holes

Fast multipole boundary element method for the analysis of plates with many holes Arch. Mech., 59, 4 5, pp. 385 401, Warszawa 2007 Fast multipole boundary element method for the analysis of plates with many holes J. PTASZNY, P. FEDELIŃSKI Department of Strength of Materials and Computational

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

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

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

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

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

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

More information

On the use of multipole methods for domain integration in the BEM

On the use of multipole methods for domain integration in the BEM On the use of multipole methods for domain integration in the BEM A.A. Mammoii, M.S. Ingber & M.J. Brown Department of Mechanical Engineering, University of New Mexico, USA Abstract Often, a single application

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Peter Benner and Jan Heiland November 5, 2015 Seminar Talk at Uni Konstanz Introduction Motivation A controlled physical processes

More information

Variational Iteration Method for Solving Nonlinear Coupled Equations in 2-Dimensional Space in Fluid Mechanics

Variational Iteration Method for Solving Nonlinear Coupled Equations in 2-Dimensional Space in Fluid Mechanics Int J Contemp Math Sciences Vol 7 212 no 37 1839-1852 Variational Iteration Method for Solving Nonlinear Coupled Equations in 2-Dimensional Space in Fluid Mechanics A A Hemeda Department of Mathematics

More information

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Solutions of Burgers Equation

Solutions of Burgers Equation ISSN 749-3889 (print, 749-3897 (online International Journal of Nonlinear Science Vol.9( No.3,pp.9-95 Solutions of Burgers Equation Ch. Srinivasa Rao, Engu Satyanarayana Department of Mathematics, Indian

More information

Finite difference method for solving Advection-Diffusion Problem in 1D

Finite difference method for solving Advection-Diffusion Problem in 1D Finite difference method for solving Advection-Diffusion Problem in 1D Author : Osei K. Tweneboah MATH 5370: Final Project Outline 1 Advection-Diffusion Problem Stationary Advection-Diffusion Problem in

More information

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

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

More information

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Journal of Computational and Applied Mechanics, Vol.., No. 1., (2005), pp. 83 94 BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Vladimír Kutiš and Justín Murín Department

More information

The use of exact values at quadrature points in the boundary element method

The use of exact values at quadrature points in the boundary element method The use of exact values at quadrature points in the boundary element method N.D. Stringfellow, R.N.L. Smith Applied Mathematics & OR Group, Cranfield University, Shrivenham, Swindon, U.K., SN6 SLA E-mail:

More information

Transient 3D Heat Conduction in Functionally. Graded Materials by the Method of Fundamental. Solutions

Transient 3D Heat Conduction in Functionally. Graded Materials by the Method of Fundamental. Solutions Transient 3D Heat Conduction in Functionally Graded Materials by the Method of Fundamental Solutions Ming Li*, C.S. Chen*, C.C. Chu, D.L.Young *Department of Mathematics, Taiyuan University of Technology,

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall

MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall James Cherry, Mehmet Sözen Grand Valley State University, cherryj1@gmail.com,

More information

Dual Reciprocity Method for studying thermal flows related to Magma Oceans

Dual Reciprocity Method for studying thermal flows related to Magma Oceans Dual Reciprocity Method for studying thermal flows related to Magma Oceans Tyler Drombosky Ph.D. Student, Applied Mathematics Scientific Computation Department of Mathematics University of Maryland, College

More information

Solution of contact problems in linear elasticity using a feasible interior point algorithm for nonlinear complementarity problems

Solution of contact problems in linear elasticity using a feasible interior point algorithm for nonlinear complementarity problems 7 th World Congress on Structural and Multidisciplinary Optimization COEX Seoul, May - 5 May 007, Korea Solution of contact problems in linear elasticity using a feasible interior point algorithm for nonlinear

More information

New Developments of Frequency Domain Acoustic Methods in LS-DYNA

New Developments of Frequency Domain Acoustic Methods in LS-DYNA 11 th International LS-DYNA Users Conference Simulation (2) New Developments of Frequency Domain Acoustic Methods in LS-DYNA Yun Huang 1, Mhamed Souli 2, Rongfeng Liu 3 1 Livermore Software Technology

More information

1.The anisotropic plate model

1.The anisotropic plate model Pré-Publicações do Departamento de Matemática Universidade de Coimbra Preprint Number 6 OPTIMAL CONTROL OF PIEZOELECTRIC ANISOTROPIC PLATES ISABEL NARRA FIGUEIREDO AND GEORG STADLER ABSTRACT: This paper

More information

Finite volume method for nonlinear transmission problems

Finite volume method for nonlinear transmission problems Finite volume method for nonlinear transmission problems Franck Boyer, Florence Hubert To cite this version: Franck Boyer, Florence Hubert. Finite volume method for nonlinear transmission problems. Proceedings

More information

The variational homotopy perturbation method for solving the K(2,2)equations

The variational homotopy perturbation method for solving the K(2,2)equations International Journal of Applied Mathematical Research, 2 2) 213) 338-344 c Science Publishing Corporation wwwsciencepubcocom/indexphp/ijamr The variational homotopy perturbation method for solving the

More information

Numerical Solution of an Inverse Diffusion Problem

Numerical Solution of an Inverse Diffusion Problem Applied Mathematical Sciences, Vol. 1, 2007, no. 18, 863-868 Numerical Solution of an Inverse Diffusion Problem Y. Ahmadizadeh Physics Dept., Faculty of Sciences Air University, Postal Code 1384663113,

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

Transactions on Modelling and Simulation vol 8, 1994 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 8, 1994 WIT Press,   ISSN X Model analysis of plates using the dual reciprocity boundary element method T.W. Davies & F.A. Moslehy Department of Mechanical and Aerospace Engineering, University of Central Florida, Orlando, Florida,

More information

Transactions on Modelling and Simulation vol 12, 1996 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 12, 1996 WIT Press,   ISSN X Simplifying integration for logarithmic singularities R.N.L. Smith Department ofapplied Mathematics & OR, Cranfield University, RMCS, Shrivenham, Swindon, Wiltshire SN6 SLA, UK Introduction Any implementation

More information

Particle-based Fluids

Particle-based Fluids Particle-based Fluids Particle Fluids Spatial Discretization Fluid is discretized using particles 3 Particles = Molecules? Particle approaches: Molecular Dynamics: relates each particle to one molecule

More information

11.3 MATLAB for Partial Differential Equations

11.3 MATLAB for Partial Differential Equations 276 3. Generate the shape functions N (i) j = a (i) j where i =1, 2, 3,..., m and j =1, 2, 3,..., m. + b (i) j x + c(i) j y (11.2.17) 4. Compute the integrals for matrix elements α ij and vector elements

More information

Inverse Source Identification based on Acoustic Particle Velocity Measurements. Abstract. 1. Introduction

Inverse Source Identification based on Acoustic Particle Velocity Measurements. Abstract. 1. Introduction The 2002 International Congress and Exposition on Noise Control Engineering Dearborn, MI, USA. August 19-21, 2002 Inverse Source Identification based on Acoustic Particle Velocity Measurements R. Visser

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

Introduction to Heat Transfer Analysis

Introduction to Heat Transfer Analysis Introduction to Heat Transfer Analysis Thermal Network Solutions with TNSolver Bob Cochran Applied Computational Heat Transfer Seattle, WA TNSolver@heattransfer.org ME 331 Introduction to Heat Transfer

More information

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013 ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1 OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains

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

EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION

EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION EXACT SOLUTIONS TO THE NAVIER-STOKES EQUATION FOR AN INCOMPRESSIBLE FLOW FROM THE INTERPRETATION OF THE SCHRÖDINGER WAVE FUNCTION Vladimir V. KULISH & José L. LAGE School of Mechanical & Aerospace Engineering,

More information

Excel for Scientists and Engineers Numerical Method s. E. Joseph Billo

Excel for Scientists and Engineers Numerical Method s. E. Joseph Billo Excel for Scientists and Engineers Numerical Method s E. Joseph Billo Detailed Table of Contents Preface Acknowledgments About the Author Chapter 1 Introducing Visual Basic for Applications 1 Chapter

More information

International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June ISSN

International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June ISSN International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June-2013 1405 Numerical Solution of Burger s equation via Cole-Hopf transformed diffusion equation Ronobir C. Sarer 1 and

More information

Abstract INTRODUCTION

Abstract INTRODUCTION Iterative local minimum search for eigenvalue determination of the Helmholtz equation by boundary element formulation N. Kamiya,E. Andoh, K. Nogae Department ofinformatics and Natural Science, School of

More information

THREE-DIMENSIONAL FINITE DIFFERENCE MODEL FOR TRANSPORT OF CONSERVATIVE POLLUTANTS

THREE-DIMENSIONAL FINITE DIFFERENCE MODEL FOR TRANSPORT OF CONSERVATIVE POLLUTANTS Pergamon Ocean Engng, Vol. 25, No. 6, pp. 425 442, 1998 1998 Elsevier Science Ltd. All rights reserved Printed in Great Britain 0029 8018/98 $19.00 + 0.00 PII: S0029 8018(97)00008 5 THREE-DIMENSIONAL FINITE

More information

Finite volume method for CFD

Finite volume method for CFD Finite volume method for CFD Indo-German Winter Academy-2007 Ankit Khandelwal B-tech III year, Civil Engineering IIT Roorkee Course #2 (Numerical methods and simulation of engineering Problems) Mentor:

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

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Computational Design Forward design: direct manipulation of design parameters Level of abstraction Exploration

More information

1 Comparison of Kansa s method versus Method of Fundamental Solution (MFS) and Dual Reciprocity Method of Fundamental Solution (MFS- DRM)

1 Comparison of Kansa s method versus Method of Fundamental Solution (MFS) and Dual Reciprocity Method of Fundamental Solution (MFS- DRM) 1 Comparison of Kansa s method versus Method of Fundamental Solution (MFS) and Dual Reciprocity Method of Fundamental Solution (MFS- DRM) 1.1 Introduction In this work, performances of two most widely

More information

Partitioned Formulation for Solving 3D Frictional Contact Problems with BEM using Localized Lagrange Multipliers

Partitioned Formulation for Solving 3D Frictional Contact Problems with BEM using Localized Lagrange Multipliers Copyright c 2007 ICCES ICCES, vol.2, no.1, pp.21-27, 2007 Partitioned Formulation for Solving 3D Frictional Contact Problems with BEM using Localized Lagrange Multipliers L. Rodríguez-Tembleque 1, J.A.

More information

Understanding Transport Phenomena Concepts in Chemical Engineering with COMSOL Multiphysics

Understanding Transport Phenomena Concepts in Chemical Engineering with COMSOL Multiphysics Understanding Transport Phenomena Concepts in Chemical Engineering with COMSOL Multiphysics Erick S. Vasquez, Ph.D. Department of Chemical and Materials Engineering, University of Dayton, Dayton, OH, USA

More information

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator Martin J. Gander and Achim Schädle Mathematics Section, University of Geneva, CH-, Geneva, Switzerland, Martin.gander@unige.ch

More information

Mathematical Preliminaries

Mathematical Preliminaries Mathematical Preliminaries Introductory Course on Multiphysics Modelling TOMAZ G. ZIELIŃKI bluebox.ippt.pan.pl/ tzielins/ Table of Contents Vectors, tensors, and index notation. Generalization of the concept

More information

An adaptive fast multipole boundary element method for the Helmholtz equation

An adaptive fast multipole boundary element method for the Helmholtz equation An adaptive fast multipole boundary element method for the Helmholtz equation Vincenzo Mallardo 1, Claudio Alessandri 1, Ferri M.H. Aliabadi 2 1 Department of Architecture, University of Ferrara, Italy

More information

Transactions on Modelling and Simulation vol 13, 1996 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 13, 1996 WIT Press,  ISSN X The cooling of molten glass in a mould Ph. Simons, R. Mattheij Scientific Computing Group, Eindhoven University of Technology, 56 MB Eindhoven, The Netherlands Abstract The actual formation of glass jars

More information

A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer

A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer Copyright c 2008 ICCES ICCES, vol.6, no.1, pp.13-18 A Meshless Radial Basis Function Method for Fluid Flow with Heat Transfer K agamani Devi 1,D.W.Pepper 2 Summary Over the past few years, efforts have

More information

Numerical Methods for Engineers and Scientists

Numerical Methods for Engineers and Scientists Numerical Methods for Engineers and Scientists Second Edition Revised and Expanded Joe D. Hoffman Department of Mechanical Engineering Purdue University West Lafayette, Indiana m MARCEL D E К К E R MARCEL

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

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems Partitioned Methods for Multifield Problems Joachim Rang, 10.5.2017 10.5.2017 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 Contents Blockform of linear iteration schemes Examples 10.5.2017

More information

Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations

Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations Ming-Jun Lai, Chun Liu, and Paul Wenston Abstract We numerically simulate the following two nonlinear evolution equations with a fourth

More information

GeoPDEs. An Octave/Matlab software for research on IGA. R. Vázquez. IMATI Enrico Magenes, Pavia Consiglio Nazionale della Ricerca

GeoPDEs. An Octave/Matlab software for research on IGA. R. Vázquez. IMATI Enrico Magenes, Pavia Consiglio Nazionale della Ricerca GeoPDEs An Octave/Matlab software for research on IGA R. Vázquez IMATI Enrico Magenes, Pavia Consiglio Nazionale della Ricerca Joint work with C. de Falco and A. Reali Supported by the ERC Starting Grant:

More information

Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics

Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics Excerpt from the Proceedings of the COMSOL Conference 2009 Milan Solving Distributed Optimal Control Problems for the Unsteady Burgers Equation in COMSOL Multiphysics Fikriye Yılmaz 1, Bülent Karasözen

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

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

MATH 333: Partial Differential Equations

MATH 333: Partial Differential Equations MATH 333: Partial Differential Equations Problem Set 9, Final version Due Date: Tues., Nov. 29, 2011 Relevant sources: Farlow s book: Lessons 9, 37 39 MacCluer s book: Chapter 3 44 Show that the Poisson

More information

Partial Differential Equations

Partial Differential Equations Part II Partial Differential Equations Year 2015 2014 2013 2012 2011 2010 2009 2008 2007 2006 2005 2015 Paper 4, Section II 29E Partial Differential Equations 72 (a) Show that the Cauchy problem for u(x,

More information

Thermal Network Analysis with TNSolver

Thermal Network Analysis with TNSolver Thermal Network Analysis with TNSolver Steady Conduction - The Composite Wall Problem Bob Cochran Applied Computational Heat Transfer Seattle, WA rjc@heattransfer.org ME 331 Introduction to Heat Transfer

More information

Elements of Matlab and Simulink Lecture 7

Elements of Matlab and Simulink Lecture 7 Elements of Matlab and Simulink Lecture 7 Emanuele Ruffaldi 12th May 2009 Copyright 2009,Emanuele Ruffaldi. This work is licensed under the Creative Commons Attribution-ShareAlike License. PARTIAL DIFFERENTIAL

More information

Semi-analytical solution of Poisson's equation in bounded domain

Semi-analytical solution of Poisson's equation in bounded domain Semi-analytical solution of Poisson's equation in bounded domain Author Song, Hao, Tao, L. Published 21 Journal Title ANZIAM Journal Copyright Statement 21 Australian Mathematical Society. The attached

More information

Nodal and divergence-conforming boundary-element methods applied to electromagnetic scattering problems

Nodal and divergence-conforming boundary-element methods applied to electromagnetic scattering problems Nodal and divergence-conforming boundary-element methods applied to electromagnetic scattering problems M. Afonso, Joao Vasconcelos, Renato Mesquita, Christian Vollaire, Laurent Nicolas To cite this version:

More information

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS IJRET: International Journal of Research in Engineering and Technology eissn: 39-63 pissn: 3-738 FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS Asish Mitra Reviewer: Heat

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

1.1 Implicit solution for vertical viscosity and diffusion terms using finite differences

1.1 Implicit solution for vertical viscosity and diffusion terms using finite differences 1 Vertical viscosity and diffusion operators in ROMS The purpose of this document is to provide sufficient technical detail for the implicit solvers in ROMS code. Although the mathematical concepts are

More information

The Method of Fundamental Solutions with Eigenfunction Expansion Method for Nonhomogeneous Diffusion Equation

The Method of Fundamental Solutions with Eigenfunction Expansion Method for Nonhomogeneous Diffusion Equation The Method of Fundamental Solutions with Eigenfunction Expansion Method for Nonhomogeneous Diffusion Equation D. L. Young, 1 C. W. Chen, 1 C. M. Fan, 1 C. C. Tsai 2 1 Department of Civil Engineering and

More information

Kasetsart University Workshop. Multigrid methods: An introduction

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

More information

Some asymptotic properties of solutions for Burgers equation in L p (R)

Some asymptotic properties of solutions for Burgers equation in L p (R) ARMA manuscript No. (will be inserted by the editor) Some asymptotic properties of solutions for Burgers equation in L p (R) PAULO R. ZINGANO Abstract We discuss time asymptotic properties of solutions

More information

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS Proceedings of ALGORITMY 2009 pp. 1 10 SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS MILOSLAV VLASÁK Abstract. We deal with a numerical solution of a scalar

More information

SOLVING INHOMOGENEOUS PROBLEMS BY SINGULAR BOUNDARY METHOD

SOLVING INHOMOGENEOUS PROBLEMS BY SINGULAR BOUNDARY METHOD 8 Journal of Marine Science and Technology Vol. o. pp. 8-4 03) DOI: 0.69/JMST-0-0704- SOLVIG IHOMOGEEOUS PROBLEMS BY SIGULAR BOUDARY METHOD Xing Wei Wen Chen and Zhuo-Jia Fu Key words: singular boundary

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

First- and second-order sensitivity analysis schemes by collocation-type Trefftz method

First- and second-order sensitivity analysis schemes by collocation-type Trefftz method Computer Assisted Mechanics and Engineering Sciences, 4: 477 489, 1997 Copyright c 1997 by Polska Akademia Nauk First- and second-order sensitivity analysis schemes by collocation-type Trefftz method Eisuke

More information

SOE3213/4: CFD Lecture 3

SOE3213/4: CFD Lecture 3 CFD { SOE323/4: CFD Lecture 3 @u x @t @u y @t @u z @t r:u = 0 () + r:(uu x ) = + r:(uu y ) = + r:(uu z ) = @x @y @z + r 2 u x (2) + r 2 u y (3) + r 2 u z (4) Transport equation form, with source @x Two

More information

Introduction of Partial Differential Equations and Boundary Value Problems

Introduction of Partial Differential Equations and Boundary Value Problems Introduction of Partial Differential Equations and Boundary Value Problems 2009 Outline Definition Classification Where PDEs come from? Well-posed problem, solutions Initial Conditions and Boundary Conditions

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

Effects of tool eccentricity on wave dispersion properties in borehole acoustic logging while drilling

Effects of tool eccentricity on wave dispersion properties in borehole acoustic logging while drilling Effects of tool eccentricity on wave dispersion properties in borehole acoustic logging while drilling Yibing Zheng and M. Nafi Toksöz Earth Resources Laboratory Dept. of Earth, Atmospheric, and Planetary

More information

Contents. Prologue Introduction. Classical Approximation... 19

Contents. Prologue Introduction. Classical Approximation... 19 Contents Prologue........................................................................ 15 1 Introduction. Classical Approximation.................................. 19 1.1 Introduction................................................................

More information

Department of Structural, Faculty of Civil Engineering, Architecture and Urban Design, State University of Campinas, Brazil

Department of Structural, Faculty of Civil Engineering, Architecture and Urban Design, State University of Campinas, Brazil Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm A SIMPLIFIED FORMULATION FOR STRESS AND TRACTION BOUNDARY IN- TEGRAL EQUATIONS USING THE

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information