Fourth Order Symmetric Finite Difference Schemes For The Wave Equation

Size: px
Start display at page:

Download "Fourth Order Symmetric Finite Difference Schemes For The Wave Equation"

Transcription

1 IT Licentiate theses 2-4 Fourth Order Symmetric Finite Difference Schemes For The Wave Equation ABRAHAM ZEMUI UPPSALA UNIVERSITY Department of Information Technology

2

3 Fourth Order Symmetric Finite Difference Schemes for the Wave Equation BY ABRAHAM ZEMUI December 2 DEPARTMENT OF SCIENTIFIC COMPUTING INFORMATION TECHNOLOGY UPPSALA UNIVERSITY UPPSALA SWEDEN Dissertation for the degree of Licentiate of Philosophy in Numerical Analysis at Uppsala University 2

4 Fourth Order Symmetric Finite Difference Schemes for the Wave Equation Abraham Zemui Department of Scientific Computing Information Technology Uppsala University Box 337 SE-75 5 Uppsala Sweden c Abraham Zemui 2 ISSN Printed by the Department of Information Technology, Uppsala University, Sweden

5 FOURTH ORDER SYMMETRIC FINITE DIFFERENCE SCHEMES FOR THE WAVE EQUATION ABRAHAM ZEMUI Dec., 2

6 Abstract. The solution of the acoustic wave equation in one space dimension is studied. The PDE is discretized using finite element approximation. A cubic piecewise Lagrange polynomial is used as basis. Consistent finite element and lumped mass schemes are obtained. These schemes are interpreted as finite difference schemes. Error analysis is given for these finite differences (only for constant coefficients). Key words. finite element approximation, error analysis, lumped mass approximations, finite difference approximation, Galerkin method, Helmholtz equation

7 Introduction There are several computational methods available for solving partial differential equations which are obtained as models from different disciplines of sciences. Among these are finite differences and finite element methods. These have their own advantages and disadvantages. The success of the finite element method in elliptic problems has put pressure on numerical analysts and engineers to give up classical difference methods and adopt finite element for linear time-dependent problems. The efficiency of highorder methods has been studied by Swartz and Wendroff in [] and by Kreiss and Oliger in [8]. On the other hand, high order finite difference operators that are used for solving partial differential equations are already obtained [2,]. However these schemes are not symmetric whereas those obtained by finite elements are symmetric. The main goal here is to produce high order symmetric finite difference schemes. These are constructed by using finite element methods. Symmetry reduces the number of independent variables from mathematical point of view. It helps in establishing stability [2]. Thus symmetry simplifies the task of getting a numerical solution. Available software, can be applied easily for symmetric schemes. To exploit these, we first obtain finite element schemes and interpret them as finite difference schemes [3,6], thereby obtaining symmetric high order finite differences. It was observed in [7] that Galerkin s method, using a local basis, provides unconditionally stable, implicit generalized finite-difference schemes for a large class of linear and nonlinear problems. In addition Strang and Fix emphasize that finite element methods can be interpreted as finite difference methods. Another interesting aspect is the use of lumped mass matrices. When we work with a finite element scheme, we express discrete finite element equations in terms of finite difference operators which lead to a banded matrix system. The coefficient matrix of this banded matrix system is the mass matrix. That is, the time derivative is preceded by a mass matrix which makes the time stepping implicit. To obtain an explicit scheme, one has to lump the mass matrix such that it becomes diagonal. Our construction of a finite difference scheme is based on lumping a finite element scheme with nodal basis functions which are piecewise cubic Lagrange polynomial functions and are generalizations of piecewise linear hat functions. The lumping we are using does not always produce a diagonal matrix. Some problems contain time derivatives in their boundary conditions. For such problems we have obtained a symmetric positive definite matrix as the lumped mass

8 matrix that retains the desired order of accuracy. It should be positive definite in order for the scheme to be stable. Lumping the mass matrix can improve stability for some problems ( as in our case) compared to the consistent mass matrix and make the scheme explicit. However lumping can also reduce the numerical accuracy significantly. It depends upon the equations under consideration. In this report acoustic wave propagation in layered media is studied. The acoustic wave equation occurs in different phenomena. Acoustic waves constitute one kind of pressure fluctuation that can exist in a compressible fluid. In addition to the audible pressure fields of moderate intensity, the most familiar, there are also ultra-sonic and infra-sonic waves whose frequencies lie beyond the limits of hearing, there are also shock waves generated by explosions and supersonic aircraft and many others. When an acoustic wave traveling in one medium encounters the boundary of a second medium, reflected and transmitted waves are generated. Hence we will consider the solution of the one dimensional acoustic wave equation not only in one medium, but also in two media. There are two boundary conditions to be satisfied for all times at all points on the boundary: () the acoustic pressures on both sides of the boundary must be equal and (2) the normal components of the particle velocities on both sides of the boundary must be equal. We use the finite element method (FEM) and the finite difference method (FDM) on the reduced equation, the Helmholtz equation associated with suitable boundary conditions. The purpose being to obtain efficient schemes motivated by Helmholtz equation to use for the time dependent wave propagation problems which will be applied in the sequel. The other important thing why we study the Helmholtz equation is that it makes easier to analyze accuracy. These analysis will also be applicable for the time dependent problems. Note that the stability will not be covered by studying the Helmholtz equation. For time domain stability, it is of critical importance that the mass matrix is positive definite while this is not so relevant for frequency domain problems. In section 2, the numerical solutions of FEM in one and two media using one-sided and centered boundary approximations are described. Although boundaries are treated easily in FEM, we will have alternatives at the boundary. One-sided and centered scheme at the boundary where the latter is obtained by putting fictitious points outside the domain. This is 2

9 common in FDM. The local truncation errors for the total problem including the boundaries are presented in section 3. In section 4, FDM(schemes obtained by lumping) are discussed. In section 5, error analysis based on reflection analysis [4] is given while in section 6 numerical examples are provided, where we study the rate of convergence of the numerical methods. Finally the time dependent problem is considered in one and two media cases which is followed by concluding remarks. The one dimensional wave equation is given by 2 P c 2 t 2 = ρ x ρ P x (.) where c = speed of sound, ρ = density and P is the acoustic pressure. Primarily, we consider the reduced wave equation, known as Helmholtz equation. The Helmholtz equation arises in many physical applications, eg. scattering problems, in electro-magnetics and acoustics. We assume the density to be constant. To get the Helmholtz equation, we assume a time harmonic dependence, then one can write the solution as P (x, t) = Re(u(x)e iωt ), u complex (.2) where ω = frequency. Substituting in (.), yields the Helmholtz equation in one dimension d 2 u dx 2 + k2 u = ; (.3) where k = ω c. It is to be solved in the interval x with different boundary conditions at the end points x = and x =. Furthermore, the equation is solved in two different media where certain boundary conditions are to be satisfied at the interface of the two media. 2 The Finite Element Method(FEM) The idea of FEM starts by a subdivision of the structure or the region of physical interest, into smaller pieces. These pieces have to be easy to be identified by a computer and may be segments as in one space dimension or may be triangles or rectangles in two space dimensions. Then within each piece the trial functions have a simple form, usually they are polynomials. A piecewise polynomial function defined in terms of the values at nodes, defined by the element geometry, leads to a sparse coefficient matrix and the possibility of solving bigger problems. It was recognized that increasing the degree of the polynomials would greatly improve the accuracy. 3

10 In our case we have constructed the global basis as a piecewise cubic Lagrange polynomial(described below). Some other bases such as piecewise quadratic and Hermite cubic elements which are constructed by imposing continuity not only on the function but also on the first derivative have been analyzed [3]. The advantage of this approach being a reduction in the degrees of freedom. There is a double node at each point x = jh. Instead of being determined by the values at four distinct points, the cubic is determined by its values and its first derivatives at the two end points. This fails in the approximation of solutions which do not have a continuous derivative. There is another cubic space, formed from functions for which the second derivative is also continuous at the nodes. Such a piecewise cubic which has a continuous second derivative is called a cubic spline. It is no longer obvious which nodal parameters determine the shape of the cubic over a given subinterval, say (j )h x jh. The nodes x j and x j which belong to the interval, account for only two conditions and the other two must come from outside. Discussions on these are given in [3]. Therefore, for the FEM applied to the problem (.3), a grid is defined by x j =jh, j =,... N. h =/N Let P3 h be the space of all piecewise cubic Lagrange polynomials which are continuous at the nodes x = jh. We seek an approximation u h (x) = N u j φ h j (x) (2.) j= where u h (x) is a piecewise cubic polynomial which in each interval x i x x i+ is the Lagrange interpolating polynomial based on the nodes x i, x i, x i+ and x i+2. It implies that u h (x) is continuous at the nodes x i but with jumps in the derivatives. Observe that the above representation involves prescribed functions φ h j (x) and unknown coefficients u j. We want φ j to fulfill the following:. φ h j is a cubic polynomial over each element, uniquely determined by its values at the nodes in the element. 2. φ h i (x j) = δ ij where δ ij denotes the Kronecker delta. 3. The support of φ i (x j ) is restricted to four sub-intervals x i 2 x x i+2 It should be noted that the u j are just the values of the function, ie u h (x j ) = u j 4

11 Moreover, any cubic polynomial defined on the whole interval can be expressed in terms of the basis namely P 3 (x) = P 3 (x j )φ h j (x) which implies P3 h P 3(x) The following φ(x) constitutes a basis for integer nodes to be rescaled and translated as required. The basis functions φ h i (x) are then formed from φ(x) stated below in (2.3) by rescaling the independent variable from x to, and translating the origin to lie at the node ih. x h φ(x) = φ h i (x) = φ( x i), i =,, 2... N (2.2) h 6 (x + )(x + 2)(x + 3), 2 x 2 (x )(x + )(x + 2), x 2 (x )(x 2)(x + ), x 6 (x )(x 2)(x 3), x 2 (2.3) 2. One-sided boundary approximation Primarily we consider one-sided schemes at the boundary. The basis function need to be modified at the boundary. Accordingly, the following modifications are needed on the interval x for the elements φ, φ, φ 2 and φ 3 φ (x) = (x )(x 2)(x 3), x 6 φ (x) = x(x 2)(x 3), x 2 φ 2 (x) = x(x )(x 3), x 2 φ 3 (x) = x(x )(x 2), x 6 Observe that the support of φ 3 (x) is extended from the interval [, 5] to the interval [, 5]. These modifications are equivalent to the use of one-sided 5

12 interpolation at the boundary. We define the scalar product and the corresponding norm by (u, v) = ρ u(x)v(x)dx, u 2 = (u, u), (2.4) Now, the Galerkin method(fem) for the Helmholtz equation is formulated as follows. Find u h (x)ɛp3 h such that ( d2 u h dx 2 + k2 u h, v h ) = (f, v h ), v h ɛp h 3 (2.5) f is approximated by its piecewise cubic interpolate f h = j f(x j )φ h j (x) where f(x j ) is the value of the function at the node x = jh. The treatment of the boundary conditions is straightforward. When a Dirichlet boundary condition is applied, we should require φ(x) = on the boundary such that the approximate solution u h (x), fulfills the boundary condition, and those boundary conditions involving derivatives can be treated by integration by parts. For instance, with a Dirichlet boundary condition at x = and we obtain after integration by parts ( N j= du(x) dx =αu(x) + g, x = (2.6) N (φ h i ) (φ h j ) dx)u j δ i, (αu g) + k 2 ( = f h φ h i dx, j= φ h i φ h j dx)u j i =,... N. (2.7) In this case as well as the one with Dirichlet boundary conditions at both ends we obtain a linear system for u,..., u N which can be expressed in matrix form Au=b, with the matrix A having entries h S i,j + hk 2 M i,j where S i,j = φ i φ j dx, M i,j = φ iφ j dx and b i = f h φ i dx. 6

13 The matrices S and M are called the stiffness and mass matrices respectively. It was found, for the Dirichlet boundary conditions, by computing the integrals in Maple that the stiffness matrix S D = and the mass matrix M D = With the impedance boundary condition (2.6) at x = we obtain α S I 2 =

14 M I = Note that when α = in (2.6), it represents Neumann boundary conditions. Our next step was to solve the Helmholtz equation in two different media. When an acoustic wave traveling in one medium encounters the boundary of a second medium, reflected and transmitted waves are generated as in fig.. I II reflected wave transmitted wave incoming wave Figure : Reflection and transmission of a wave incident on the boundary between fluids with different characteristic impedances. The two media could be both fluids or one of the media is a solid. The ratio of the pressure amplitudes and intensities of the reflected and transmitted waves to those of the incident wave depend on the characteristic acoustic impedances and speeds of sound in the two media and on the angle the incident wave makes with the interface. Let u and u 2 be the solutions of the equation in medium and 2 respectively, and let the densities and 8

15 speed of sound be ρ, c and ρ 2, c 2 in medium and medium 2. The equations are to be solved in the interval x. The following boundary conditions are to be satisfied at the interface of the two media, the first requiring continuity of pressure, means that there can be no net force on the plane separating the fluids. The second condition, continuity of the normal component of particle velocity, requires that the fluids remain in contact. Thus The equations are u () = u 2 () (2.8) u () = u 2 () (2.9) ρ x ρ 2 x ρ d dx ( ρ du dx ) + k2 u =, x (2.) ρ 2 d dx ( ρ 2 du 2 dx ) + k2 2u 2 =, x (2.) where the wave numbers are k = ω c in medium I and k 2 = ω c 2 in medium II. Although the waves must have the same frequency, since the speeds c and c 2 are different, the wave numbers are different. The analytic solutions in the two media with an incoming wave from the left are u (x) = e ik x + Re ik x u 2 (x) = T e ik 2x (2.2) (2.3) where R and T are the reflection and transmission coefficients and are given by R = c 2ρ 2 c ρ c 2 ρ 2 + c ρ 2c 2 ρ 2 T = c 2 ρ 2 + c ρ c ρ and c 2 ρ 2 are called impedances of medium I and II respectively. To solve it numerically we apply the above concepts discussed in one medium to this problem in the interval x where u is assumed to be the solution in the interval x and u 2 is the solution in the second medium x and imposing equations (2.8) and (2.9) on the basis where the two media are tied. At the interface a common basis exists. The 9

16 scalar product is defined by (u, v) = = ρ u(x)v(x)dx ρ u(x)v(x)dx + ρ 2 u(x)v(x)dx. (2.4) The Galerkin formulation now leads to (φ h i ) ρ (φ h 2 i ) ρ 2 N u i (φ h j ) dx + k 2 N 2 u i (φ h 2 j ) dx + k 2 2 φ h 2 i u i φ h j ρ dx+ N N 2 u i φ h 2 j dx = φ h i ρ 2 (2.5) The matrices obtained are the same as in the above for the impedance boundary condition in one medium case except at the interface we have the sum of the two entries. The following is an example how the stiffness matrix looks like. I II Figure 2: Stiffness matrix in two media

17 and where S = I = h ρ S II = h 2 ρ 2 S Moreover, at the interface where the two block matrices overlap, the entry for the stiffness matrix is 9 h ρ h 2 ρ 2 9 where h and h 2 are the step sizes in the respective media. The same applies for the mass matrix. 2.2 Centered boundary approximations We have also implemented a centered scheme at the boundary for comparison with one sided schemes. Here the support is extended to the left, ie., we consider the grid points x, x, x, x 2, etc as shown below such that x = which is not necessarily a grid point lies between x and x and x = αh where h is the step size and α.5. We refrain from taking.5 < α < as it produces a singularity for α =, and for some values it is almost one sided. If the latter case arises we will use only the points x x and x 2. It should be noted that the main reason why we put α

18 into consideration is that in two-dimensional irregular domains we cannot expect α =. x - x x= x x 2 x 3 Figure 3: Arrangements of grid points for the centered scheme at the boundary. Now considering the Dirichlet boundary condition, we have added φ (x) for the basis defined in (2.3) and modified φ (x), φ (x) and φ 2 (x) to satisfy the essential boundary condition. φ (new) = φ (x) φ (α) φ (α) φ (x) φ (new) = φ (x) φ (α) φ (α) φ (x) φ 2 (new) = φ 2 (x) φ 2(α) φ (α) φ (x) For the Neumann boundary condition no changes have been made. However for the two media case we keep the right and left sides and modify φ in order the continuity conditions to be fulfilled at the interface as φ = φ l (x) φ l (α), x φ r (x) φ r (α), x Consequently for α =, the following stiffness and mass matrices are obtained, respectively for the Dirichlet boundary condition. S D =

19 M D = One can imagine easily how the corresponding matrices for impedance and for the two media cases looks like. Hence we avoid listing them. 3

20 3 Local truncation errors Error estimates for FEM based on Galerkin methods are determined by the approximation property of the finite element space. In other words if V h is a space of piecewise polynomials of degree r, from approximation theory we know that there is a v h in V h such that v v h const h r for v smooth enough, vɛv h. Then there is an error estimate for the solution u h such that u u h const h r In the subsequent discussions we use the conventional error analysis of FDM. We first consider the standard rows for the interior points far from the boundaries of the stiffness and mass matrices which are respectively h ( ) and h( ) The Galerkin method can be viewed as a difference method for u j. Exploitation of this point of view led to the super-convergence results of [6] and [] which we apply for our scheme hk 2 3 ( 52 u j u j u j u j u j+ 3 7 u j u j+3) + h ( u j u j u j 9 9 u j + 24 u j+ + 3 u j+2 7 u j+3) = (3.) Correspondingly, it was found that the local truncation error by Taylor series is hu (x i ) h5 u (6) 59 8 h7 u (8) and hu(x i ) h5 u (4) h7 u (6) Observe here that super-convergence is attained, ie., the stiffness matrix d is a 4th order approximation of 2 whereas (3.) is a 6th order accurate dx 2 approximation of u + k 2 u = 4

21 In addition to the interior points we have also tried to determine the accuracy of the interior including the boundaries. We have listed tables of Taylor series expansions for the different boundary conditions encountered. row stiffness 3 24 hu h2 u h3 u (4) h4 u (5) hu h2 u h3 u (4) h4 u (5) hu + 87 h2 u h3 u (4) h4 u (5)... Table : Taylor series expansion for the first three non-regular rows of the stiffness matrix with a Dirichlet boundary condition. row mass h2 u h3 u h4 u h2 u h3 u h4 u h2 u h3 u h4 u... Table 2: Taylor series expansion for the first three non-regular rows of the mass matrix with a Dirichlet boundary condition. Although the truncation error is large at the boundary, still the scheme is of order 5 for FEM (to be proved in section(5)) and of order 4 for FDM. The local truncation error is of order three. To justify our claim for the local truncation error we have divided the FEM scheme by h to have analogy with finite difference techniques. From the tables () and (2) and from the differential equation(.3), since u() = from the boundary condition the even order derivatives vanish, and u () = k 2 u () is used in each row. Then we are left with h 3 in both tables as truncation error. Therefore we infer that FEM is of order three at the boundary. It is proved in [9] that for certain classes of difference schemes it is possible to lower the accuracy one order at the boundary without losing the convergence rate defined by the interior scheme. However here it turns out that the global error is of order 5 while the local truncation error at the boundary is of order 3. For the sake of completeness we list below the Taylor series expansions of the stiffness and mass matrices for the Neumann boundary conditions. The local truncation error at the boundary is of order 2 and the global error is of order four for both FEM and FDM. 5

22 row stiffness 3 hu h2 u + 9 h3 u (4) + 45 h4 u (5) hu h2 u h3 u (4) h4 u (5) hu h2 u h3 u (4) h4 u (5) hu + 87 h2 u h3 u (4) h4 u (5)... Table 3: Taylor series expansion for the first four non-regular rows of the stiffness matrix where Neumann boundary conditions is employed. row mass 3 h2 u + 45 h3 u h4 u h2 u h3 u h4 u h2 u h3 u h4 u h2 u h3 u h4 u... Table 4: Taylor series expansion for the first non-regular rows of the mass matrix where Neumann boundary condition is employed. In a similar fashion we reach the same conclusion for the centered scheme at the boundary. row stiffness 24 hu + h2 u h3 u (4) + 44 h4 u (5) hu h2 u h3 u (4) h4 u (5)... 3 hu + 2h2 u + 2h3 u (4) h4 u (5)... 4 hu + 3h2 u h3 u (4) h4 u (5)... Table 5: Taylor series expansion for the first four non-regular rows of the stiffness matrix of the centered scheme at the boundary with Dirichlet boundary condition. It is of order four, but the centered scheme is better as we compare the constant terms in the respective truncation errors. 6

23 row mass h2 u + 8 h3 u + 84 h4 u h2 u h3 u h4 u h 2 u + 2h3 u h4 u h 2 u h3 u h4 u... Table 6: Taylor series expansion for the first non-regular rows of the mass matrix of the centered scheme at the boundary with Dirichlet boundary condition. 4 Lumped Mass Matrix To obtain an explicit scheme in the time dependent problem, it is common to lump the mass matrix such that it becomes diagonal. It should be noted that the stiffness matrix is retained as in FEM. We have lumped the mass matrix as follows. For a regular row, ie., one corresponding to an interior point away from the boundary, we simply lump the mass matrix to a single diagonal entry equal to. It is evident from the local truncation error obtained on page (4) that this approximation will keep fourth order accuracy although the super-convergence of the FEM scheme is lost. For the non-regular rows which are affected by the boundary conditions we consider the Taylor series expansion of each and we seek fourth order accuracy by making the mass matrix diagonal, if it is possible, otherwise by making the mass matrix symmetric and positive definite. The latter happens when we consider two different media. In the subsequent we give examples of the steps performed in obtaining the entries for the non -regular rows of the lumped matrix for different boundary conditions. To begin with, consider Dirichlet boundary conditions and let us look the Taylor series expansions given in tables 7 and 8. row stiffness 3 24 hu h2 u h3 u (4) h4 u (5) hu h2 u h3 u (4) h4 u (5) hu + 87 h2 u h3 u (4) h4 u (5)... Table 7: Taylor series expansion for the first three non-regular rows of the stiffness matrix. 7

24 row mass lumped(fd) h2 u h3 u h4 u h2 u h3 u h4 u h2 u h3 u h4 u Table 8: Taylor series expansion for the first three non-regular rows of the mass matrix including the entries in the lumped mass matrix. It should be noted that using the differential equation (.3) and the boundary conditions, the derivatives of the second order in the Taylor series expansions in both tables vanish. Moreover the derivatives of order three in the Taylor series expansion of the stiffness matrix cancels its corresponding derivatives of first order in the Taylor series expansion of the mass matrix. Now we want the diagonal elements in the lumped scheme to be the coefficients that occur in the cancellations, and use γu i = ξ(u + ihu + (ih)2 2 u +...) letting γ to be the principal coefficients that occurred in the cancellations and ξ to be the diagonal elements in the lumped mass matrix. From this equation we determine the value of ξ which is the value of one of the diagonals as they are given in the above table and the following matrix. M l = Applying the same technique for the Neumann boundary condition, the 8

25 lumped mass matrix is found to be M ln = However in lumping the mass matrix, for the third boundary condition(impedance) we considered, the change is significant as it is no longer restricted to the first row as in FEM. Suppose one uses the following boundary condition du() dx αu() =, (4.) As in the above the Taylor series expansion of each row is found. row stiffness αu + u + 3 hu h2 u + 9 h3 u (4) hu h2 u h3 u (4) hu h2 u h3 u (4) hu + 87 h2 u h3 u (4) +... Table 9: Taylor series expansion for the first four non regular rows of the stiffness matrix of the impedance boundary condition. 9

26 row mass lumped(fd) 3 hu h2 u 45 h3 u αh hu h2 u h3 u αh hu h2 u h3 u αh 4 24 hu + 87 h2 u h3 u αh Table : Taylor series expansion for the first four non regular rows of the mass matrix of the impedance boundary condition. We observe that the principal coefficients in both expansions cancel each other, namely the coefficients of the derivatives of the second order in the Taylor series expansion of the stiffness matrix with that of the undifferentiated function in the Taylor series expansion of the mass matrix. Besides the coefficients of the derivatives of order three in the Taylor series expansion of the stiffness matrix cancel out those coefficients of the first order derivatives in the Taylor series expansion of the mass matrix. Consequently, to find the entries in the lumped mass matrix of this, where the impedance boundary condition is applied, we use γu i + ρu i = ξ(u + ihu + (ih)2 2 u +...) + βu i and the boundary condition u = αu, where γ,ρ represents the coefficients of the principal and those of the first order derivative that occurred in the cancellation described above and ξ and β are to be determined for each row. Consequently, the lumped mass matrix turns out to be αh αh 5 6 M li 23 9 αh = αh The above matrix is positive definite for sufficiently small αh. Before we proceed, it is worth mentioning that the above procedure of lumping does not work when we have inflow boundary condition such as u x + u t = f (4.2) 2

27 Hence we have formed non-diagonal lumping which is symmetric and positive definite. Positive definiteness should be guaranteed in order for the time dependent equations to be stable. To prove our claim, we consider the discrete form of the wave equation. We introduce a grid in time, with points t n = n t, n =,, 2,... A time discrete function u n can then be defined. We approximate the time derivative by a centered second order accurate finite difference formula The discrete form is 2 t 2 = un+ 2u n + u n ( t) 2 (4.3) M un+ 2u n + u n ( t) 2 Su n = (4.4) where M and S are mass and stiffness matrices respectively, and it is equivalent to u n+ (2 + ( t) 2 M S)u n + u n = (4.5) We shall assume that the eigenvalues of S are non-positive, which is the case with Dirichlet or Neumann boundary conditions. Then the eigenvalues λ of M S are also non-positive by the identity x Sx = λx Mx provided that M is positive definite. By a change of coordinates v = M /2 u, the matrix M S goes over into the symmetric matrix M /2 SM /2 and the difference equation (4.5) becomes equivalent to a set of scalar equations with λ. This equation is stable if v n+ (2 + tλ)v n + v n = (4.6) t 2 λ /2 Therefore the stability limit on t is determined by the largest eigenvalues of M S. We now going to construct a symmetric and positive definite lumped mass matrix. It suffices to consider the non-regular rows. Since there are four rows of these, we form the following system of equations 4 m i,j u j = ξ i u + β i hu, i =, 2, 3, 4 (4.7) j= 2

28 where ξ i and β i are the coefficients of u and u respectively in the ith row for the Taylor series expansion of the mass matrix shown in table(8). Applying Taylor series expansion for the left hand side of the equation and requiring symmetry, a system of 8 equations and unknowns is solved, ie., we have three free parameters. The following entries were obtained t t 3 + 4t 45 2t 2 + 8t 3 7t 5 + t 2 4t 3 + 2t t t 2 + 8t 3 7t t 2 5t 3 + 2t t 2 + 6t 3 3t t 3 2t t 2 4t 3 + 2t t 2 + 6t 3 3t t t 3 + t t t 3 2t t 3 + t t 3 At this stage we require the above matrix (the lumped mass matrix) to be positive definite. As an example for t small enough, it was found by inspection t =, t 2 = 2 and t 3 = produce the required order of accuracy and stable scheme Finally for the two media case, the lumped matrix is not diagonal throughout. It is to be recalled that in constructing the lumped mass matrix, we require the mass matrix to attain fourth order accuracy which is established by Taylor series expansion and also imposing the boundary conditions. However, at the interface there are only continuity conditions. Hence at the interface, it is the positive definite matrix shown above. In general the matrix is as in fig.4. 22

29 nz = 65 Figure 4: Lumped mass matrix which is symmetric positive definite at the interface. Furthermore the lumped mass matrix for the wave equation in the two media case with the impedance boundary condition given in (4.2), has the following form. 23

30 nz = 89 Figure 5: Lumped mass matrix for the impedance boundary condition in two media. 5 Error analysis This section presents a reflection analysis of the errors including the boundaries associated with the approximations introduced in the last sections. Comparisons are made with the one-sided and centered approximations at the boundaries. It should be noted that for the Dirichlet and impedance boundary conditions, we consider an incoming wave from + as being reflected at x = as shown in the diagram. The Galerkin method, ie., FEM, can now be viewed as a difference method for u j 24

31 reflected wave incoming wave x= Figure 6: Reflection of a wave traveling to the left. l(u j ) = h 2 (a 3u j 3 +a 2 u j 2 +a u j +a u j +a u j+ +a 2 u j+2 +a 3 u j+3 )+ k 2 (b 3 u j 3 + b 2 u j 2 + b u j + b u j + b u j+ + b 2 u j+2 + b 3 u j+3 ) = (5.) Since the scheme is symmetric, l(u j ) = c 3 u j 3 +c 2 u j 2 +c u j +c u j +c u j+ +c 2 u j+2 +c 3 u j+3 = (5.2) where c i = h 2 a i + k 2 b i To do an error analysis for the scheme, we consider the finite difference formulation of the problem in order to apply the technique used for finite differences rather than for FEM. The characteristic equation for (5.2) is c 3 κ 3 + c 2 κ 2 + c κ + c + c κ + c 2 κ 2 + c 3 κ 3 = (5.3) It can be shown easily that if κ is a solution of (5.) then κ is also a solution. To solve this equation, let κ = e ikh+ir where κ is the principal root, then one can write the equation as follows c + c (2cos(kh + r)) + c 2 (2cos(2(kh + r))) + c 3 (2cos(3(kh + r))) = Put s = kh, expand in Taylor series and neglecting high powers of r yields 2sr 648 s8 + O(s 9 r) =

32 which implies and Observe that r = 296 s7 + O(s 8 ) 7 ikh( κ e 296 (kh)7 ) ir = O(s 7 ). Similarly for FDM, one can show that ir = O(s 5 ) The spurious roots are simple roots. This implies that they can be found by setting the coefficients that correspond to the mass matrix equal to zero and from above it suffices to list only these κ 2 = κ 3 = Now consider the incoming wave κ n where κ is the principal root and suppose the boundary condition is of Dirichlet type, then the analytic solution on x is u(x) = e ikx e ikx (5.4) and the numerical solution in terms of the principal root is which is equivalent to u n = κ n κ n + e n u n = ( + A )κ n + A 2 κ n 2 + A 3 κ n 3 + κ n ; κ 2 <, κ 3 < (5.5) The error is u(x n ) u n = e n + e ikx n k n e ikx n + k n e n = { A κ n + A 2κ n 2 + A 3κ n 3, n, n= where e n represents the error due to the boundary approximation. Then e n satisfies the difference equation (5.). Substituting into the difference equations at the boundary yields a linear system of equations in the unknowns 26

33 A, A 2 and A 3 while κ, κ 2 and κ 3 are the roots obtained above. Since κ 2 <, κ 3 <, we take κ 2 =.388 and κ 3 =.334. This linear system has the following form where C = C + O(h) + O(h 2 ) and C = Cx = b (5.6) h2 A x = A 2 A 3 c h 3 b = c 2 h 3 c 3 h 3 with c, c 2 and c 3 are the constants obtained by Taylor series expansion for the first three rows. These are c = 79/72, c 2 = 73/9 and c 3 = 87/. In this linear system of equations it suffices to show that the determinant of the matrix of the coefficient C is nonzero for all sufficiently small h. In our case we have shown that det(c) is different from zero. Hence we conclude that the order of accuracy is of O(h 5 ). We have obtained the same order using a centered scheme at the boundary. However it is a known fact that different methods of the same order can have different errors, they are distinguished by the error constants. As a comparison for the same problem, using a centered scheme where α is and.5, (see, fig3) we got C and b to be respectively C = / / / b = h3 353 h3 2h 3 3h 3 27

34 and C = b =.57h 3.5h 3.4h 3 2.5h 3 Note that in these two cases A κ n + A 2κ n 2 + A 3κ n 3, n e n =, n= A, n=- Hence, x = A A A 2 A 3 Solving the three different systems of equations, the unknowns were found to be, for the one-sided scheme at the boundary 3.9h 5 x = 56.h 5 2.2h 5 for the centered scheme at the boundary, ie., for α =.9h h 5 x = 9.36h h 5 while for α =.5 6.4h 5 x =.h h 5 h 5 28

35 We see from the values of the unknowns A i s, in particular the value of A, is smaller in the centered schemes at the boundary rather than in the one-sided schemes at the boundary. It should be noted that the reason we compared the values of A is that it is the constant term of the non-decaying κ. Hence we conclude that centered schemes at the boundary are better. In a similar fashion applying the techniques discussed above we show for the other boundary conditions (Neumann and impedance) and also for the FDM schemes. 6 Numerical Examples In this section some of the numerical experiments that have been performed are described. Consider The exact solution is 2 u x 2 + k2 u = (k 2 π 2 )sin(πx), x (6.) u() = (6.2) u() = (6.3) u(x) = sin(πx), x (6.4) The FEM and FDM (lumped mass) solutions are obtained. Table shows a grid refinement study for the problem. h FEM (l ) Lumped (l ) rate(fem) rate(lumped) Table : Dirichlet boundary condition. The second numerical example is the Neumann boundary condition. 2 u x 2 + k2 u = (k 2 π 2 )cos(πx), x (6.5) du() dx = (6.6) du() dx = (6.7) 29

36 Here, the exact solution is u(x) = cos(πx), x (6.8) The numerical solutions of the FEM and FDM are obtained, and a grid refinement study for both follows in the following table. Furthermore, the numerical solution for the impedance boundary condition h FEM (l ) Lumped (l ) rate(fem) rate(lumped) Table 2: Neumann boundary condition du dx + iku = 2ikeikx, x = (6.9) du iku =, x = (6.) dx is obtained, and table 3 gives the convergence rates of both the FEM and FDM (lumped). Note that the analytic solution of this problem is u(x) = e ikx (6.) h FEM (l ) Lumped (l ) rate(fem) rate(lumped) Table 3: Impedance boundary condition. As an illustration, the following graphs were taken for the (6.9) and (6.), with impedance boundary conditions for both FEM and FDM (Lumped) schemes. 3

37 h =.5 Numerical Analytical The consistent mass matrix.5 h =.5 Numerical Analytical The lumped mass matrix Figure 7: Graphs for FEM(top) and for FDM with step size h =.5 3

38 h =. Numerical Analytical The consistent mass matrix.5 h =. Numerical Analytical The lumped mass matrix Figure 8: Graphs for FEM(top) and for FDM with step size h =. Finally, for the two media case given in (2.) with du dx + ik u = 2ik e ik x, x = (6.2) du dx ik 2u =, x = (6.3) We have tested for different step sizes h and h 2 and different densities. For equal step sizes, table(4) shows the rate of convergence. h = h = h 2 FEM (l ) Lumped (l ) rate(fem) rate(lumped) Table 4: Impedance boundary condition in two media In addition, the following graphs illustrate the two methods, FEM and FDM for the two media problem with different step sizes. 32

39 h =. h2 =. Numerical Analytical The consistent mass matrix.5 h =. h2 = The lumped mass matrix Figure 9: Graphs of FEM(top) and FDM with step size h =.. 33

40 h =. h2 =. Numerical Analytical The consistent mass matrix.5 h =. h2 = The lumped mass matrix Figure : Graphs of FEM(top) and FDM with step size h =.. Observe, the lumped scheme(fdm) needs finer step size to reach asymptotic range of accuracy. 34

41 7 Time Dependent Problems Although, FEM is usually thought of as a method of discretization in space, it can be used in time as well. However, here we use the method of lines [4]. It allows the space discretization to be handled separately. Consequently, for the wave equation (.), we have used finite difference approximations for the time derivative terms obtained by Taylor series combined with the FEM in space. At first we consider the wave equation with Dirichlet boundary conditions 2 u c 2 t 2 = 2 u x 2, x, t (7.) u(x, ) = f(x) (7.2) u(x, ) t = g(x) (7.3) u(, t) = u(, t) = (7.4) Discretizing the spatial part of the equation by Galerkin method leads to a system of ordinary differential equations in time. M 2 u = Su (7.5) t2 We now look at the time discretization of the system of ordinary differential equations (7.5) by FDM. We approximate the time derivative by a centered fourth order accurate finite difference formula as follows. 2 u t 2 = un+ 2u n + u n ( t) 2 ( t)2 4 u 2 t 4 + O(( t)4 ) (7.6) From (7.5) which implies ie., 2 u t 2 = M Su 4 u t 4 = M S 2 u t 2 4 u t 4 = M S(M Su) 35

42 substituting (7.6) into (7.5), we obtain u n+ = 2u n u n + ( t) 2 M S(u n + ( t)2 2 M Su n ) (7.7) where M and S are the mass and stiffness matrices respectively. In addition to the Dirichlet boundary condition, the other types of boundary conditions, such as, the Neumann boundary condition u(, t) x and the impedance boundary condition = u(, t) x = (7.8) u x u c t = 2 f(t) c t were also applied. we have taken as first step the following boundary conditions (7.9) u (, t) x = αu(, t) (7.) u(, t) = (7.) Exact solutions may be given by u(x, t) = sin(β(x ))sinβt (7.2) and α = βcosβ sinβ For instance when β = 2 we have the following graph (7.3) 36

43 ..2 t =, dt=., u v = Numerical Analytical Figure : FEM graph for the boundary conditions given in (7.) and (7.). Finally the equation is also solved in two media. The problem is posed as follows. Let u and u 2 be the solutions of the equation in media I and II respectively, then the equations are and 2 u t 2 = 2 u, x, t (7.4) x2 c 2 u x u c t c 2 2 u 2 x + u 2 c 2 t = 2 f(t), x = (7.5) c t 2 u 2 t 2 = 2 u 2 x 2, x, t (7.6) =, x = (7.7) The complete solution u contains two arbitrary, but twice differentiable, functions u (x, t) = f(x c t) + g(x + c t), (7.8) 37

44 while u 2 (x, t) = h(x c 2 t) (7.9) The second solution (7.9) is a wave traveling to the right, while a reflected wave traveling to the left is not allowed, according to the boundary condition (7.7). We use f(x c t) = e α(x c t+γ) 2, and g(x + c t) = c 2ρ 2 c ρ c ρ c 2 ρ 2 e α( x c t+γ) 2 2c 2 ρ 2 h(x c 2 t) = e α((x c 2)t c ρ + c 2 ρ 2 c c2 +γ) 2 which are obtained by making use of the continuity equations (2.8) and (2.9) at the interface between the two media. Furthermore, numerically, it is also not easy to implement as the boundary condition contains a derivative in time. It is formulated as c 2 M 2 u t 2 + A u + Su = F (t) (7.2) t where M and S are the mass and stiffness matrices respectively and and A = F (t) = 2 df(,t) c dt. Substituting the fourth order finite difference in time for 2 u t 2 difference in time for u t, the following is obtained. and central Q u n+ = Q 2 u n + Q 3 u n + F (7.2) 38

45 where Q = Q 3 = M ( t) 2 + AM A t 2 24 AM S S 2 + A 2 t Q 2 = 2M ( t) 2 AM A S 6 6 M A 3 M ( t) 2 + AM A + t 2 24 AM S S 2 + A 2 t and F = ( t)2 df AM 2 dt ( t)2 d 2 F 2 dt 2 ( t)2 df M 6 dt To see how the finite difference obtained by lumping performs with time dependent problems comparing to steady state problems such as the Helmholtz equation discussed earlier, we consider the following numerical examples with Dirichlet boundary conditions 2 u c 2 t 2 = 2 u x 2, x, t (7.22) u(x, ) = sinπx (7.23) u(x, ) t = (7.24) u(, t) = u(, t) = (7.) h t FEM (l ) FDM (l ) rate(fem) rate(fdm) Table 5: Rate of convergence for Dirichlet boundary conditions With impedance boundary condition with α given in (7.3). u (, t) x = αu(, t) (7.26) u(, t) = (7.27) 39

46 h t FEM (l ) FDM (l ) rate(fem) rate(fdm) Table 6: Rate of convergence for the impedance boundary conditions As a third example 2 u c 2 t 2 = 2 u x 2, x, t (7.28) u u x c t u x + u c t = 2 c f(t), x = (7.29) t =, x = (7.3) Observe that we are using a symmetric positive definite matrix for FDM as remarked in section 2. The following table shows the rate of convergence. h t FEM (l ) FDM (l ) rate(fem) rate(fdm) Table 7: Rate of convergence for the impedance inflow boundary conditions. At last, for the two media problem ( ) taking α = 2 and ρ =.3, the rate of convergence using a fourth order finite difference in time is given below h = h = h 2 t FEM (l ) FDM (l ) rate(fem) rate(fdm) Table 8: Rate of convergence for the impedance boundary condition in two media. 4

47 The following graph illustrates this last example.2 The consistence mass matrix Numerical Analytical Figure 2: FEM and FDM in two media using fourth order finite difference in time. 8 CONCLUSION In this paper FEM and FDM solutions of the Helmholtz equation in one dimension with different boundary conditions for the one medium and two media cases have been considered. The PDE is discretized by the Galerkin method. The main objective of the paper is to develop high order symmetric finite difference approximations that will be employed for the wave equation. FEM constructed for the Helmholtz equation have been shown to perform well for the Dirichlet boundary condition compared to FDM. The analysis and the numerical experiments described in the paper show that the error of FEM is O(h 5 ) while the error of FDM(lumped) is O(h 4 ). In addition it is observed that the error of FEM in the interior is of O(h 6 ) for the Helmholtz equation while the error of FDM is only O(h 4 ). This means that for this particular equation FEM is superior with regard to the rate of convergence. Hence it is not significant to lump the mass matrix in order to obtain FDM 4

48 for the Dirichlet boundary condition despite the latter is symmetric. In other words if one is interested in the order of accuracy of a scheme for the wave equation, FEM should be used. Moreover, although FEM and FDM both have the same order of accuracy in the Neumann boundary condition case the latter yields bigger error coefficient than the former. Hence, we infer that FEM is better in frequency domain problems. Also as it is explained in the paper for the impedance boundary condition where we have time derivatives in the expression of the boundary, it is not possible to have diagonal lumped mass matrix(fdm) that retains the order of accuracy to implement it in the time domain. It is done by a positive definite symmetric matrix rather than a diagonal matrix which affects the cost when we implement it in higher dimensions. The other comparison we have made is among the one-sided scheme at the boundary and centered scheme at the boundary, and it is shown that the latter works better which coincides with the known fact from the theory of finite differences [5]. For time dependent problems, FEM with Dirichlet boundary condition retains the super-convergence and FDM yields the desired accuracy. However for the Neumann boundary condition both acquired the same order of accuracy showing FDM which is symmetric (being diagonal matrix) attains high order accuracy as desired. For the third type of boundary condition, the impedance, imposing time-dependent boundary condition, FDM is symmetric and positive definite and the expected rate of convergence is obtained but the scheme needs finer space step size to reach asymptotic range of accuracy. Moreover, the advantage of the FDM is its added stability condition. It was found by applying von-neumann analysis, for the Cauchy problem that the stability condition is c t <.7h for FDM, whereas c t < h for FEM. In both cases c was taken to be. Note that since we are considering boundary value problem the CFL condition is slightly diferent from the Cauchy problem. This implies that we have achieved a consistent difference equation with a typical Courant condition for numerical stability. Hence for time dependent problems and for the wave equation, it is of great importance to lump the mass matrix thereby obtaining FDM scheme. 42

49 REFERENCES [] B.Swartz and B.Wendroff. The relative efficiency of finite difference and finite element methods I: Hyperbolic problems and splines, SIAM J. Numer. ANAL., (974), pp [2] P.Olsson, D. Gottlieb, B. Gustafsson, B. Strand, On the super-convergence of Galerkin methods for Hyperbolic IBVP, SIAM J.Numer. ANAL., 33(996), pp [3] STRANG,G and Fix,G. An analysis of the finite element method. 973, Prentice-Hall,Inc.,Englewood Cliffs, N.J. [4] B.Gustafson, H.-O.Kreiss, and J.Oliger. Time Dependent problems and Difference Methods. Wiley and Sons,995. [5] H.-O.KREISS, Difference approximations for boundary and eigenvalue problems for ordinary differential equations, Math.Comp., 26(972), pp [6] V.THOMÉE AND B.WENDROFF, Convergence estimates for Galerkin methods for variable coefficient initial value problems, SIAM J.Numer.Anal., (974), pp [7] B.SWARTZ AND B.WENDROFF, Generalized finite-difference schemes, Math.Comp.,23(969), pp [8] H.O. Kreiss and J. Oliger. Comparison of accurate methods for the integration of hyperbolic equations. Tellius,24(972),pp.99-. [9] B.GUSTAFSSON, The convergence rate for difference approximations to general mixed initial boundary value problem, SIAM J.Numer Anal, 8(98), pp [] V.THOMÉE, Spline approximation and difference scheme for the heat equation, The Mathematical Foundation of the Finite Element Method with Application to partial Differential Equations, A.K. Aziz,ed., Academic Press, New York. 972 [] M.H.Carpenter, D.Gottlieb, and S.Abarbanel. Time-stable boundary conditions for finite-difference schemes solving hyperbolic systems: Methodology and application to high-order compact schemes. J. Comput. Phys., (2):22-236, Apr. 994 [2] Douglas J. Riley. Transient Finite-Elements for Computational Electromagnetics: Hybridization with Finite Differences, Modeling Thin Wires and Thin slots, and Parallel processing. applied Computational Electromagnetics Society(ACES) Symposium, Monterey, California, March 2 43

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

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

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

Scientific Computing I

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

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes Root finding: 1 a The points {x n+1, }, {x n, f n }, {x n 1, f n 1 } should be co-linear Say they lie on the line x + y = This gives the relations x n+1 + = x n +f n = x n 1 +f n 1 = Eliminating α and

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

Finite Difference Methods for Boundary Value Problems

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

More information

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

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

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

We consider the problem of finding a polynomial that interpolates a given set of values:

We consider the problem of finding a polynomial that interpolates a given set of values: Chapter 5 Interpolation 5. Polynomial Interpolation We consider the problem of finding a polynomial that interpolates a given set of values: x x 0 x... x n y y 0 y... y n where the x i are all distinct.

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

More information

Finite Differences: Consistency, Stability and Convergence

Finite Differences: Consistency, Stability and Convergence Finite Differences: Consistency, Stability and Convergence Varun Shankar March, 06 Introduction Now that we have tackled our first space-time PDE, we will take a quick detour from presenting new FD methods,

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

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

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material.

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material. Poisson Solvers William McLean April 21, 2004 Return to Math3301/Math5315 Common Material 1 Introduction Many problems in applied mathematics lead to a partial differential equation of the form a 2 u +

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

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

Examination paper for TMA4215 Numerical Mathematics

Examination paper for TMA4215 Numerical Mathematics Department of Mathematical Sciences Examination paper for TMA425 Numerical Mathematics Academic contact during examination: Trond Kvamsdal Phone: 93058702 Examination date: 6th of December 207 Examination

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

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Fixed point iteration and root finding

Fixed point iteration and root finding Fixed point iteration and root finding The sign function is defined as x > 0 sign(x) = 0 x = 0 x < 0. It can be evaluated via an iteration which is useful for some problems. One such iteration is given

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

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 Discretization of Boundary Conditions Discretization of Boundary Conditions On

More information

ON NUMERICAL METHODS FOR ELLIPTIC TRANSMISSION/BOUNDARY VALUE PROBLEMS

ON NUMERICAL METHODS FOR ELLIPTIC TRANSMISSION/BOUNDARY VALUE PROBLEMS ON NUMERICAL METHODS FOR ELLIPTIC TRANSMISSION/BOUNDARY VALUE PROBLEMS ANIRBAN ROY 349 LAFAYETTE DR, BETHLEHEM, PA, 182 Project Supervisors: Anna L. Mazzucato and Victor Nistor Department of Mathematics,

More information

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

Finite Element Method for Ordinary Differential Equations

Finite Element Method for Ordinary Differential Equations 52 Chapter 4 Finite Element Method for Ordinary Differential Equations In this chapter we consider some simple examples of the finite element method for the approximate solution of ordinary differential

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Scuola di Dottorato THE WAVE EQUATION Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Lucio Demeio - DIISM wave equation 1 / 44 1 The Vibrating String Equation 2 Second

More information

1. Differential Equations (ODE and PDE)

1. Differential Equations (ODE and PDE) 1. Differential Equations (ODE and PDE) 1.1. Ordinary Differential Equations (ODE) So far we have dealt with Ordinary Differential Equations (ODE): involve derivatives with respect to only one variable

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

New Diagonal-Norm Summation-by-Parts Operators for the First Derivative with Increased Order of Accuracy

New Diagonal-Norm Summation-by-Parts Operators for the First Derivative with Increased Order of Accuracy AIAA Aviation -6 June 5, Dallas, TX nd AIAA Computational Fluid Dynamics Conference AIAA 5-94 New Diagonal-Norm Summation-by-Parts Operators for the First Derivative with Increased Order of Accuracy David

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

PDEs, part 3: Hyperbolic PDEs

PDEs, part 3: Hyperbolic PDEs PDEs, part 3: Hyperbolic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2011 Hyperbolic equations (Sections 6.4 and 6.5 of Strang). Consider the model problem (the

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II Supplementary Material on Finite Different Methods for Two-Point Boundary-Value Problems Xiangmin Jiao Stony Brook University Xiangmin Jiao Stony Brook University AMS527:

More information

Manoj Kumar 1, Pratibha Joshi 2. (Received 31 August 2011, accepted 26 December 2011)

Manoj Kumar 1, Pratibha Joshi 2. (Received 31 August 2011, accepted 26 December 2011) ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.14(2012) No.1,pp.11-22 A Mathematical Model and Numerical Solution of a One Dimensional Steady State Heat Conduction

More information

10 The Finite Element Method for a Parabolic Problem

10 The Finite Element Method for a Parabolic Problem 1 The Finite Element Method for a Parabolic Problem In this chapter we consider the approximation of solutions of the model heat equation in two space dimensions by means of Galerkin s method, using piecewise

More information

Chapter 4: Interpolation and Approximation. October 28, 2005

Chapter 4: Interpolation and Approximation. October 28, 2005 Chapter 4: Interpolation and Approximation October 28, 2005 Outline 1 2.4 Linear Interpolation 2 4.1 Lagrange Interpolation 3 4.2 Newton Interpolation and Divided Differences 4 4.3 Interpolation Error

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

More information

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

Numerical Analysis Preliminary Exam 10.00am 1.00pm, January 19, 2018

Numerical Analysis Preliminary Exam 10.00am 1.00pm, January 19, 2018 Numerical Analysis Preliminary Exam 0.00am.00pm, January 9, 208 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

Error formulas for divided difference expansions and numerical differentiation

Error formulas for divided difference expansions and numerical differentiation Error formulas for divided difference expansions and numerical differentiation Michael S. Floater Abstract: We derive an expression for the remainder in divided difference expansions and use it to give

More information

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics Fundamental Solutions and Green s functions Simulation Methods in Acoustics Definitions Fundamental solution The solution F (x, x 0 ) of the linear PDE L {F (x, x 0 )} = δ(x x 0 ) x R d Is called the fundamental

More information

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

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

More information

A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem

A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem A posteriori error estimates for the adaptivity technique for the Tikhonov functional and global convergence for a coefficient inverse problem Larisa Beilina Michael V. Klibanov December 18, 29 Abstract

More information

MATH 205C: STATIONARY PHASE LEMMA

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

More information

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations Numerical Analysis of Differential Equations 215 6 Numerical Solution of Parabolic Equations 6 Numerical Solution of Parabolic Equations TU Bergakademie Freiberg, SS 2012 Numerical Analysis of Differential

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis

12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis ATH 337, by T. Lakoba, University of Vermont 113 12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis 12.1 Formulation of the IBVP and the minimax property of its

More information

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

Asymptotic Behavior of Waves in a Nonuniform Medium

Asymptotic Behavior of Waves in a Nonuniform Medium Available at http://pvamuedu/aam Appl Appl Math ISSN: 1932-9466 Vol 12, Issue 1 June 217, pp 217 229 Applications Applied Mathematics: An International Journal AAM Asymptotic Behavior of Waves in a Nonuniform

More information

Qualifying Examination

Qualifying Examination Summer 24 Day. Monday, September 5, 24 You have three hours to complete this exam. Work all problems. Start each problem on a All problems are 2 points. Please email any electronic files in support of

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

A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation

A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation Majid Nabavi, M. H. Kamran Siddiqui, Javad Dargahi Department of Mechanical and Industrial Engineering, Concordia

More information

Numerical Methods of Approximation

Numerical Methods of Approximation Contents 31 Numerical Methods of Approximation 31.1 Polynomial Approximations 2 31.2 Numerical Integration 28 31.3 Numerical Differentiation 58 31.4 Nonlinear Equations 67 Learning outcomes In this Workbook

More information

Classification of partial differential equations and their solution characteristics

Classification of partial differential equations and their solution characteristics 9 TH INDO GERMAN WINTER ACADEMY 2010 Classification of partial differential equations and their solution characteristics By Ankita Bhutani IIT Roorkee Tutors: Prof. V. Buwa Prof. S. V. R. Rao Prof. U.

More information

Lecture 4: Numerical solution of ordinary differential equations

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

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

i=1 α i. Given an m-times continuously

i=1 α i. Given an m-times continuously 1 Fundamentals 1.1 Classification and characteristics Let Ω R d, d N, d 2, be an open set and α = (α 1,, α d ) T N d 0, N 0 := N {0}, a multiindex with α := d i=1 α i. Given an m-times continuously differentiable

More information

Lecture 8: Boundary Integral Equations

Lecture 8: Boundary Integral Equations CBMS Conference on Fast Direct Solvers Dartmouth College June 23 June 27, 2014 Lecture 8: Boundary Integral Equations Gunnar Martinsson The University of Colorado at Boulder Research support by: Consider

More information

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

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

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior Boundary conditions In a domain Ω one has to add boundary conditions to the heat (or diffusion) equation: 1. u(x, t) = φ for x Ω. Temperature given at the boundary. Also density given at the boundary.

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

100 CHAPTER 4. SYSTEMS AND ADAPTIVE STEP SIZE METHODS APPENDIX

100 CHAPTER 4. SYSTEMS AND ADAPTIVE STEP SIZE METHODS APPENDIX 100 CHAPTER 4. SYSTEMS AND ADAPTIVE STEP SIZE METHODS APPENDIX.1 Norms If we have an approximate solution at a given point and we want to calculate the absolute error, then we simply take the magnitude

More information

Convergence of Summation-by-Parts Finite Difference Methods for the Wave Equation

Convergence of Summation-by-Parts Finite Difference Methods for the Wave Equation J Sci Comput (2) 71:219 245 DOI 1./s1915-16-297-3 Convergence of Summation-by-Parts Finite Difference Methods for the Wave Equation Siyang Wang 1 Gunilla Kreiss 1 Received: 15 January 216 / Revised: 16

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Finite Element Methods

Finite Element Methods Finite Element Methods Max D. Gunzburger Janet S. Peterson August 26, 214 2 Chapter 1 Introduction Many mathematical models of phenomena occurring in the universe involve differential equations for which

More information

Green s Functions and Distributions

Green s Functions and Distributions CHAPTER 9 Green s Functions and Distributions 9.1. Boundary Value Problems We would like to study, and solve if possible, boundary value problems such as the following: (1.1) u = f in U u = g on U, where

More information

Equations Introduction

Equations Introduction Chapter 9 90 Introduction Partial Differential Equations The numerical treatment of partial differential equations is, by itself, a vast subject Partial differential equations are at the heart of many,

More information

Well-posedness, stability and conservation for a discontinuous interface problem: an initial investigation.

Well-posedness, stability and conservation for a discontinuous interface problem: an initial investigation. Well-posedness, stability and conservation for a discontinuous interface problem: an initial investigation. Cristina La Cognata and Jan Nordström Abstract A robust interface treatment for the discontinuous

More information

Divergence Formulation of Source Term

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

More information

High Frequency Scattering by Convex Polygons Stephen Langdon

High Frequency Scattering by Convex Polygons Stephen Langdon Bath, October 28th 2005 1 High Frequency Scattering by Convex Polygons Stephen Langdon University of Reading, UK Joint work with: Simon Chandler-Wilde Steve Arden Funded by: Leverhulme Trust University

More information

The Helically Reduced Wave Equation as a Symmetric Positive System

The Helically Reduced Wave Equation as a Symmetric Positive System Utah State University DigitalCommons@USU All Physics Faculty Publications Physics 2003 The Helically Reduced Wave Equation as a Symmetric Positive System Charles G. Torre Utah State University Follow this

More information

SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM. Mirjana Stojanović University of Novi Sad, Yugoslavia

SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM. Mirjana Stojanović University of Novi Sad, Yugoslavia GLASNIK MATEMATIČKI Vol. 37(57(2002, 393 403 SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM Mirjana Stojanović University of Novi Sad, Yugoslavia Abstract. We introduce piecewise interpolating

More information

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 0139.9 NUMERICAL FLUID MECHANICS SPRING 015 Problem Set 4 Issued: Wednesday, March 18, 015 Due: Wednesday,

More information

1 Solutions to selected problems

1 Solutions to selected problems Solutions to selected problems Section., #a,c,d. a. p x = n for i = n : 0 p x = xp x + i end b. z = x, y = x for i = : n y = y + x i z = zy end c. y = (t x ), p t = a for i = : n y = y(t x i ) p t = p

More information

The Finite Element Method for the Wave Equation

The Finite Element Method for the Wave Equation The Finite Element Method for the Wave Equation 1 The Wave Equation We consider the scalar wave equation modelling acoustic wave propagation in a bounded domain 3, with boundary Γ : 1 2 u c(x) 2 u 0, in

More information

Lecture Note 3: Interpolation and Polynomial Approximation. Xiaoqun Zhang Shanghai Jiao Tong University

Lecture Note 3: Interpolation and Polynomial Approximation. Xiaoqun Zhang Shanghai Jiao Tong University Lecture Note 3: Interpolation and Polynomial Approximation Xiaoqun Zhang Shanghai Jiao Tong University Last updated: October 10, 2015 2 Contents 1.1 Introduction................................ 3 1.1.1

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Diploma Thesis Institute for Numerical Simulation, TUHH On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Corrected version Katja Baumbach August 17, 2006 Supervisor: Prof. Dr.

More information

Partial Differential Equations and the Finite Element Method

Partial Differential Equations and the Finite Element Method Partial Differential Equations and the Finite Element Method Pavel Solin The University of Texas at El Paso Academy of Sciences ofthe Czech Republic iwiley- INTERSCIENCE A JOHN WILEY & SONS, INC, PUBLICATION

More information

Polynomial Approximation: The Fourier System

Polynomial Approximation: The Fourier System Polynomial Approximation: The Fourier System Charles B. I. Chilaka CASA Seminar 17th October, 2007 Outline 1 Introduction and problem formulation 2 The continuous Fourier expansion 3 The discrete Fourier

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