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

Size: px
Start display at page:

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

Transcription

1 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 as a well-established numerical technique for solving problems engineering and applied science. The main advantage of the BEM is its unique ability to provide a complete solution in terms of boundary value only. An initial restriction of the BEM is that the fundamental solution to the original partial differential equation is required in order to obtain an equivalent boundary integral equation. Another is that non-homogeneous terms are included in the formulation by means of domain integrals, thus making the technique lose the attraction of its boundary only character.the resolution of these problems has been the subect of considerable research over the past decade and several methods have been suggested. It is our opinion that the most successful so far is the dual reciprocity method (DRM) by means of accuracy and programming point of view.

2 . Introduction There are three classical methods for solving problems in engineering and applied science. The first approach is the finite difference method. This technique approximates the derivatives in the differential equation which govern each problem using some type of truncated Taylor expansion. The second one is the finite element method (FEM). This method involves the approximation of the variables over small parts of the domain, called elements, in term of polynomial interpolation function. The disadvantages of FEM are that large quantities of data are required to discretize the full domain. The third one is the boundary element method (BEM). This approach is developed as a response to that problem. The method requires discretization of the boundary only thus reducing the quantity of data necessary to run a program. However, there are some difficulties of extending the technique to several applications such as non-homogeneous, non-linear and time-dependent problems for examples. The main drawback in these case is the need to discretize the domain into a series of internal cells to deal with the terms not taken to the boundary by application of the fundamental solution. This additional dicretization destroys some of the attraction of the method in terms of the data required to run the program and the complexity of the extra operations involved. It was then realised that a new approach was needed to deal with domain integrals in boundary elements. Several methods have been proposed by different authors. The most important of them are:. Analytic Integration of the Domain Integrals.. The Use of Fourier Expansion. 3. The Galerkin Vector Technique. 4. The Multiple Reciprocity Method. 5. The Dual Reciprocity Method The Dual Reciprocity Method (DRM) is essentially a generalised way of constructing particular solutions that can be used to solve non-linear and time-dependent problems as well as to represent any internal source distribution. This work is intended to study this method.

3 . The boundary Element Method for the equation u 0 and u b. Laplace equation The Laplace equation satisfied by the potential u in a domain with a boundary as shown in Figure can be converted into the well known integral equation (Brebbia, 978) cu uq d qu d (.) u where and we assume that u u on and q q on. n denotes n the unit outward normal to and u is the fundamental solution of the Laplace equation; c is a real number which is described in the following paragraphs. n u u u 0 u q q n Figure. : Laplace equation posed on the domain with the boundary Let P be a point in the domain and assume that P is an internal point. Then equation (.) becomes (Paris and Cañas, 997) u( P) qu d uq d (.) u where u is a fundamental solution and q. n On the other hand, in the case when P is a boundary point, equation (.) is of the form (Paris and Cañas, 997) where c( P) u( P) uq d qu d (.3) ( P) c( P), (P) is the internal angle at the boundary point P. 3

4 For a two-dimensional domain, the fundamental solution is (Gilbert and Howard, 990) u ln( ) r (.4) On the other hand, in a three-dimensional domain (Gilbert and Howard, 990) u 4r where r is the distance between the source point and the field point, see Figure.. Field point r Source point Figure. : Distance r between the source point and the field point The boundary integral equation (.3) is discretized by partitioning the boundary into elements. The element lies between node and node + as shown in Figure.3. This is equivalent to replacing the boundary curve by a polygon Target element + [] r i 3 Base node Figure.3 : Discretization of the boundary into elements 4

5 We choose a suitable set of basis function w ( s) :,,..., where s is the distance around the boundary,, and consider the boundary element approximation u ~ ( s) w ( s) U q ~ ( s) w ( s) Q where U and Q are the, approximate, values of u and q at node. Setting u u~ and q q~ in equation (.3) we collocate at the nodal points to obtain a system of algebraic equation (Davies and Crann, 996) c u i i ( w s) U q ds w ( s) Q u ds (.5) which we may write as c u i i i Hˆ U G Q (.6) i where Hˆ G i i w ( s) q ds w ( s) q ds (.7.) w ( s) u ds w ( s) u ds (.7.) We shall consider linear elements in which w (s) is the usual hat function based at node as shown in Figure.4. 5

6 w (s) Figure.4 : Hat function based on node Consider an arbitrary segment such as the one shown in Figure.5, odal value of u and q = - = ode + ode Figure.5 : Relation between local co-ordinate and dimensionless co-ordinate, ( s s ) l s s l Local co-ordinate s s l With the basis function w (s) being the hat function shown in Figure.4, we see that the values of u and q at any point of an element can be defined in terms of their nodal values and the linear interpolation functions and such that u( ) U q( ) Q U Q U U Q Q 6

7 where is the dimensionless co-ordinate and and are the usual Lagrange interpolation polynomials ( ( ) ) The integral along the element in equation (5) becomes, for the left hand side, U U w q ds q ds h h U (.8) U [ ] where for each element we have two components, h q ds [ ] h q ds [ ] Similarly, for the right hand side we obtain Q Q w u ds q ds g g (.9) Q Q [ ] where for each element we have two components, g u ds [ ] g u ds [ ] Hence, from equation (.6), for each collocation node i we have H ˆ h h (.0.) i ( ) and G i g g( ) (.0.) 7

8 In this development of the boundary element method, the equation c U i i i Hˆ U G Q (.) i has been obtained by collocating at the nodes defining the function values i.e. the collocation and functional nodes are the same. In equation (.), defines a functional node and i denotes a collocation node. Let us define H ˆ where i i H i H i H ˆ c where i i i then we can write equation () as H iu G i Q (.) The system of linear equations may be written in matrix form HU = GQ (.3) Applying the boundary conditions to identify the Dirichlet and eumann boundary regions we can partition the system (.3) in the form U U Q H H G G Q where U and Q comprise known boundary values and U and Q comprise unknown boundary values. The equations are then rearranged in the form AX = F Where A G H, Q X, and F [ GQ HU] U Once the values of U and Q on the whole boundary are known we can calculate the value of u at any internal point P k by using equation (.). We obtain 8

9 u k G k Q Hˆ U (.4) k The LIBEM code (Mushtag, 995), based on Brebbia (978), is implemented by using this mathematical algorithm and works well with smooth domain boundaries because there are no corners in such boundaries. However, the MULBEM program (Toutip, 999), can solve problems caused corners and discontinuous boundary condithions using the multiple node method (Subia and Ingber, 995).. Poisson equation Consider the Poisson equation as shown in Figure.6 u b in (.5) n u u q q Figure.6 : Geometric Definitions of the Problem where b is at present assumed to be a known function. In a similar way as done in the Laplace equation, we have u bu d q qu d u u q d (.6) which inegrated by parts twice to produce u ud bu d qu d qu d uq d uq d (.7) After substituting the fundamental solution u of the Laplace equation into (.7) and grouping all boundary terms together we obtain 9

10 c u i uq d i bu d qu d (.8) otice that although the function b is known and consequently the integral in does not introduce any new unknowns, the problem has changed in character as we need now to carry out a domain integral as well as the boundary integral. The constant c i depends only on the boundary geometry at the point i under consideration. The simplest way of computing the domain integral term in equation (.8) is by subdividing the region into a series of internal cells, on each of which a numerical integration scheme such as Gauss quadrature can be applied. However, this technique loses the attraction of its boundary only character. It was then realised that a new approach was needed to deal with domain integrals in boundary elements. Several methods have been proposed by different authors. The most important of them are:. Analytic Integration of the Domain Integrals. This approach, although producing very accurate results, is only applicable to a limited number of cases for which the integrals can be evaluated analytically.. The Use of Fourier Expansion. The Fourier expansion method is not straightforward to apply in many cases as the calculation of the coefficients can be computationally cumbersome, although the method has been applied with some success to relatively simple cases. 3. The Galerkin Vector Technique. This approach uses a primitive, higherorder fundamental solution and Green s identity to transform certain types of domain integrals into equivalent boundary integrals. The main difficulty of the approach is that it can only solve comparatively simple cases. It has been extended to deal with other applications giving origin to the technique discussed in the paragraph. 4. The Multiple Reciprocity Method. This is an extension of the Galerkin vector technique which utilises as many higher-order fundamental solutions as required rather than using ust one. The main difficulty is that the method cannot be easily applied to general non-linear problems although it has been successfully used to solve some time-dependent problems. 5. The Dual Reciprocity Method. This is the subect of this work and constituted the only general technique other than cell integration. The Dual Reciprocity Method (DRM) is essentially a generalised way of constructing particular solutions that can be used to solve non-linear and time-dependent problems as well as to represent any internal source distribution. The method can be applied to define sources over the whole domain or only on part of it. The approach will be described in the next section. 0

11 3. The Dual Reciprocity Method for Equation of the Type u b x, y 3. Mathematical Development of the DRM for the Poisson Equation Consider the Poisson equation u b (3.) where b bx, y, that is, b is considered to be a known function of position. The solution to equation (3.) can be expressed as the sum of the solution of a homogenous and a particular solution as u uh uˆ where u h is the solution of the homogeneous equation and û is a particular solution of the Poisson equation such that uˆ b (3.) If there are boundary nodes and L internal nodes, as shown in Figure 3. : Boundary node : Internal node Figure 3. : Boundary and internal nodes there will be form L values of û and the approximation of b can be written in the

12 b L (3.3) f where the :,,..., L is a set of coefficients and the f are approximating functions. The particular solutions û, and the approximating, f are linked through the relation uˆ f (3.4) The function f in (3.3) can be compared with the usual interpolation function i in expansions such as which are used on the boundary elements themselves. Substituting equation (3.4) into (3.3) gives b u iu i (3.5) L uˆ (3.6) Equation (3.6) can be substituted into the original equation (3.) to give the following expression u L uˆ (3.7) Multiplying by the fundamental solution and integrating by parts over the domain, we obtain L u u d ( u) u d ˆ (3.8) ote that the same result may be obtained from equation ( u) u d bu d (3.9) Integrating the Laplacian terms by parts in (3.8), produces the following integral equation for each source node i, c u i i L q ud u qd c u q uˆ i i d ˆ u qˆ d (3.0)

13 The term qˆ in equation (3.0) is defined as outward normal to, and can be expanded to u qˆ ˆ, where n is the unit n uˆ x uˆ y qˆ (3.) x n y n ote that equation (3.0) involves no domain integrals. The next step is to write equation (3.0) in discretized form, with summations over the boundary elements replacing the integrals. This gives for a source node i the expression L ciui q ud u qd ciuˆ i q uˆ d u q ˆ d (3.) k k k k k k k 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 u i i k H ik u k k G ik q k L ciuˆ i H ikuˆ k Gik qˆ k (3.3) k k 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 (3.3) can be expressed in matrix form as Hu Gq L Hu Gˆ ˆ (3.4) q If each of the vectors û and qˆ is considered to be one column of the matrices Û and Qˆ respectively, then equation (3.4) may be written without the summation to produce Hu Gq Huˆ Gˆ (3.5) q Equation (3.5) is the basis for the application of the Dual Reciprocity Boundary Element Method and involves discretization of the boundary only. The process described forms the basis of the method and gives a process for extending to non-linear problems. However, in the linear case ( b = b(x, ), we can develop the method in an manner, such that we can easily adapt the existing MULBEM code, as follows: Consider the Poisson equation (3.) with the boundary conditions as shown in Figure.6. From equation (3.3) we have 3

14 b L f with uˆ f where f and û are known. Set L U u uˆ (3.6) Taking Laplacian operator both two sides we obtain U u L Substituting (3.) and (3.4) into equation (3.7) we have ( uˆ ) (3.7) U b L (3.8) f Finally, by substituting (3.3) into equation (3.8), we obtain a new Laplace eqaution U 0 (3.9) with boundary conditions U U L u uˆ on and Q Q q L qˆ on where Q is the normal derivative of U. After the Laplace eqution (3.9) has been solved, the values of U and Q are known and hence we also obtain the solution of the Poisson equation (3.) by the followings: L u U uˆ on boundary and inside (3.0) and q Q on boundary (3.) The MULBEM code is modified to the MULDRM by this manner. 4

15 Interior odes The definition of interior nodes is not normally a necessary condition to obtain a boundary solution, however, the solution will usually be more accurate if a number of such nodes is used. When interior nodes are defined, each one is independently placed, and they do not form part of any element or cell, thus the co-ordinates only are needed as input data. Hence these nodes may be defined in any order. The Vector The vector in equation (3.5) will now be considered. It was seen in equation (3.3) that b L (3.) f This may be expressed in matrix form as b F (3.3) where each column of F consists of a vector f containing the values of the function f at the ( L) DRM collocation points. In the case of the problems considered in this section, the function b in (3.) and (3.) is a known function of position. Thus equation (3.3) may be inverted to obtain, i.e. F b (3.4) The right-hand side of equation (3.5) is thus a known vector. Writing (3.5) as Hu Gq d (3.5) where d HUˆ GQˆ (3.6) Applying boundary conditions to (3.5), this equation reduces to the form Ax y (3.7) where x contains unknown boundary values of u and q. 5

16 Internal Solution After equation (3.7) is obtained using standard techniques, the values at any internal node can be calculated from equation (3.3), each one involving a separate multiplication of known vectors and matrices. In the case of internal nodes, as was explained in previous section, c and equation (3.3) becomes i u i k H ik u k k G ik q L k uˆ i H ikuˆ k Gikqˆ k (3.8) k k 3. Different f Expansions The particular solution, approximating functions û, its normal derivative, qˆ, and the corresponding f used in DRM analysis are not limited by formulation except that the resulting F matrix, equation (3.3), should be non-singular. In order to define these functions it is customary to propose an expansion for f and then compute û and qˆ using equations (3.4) and (3.), respectively. The originators of the method have proposed the following types of functions for f. Elements of the Pascal triangle. Trigonometric series 3. The distance function r use in the definition of the fundamental solution The r function was adopted first by ardini and Brebbia and then by most researchers as the simplest and most accurate alternative. The definition of r is that r r x r y (3.9) where r x and r y are the components of r in the direction of the x and y axes. If f r, it can easily be shown that the corresponding û function is dimensional case. The function qˆ will be given by r 9, in the two r qˆ rx cos( n, x) ry cos( n, (3.30) 3 6

17 In the above, the direction cosine refer to the outward normal at the boundary with respect to the x and y axes. Formula (3.30) may be easily obtained suing (3.) and r rx r ry remembering that and. x r y r Furthermore, some recent works suggest that series f r is in fact one component of the f r r... r m (3.3) The û and qˆ functions corresponding to (3.3) are : uˆ r 4 3 r 9 m r... ( m ) (3.3) m x y r r qˆ rx ry... (3.33) n n 3 ( m ) In principal, any combination of terms may be selected from (3.3). To illustrate this, for Poisson-type equation, one case will be considered: f r The presence of the constant guarantees the completeness of the expansion and also implies that the leading diagonal of F is no longer zero. Equation (3.3) may be solved for using standard Gaussian elimination. This is the simplest alternative to program. It has already produced excellent results for a wide range of engineering problems. ote that in this case uˆ r 4 3 r 9 and qˆ r x x r n y y r n 3 We implement the DRBEM program first based on this manner. Furthermore, the program include the thin plate spline function for approximation. However this program is still separated the execution of solving the boundary solution and internal solution. Finally, the DRBEM is implemented to solve the whole system of equation in order to apply to solve non-linear case in the future work. We discuss computational results in the late section. 7

18 4. Computational Result of the MULDRM program Example : Square plate with internal heat generation (Gibson, 985) Consider the Poisson equation u (4.) The problem is to be solved over an isotropic square plate occupying the region 6 x 6 and 6 y 6. The symmetry of the region means we need consider only the negative quadrant as shown Figure 4.. (-6,6) 0 9 (0,6) 3 8 u (-6,0) (0,0) : Boundary node : Internal node : Multiple node Figure 4. : Discretization of the boundary into elements with 4 multiple nodes and 5 internal points Initially the boundary is modelled with boundary elements and 4 multiple nodes at the corners. The calculation of the potential is required at the five internal points shown in Figure 4..Boundary conditions are specified as zero flux on the line x 0, y 0and as zero temperature on the line x 6, y 6. The internal solutions obtained using MULDRM program are compared with those of the Monte Carlo method and the exact solution in Table 4.. 8

19 Error (%) DRBEM 3/8/09 Table 4. : Internal solutions of square plate with internal heat generation problem Internal Monte Calo method MULDRM Exact point Standard Multiple solution (-,) (-4,) (-3,3) (-,4) (-4,4) Percentage errors of the potentials at the internal points are shown in Figure 4.. Percentage errors of potential (-,) (-4,) (-3,3) (-,4) (-4,4) Monte Calo Standard Multiple node Figure 4. : Percentage errors of potential at the internal points We see from the figure that the percentage errors of the solution using the multiple node approach are less than the other methods. Example : The Torsion problem Consider the Poisson equation u (4.) on the elliptical domain as shown in Figure

20 (0,) (-,0) 9 (,0) (0,-) 6 7 : Boundary node : Internal point : Multiple node Figure 4.3 : Discretization of the boundary into 6 elements 7 internal points and 4 multiple nodes in elliptical domain The elliptical section shown in Figure 3 has a semi-maor axis a = and a semiminor axis b =. The equation of the ellipse is x a b y (4.3) The boundary condition is the Dirichlet condition with u = 0 on the boundary. The exact solution is The normal derivative is 0 x y u.8 (4.4) a b q 0.( x 8y ) (4.5) We use the number of multiple nodes as 4, 8 and 6. The four multiple nodes are shown in Figure 4.3. The solutions are compared with the cell integration method and the exact solution as shown in Table 4.. 0

21 Error (%) DRBEM 3/8/09 Table 4. : Internal solutions of the Torsion problem Internal Cell MULDRM Program (o. of multiple nodes) Exact point Integration solution (.5,0.0) (.,-0.35) (0.6,-0.45) (0.0,-0.45) (0.9,0.0) (0.3,0.0) (0.0,0.0) Percentage errors of potential at the internal points are shown in Figure 4.4 Percentage errors of potential (.5,0.0) (.,-0.35) (0.6,-0.45) (0.0,-0.45) (0.9,0.0) (0.3,0.0) (0.0,0.0) Cell Integration Standard Multiple node Figure 4.4 : Comparison percentage errors at the internal point We see that from Figure 4.4 that the multiple nodes do not seem to help much because the domain boundary is smooth. The boundary does not contain real corners. However, the solution using the method is quite better compared with the others.

22 Results for different functions b b( x, The problem in Example will now be presented for different known function b( x, In all applications the same problem geometry will be used, that given in figure 4.3 with homogeneous condition u 0. ( a ) The case u x This case and another in this section will be modeled using the element geometry shown in Figure 4.3. The governing equation is The exact solution is given by u x (4.6) x x u y (4.7) 7 4 which satisfies the boundary condition u 0 on and produces x 3x q y (4.8) 4 Results for both the DRBEM program with varieties of multiple nodes and the cell integration are given in Table 4.3. Table 4.3 : Internal solution for the equation u x Internal Cell MULDRM Program (O. of multiple nodes) Exact point Integration solution (.5, 0.00) (., 0.35) (0.6,-0.45) (0.0,-0.45) (0.9, 0.00) (0.3, 0.00) (0.0, 0.00) Percentage errors of potential at the internal points are shown in Figure 4.5

23 error (%) DRBEM 3/8/09 Percetage errors of potential (. 5, ) (., ) ( 0. 6, ) ( 0. 9, ) ( 0. 3, ) C e ll in te g r a tio n S ta n d a r d M u ltip le n o d e s ( b ) The case u x In this case the governing equation is The exact solution is given by u x (4.9) x 50x 8y 33.6 y 4 u (4.0) 46 which again satisfies the boundary condition u 0 on and produces 3 x 50x 96xy 83.x 96x y 3y 83. yy 3 q (4.) Results for the DRBEM program with varieties of multiple nodes and the exact solution are given in Table

24 Error (%) DRBEM 3/8/09 Table 4.4 : Internal solution for the equation u x Internal MULDRM Program (o. of multiple nodes) Exact point solution (.5,0.0) (.,-0.35) (0.6,-0.45) (0.0,-0.45) (0.9,0.0) (0.3,0.0) (0.0,0.0) Percentage errors of potential at the internal points are shown in Figure 4.6 Percentage errors of potential (.5,0.0) (.,-0.35) (0.6,-0.45) (0.0,-0.45) (0.9,0.0) (0.3,0.0) (0.0,0.0) Standard Multiple node Figure 4.6 : Comparison percentage errors at the internal points We see from Figure 4.6 that the multiple nodes do not seem to help much in case of the smooth boundary as we mentioned in the first problem of Example. 4

25 5. Computational results of the DRBEM program We have implemented the program DRBEM to solved the Poisson equations in the form u u u p( x, p ( x, u p3( x, p4 ( x, x y (5.) using both of the radial basis function f r and f r log r with linear term. The previous DRBEM program is separated to solve the boundary solution and use the result to evaluate the internal solution. On the other hand this program solve the whole system of equations to obtain the boundary solution and the internal solution in the same time. The program is tested with some problems in 6 cases: Case : p p p p p3 p4 p ( x, x x y p3 p4 p( x, 5e p3 p4 p ( x, p p4 p 3( x, p p 3( x,, p4 ( x, Case : p 0, Case 3: p 0, Case 4: p 0, Case 5: p 0, Case 6: p 0, We are going to present the result in each case. Case : p p p p This case is a kind of Laplace equation. We test the program with a previous problem examined by LIBEM and MULBEM program. Consider the potential problem u 0 (5.) in a square plate 0 x 6, 0 y 6 with solution u x. We partition the boundary into elements without multiple nodes. The boundary values of function and normal derivative are shown in Figure 5.. 5

26 (0,6) y q = 0 (6,6) u = 300 u = 0 (0,0) (6,0) q = 0 x Figure 5.: Boundary conditions for Problem The results are compared with those of using LIBEM and MULBEM program and shown in Table 5.. Table : The potential at the internal points Point x y LIBEM MULBEM DRBEM Exact f = +r f=tps solution Case : p p p 0, 3 4 p ( x x, Consider the Poisson equation on the elliptical domain as shown in Figure 5. u x (5.3) 6

27 (0,) (-,0) 9 (,0) (0,-) 6 7 : Boundary node : Internal point Figure 5.: Discretization of the boundary into 6 elements and 7 internal points in elliptical domain The elliptical section shown in Figure has a semi-maor axis a = and a semiminor axis b =. The equation of the ellipse is x y (5.4) The boundary condition is the Dirichlet condition with u = 0 on the boundary. The exact solution is given by x 50x 8y 33.6 y 4 u (5.5) 46 which again satisfies the boundary condition u 0 on and produces 3 x 50x 96xy 83.x 96x y 3y 83. yy 3 q (5.6) The potential solution at the internal nodes are shown in Table 5. and the normal derivatives at the boundary are shown in Table

28 Table 5.: The potential at the internal nodes of the problem Point x y DRBEM DRBEM Exact f = +r f=tps f = +r f=tps solution Table 5.3: The normal derivative at the boundary of the problem Point x y DRBEM DRBEM Exact f = +r f=tps f = +r f=tps solution Case 3: p p p 0, 3 4 p( x, 5e x y Consider the Poisson equation u x y 5 e (5.7) on the quarter of a unit-circle x y. Discretization and boundary condition are shown in Figure

29 9 (0,) q e x y 6 u x y e (0,0) (,0) q e x y Boundary node Internal node Figure 5.3: Discretization and boundary condition of the mixed problem The potential solutions at the internal nodes are shown in Table 5.4 and the normal derivatives at the boundary are shown in Table 5.5. Table 5.4: The potential at the internal nodes of the problem Point x y DRBEM DRBEB Exact f = +r f=tps f = +r f=tps solution

30 Table 5.5: The normal derivative on the boundary of the problem Point x y DRBEM DRBEB Exact f = +r f=tps f = +r f=tps solution Case 4: p p p 0, p ( x, 3 4 Consider the Poisson equation u u (5.8) on the boundary as shown in Case. Since homogeneous boundary condition will result in the trivial solution u q 0 at all nodes, a non-homogeneous condition has to be used, for example u sin x (5.9) The solutions of the program are also compared with those of the original program and the exact solutions and are shown in Table 5.6. Table 5.6: The potential at the internal nodes of the problem 30

31 Point x y Original DRBEM Exact f = +r f=+r+r^+r^3 f = +r f=tps solution Case 5: : p p p 0, p ( x, 4 Consider the Poisson equation 3 u u (5.0) x on the boundary as shown in Case. Since homogeneous boundary condition will result in the trivial solution u q 0 at all nodes, a non-homogeneous condition has to be used, for example u x e (5.) The solutions of the program are also compared with those of the original program and the exact solutions and are shown in Table 5.7. Table 5.7: The potential at the internal nodes of the problem Point x y Original DRBEM Exact f = +r f=+r+r^+r^3 f = +r f=tps solution

32 Case 6: p p 0, p x,, p ( x, 3( 4 Consider the Poisson equation u u u (5.) x y on the boundary as shown in Case. Since homogeneous boundary condition will result in the trivial solution u q 0 at all nodes, a non-homogeneous condition has to be used, for example u x y e e (5.3) The solutions of the program are also compared with those of the original program and the exact solutions and are shown in Table 5.8. Table 5.8: The potential at the internal nodes of the problem Point x y Original DRBEM Exact f = +r f=+r+r^+r^3 f = +r f=tps solution Conclusion We cannot distinguish the results computed by the standard linear elements and the multiple node approach in problems containing smooth boundary. The MULDRM program which transform Poisson equation to Laplace one works well but available only in case of the right hand side function is a position function. The DRBEM program which separates the execution of solving boundary and internal solution works as well as the DRBEM one which solves the whole solution in the same time. However the DRBEM is suitable to modify to solve the non-linear problem which is the future work. In problem containing corner domain, the normal derivative solution at the boundary is still poor. It is our purpose to modify the program to resolve this problem. For approximation of functions, the thin plate spline works better than the linear function f r for all cases. 3

33 References Golberg, M.A. (994) The theory of radial basis functions applied to the BEM for inhomogrneous partial differential equations. Boundary Elements Communications 5, Golberg, M.A. (996) The method of fundamental solutions for Poisson's equation. Engineering Analysis with Boundary Elements 6, Golberg, M.A., Chen, C.S., Bowman, H. and Power, H. (998) Some comments on the use of radial basis functions in the dual reciprocity method. Computational Mechanics, Karur, S.R. and Ramachandran, P.A. (994) Radial basis function approximation in the dual reciprocity method. Mathematical and Computer Modelling 0, Partridge, P.W. and Brebbia, C.A. (989) Computer implementation of the BEM dual reciprocity method for the solution of Poisson type equations. Software for Engineering Workstations 5, Partridge, P.W. and Brebbia, C.A. (990) Computer implementation of the BEM dual reciprocity method for the solution of general field equations. Communications in Applied umerical Methods 6, Partridge, P.W., Brebbia, C.A. and Wrobel, L.C. (99) The dual reciprocity boundary element method, Southampton: Computational Mechanics Publications. Powell, M.J.D. (994) The uniform covergence of thin plate spline interpolation in two dimension. umerical Mathematics 68, ====================================== 33

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

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

Discrete Projection Methods for Integral Equations

Discrete Projection Methods for Integral Equations SUB Gttttingen 7 208 427 244 98 A 5141 Discrete Projection Methods for Integral Equations M.A. Golberg & C.S. Chen TM Computational Mechanics Publications Southampton UK and Boston USA Contents Sources

More information

The method of fundamental solutions for Poisson's equation M.A. Golberg Czrc/e

The method of fundamental solutions for Poisson's equation M.A. Golberg Czrc/e The method of fundamental solutions for Poisson's equation M.A. Golberg Czrc/e ABSTRACT We show how to extend the method of fundamental solutions (MFS) to solve Poisson's equation in 2D without boundary

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

CHAPTER II MATHEMATICAL BACKGROUND OF THE BOUNDARY ELEMENT METHOD

CHAPTER II MATHEMATICAL BACKGROUND OF THE BOUNDARY ELEMENT METHOD CHAPTER II MATHEMATICAL BACKGROUND OF THE BOUNDARY ELEMENT METHOD For the second chapter in the thesis, we start with surveying the mathematical background which is used directly in the Boundary Element

More information

Boundary Element Method for the Helmholtz Equation

Boundary Element Method for the Helmholtz Equation Journal of Mathematical Extension Vol. 9, No. 4, (205), 65-79 ISSN: 735-8299 URL: http://www.ijmex.com Boundary Element Method for the Helmholtz Equation A. Mesforush Shahrood University Z. Mehraban Shahrood

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

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS Victor S. Ryaben'kii Semyon V. Tsynkov Chapman &. Hall/CRC Taylor & Francis Group Boca Raton London New York Chapman & Hall/CRC is an imprint of the Taylor

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

MEEN 673 ********************************* NONLINEAR FINITE ELEMENT ANALYSIS ********************************* J. N. Reddy

MEEN 673 ********************************* NONLINEAR FINITE ELEMENT ANALYSIS ********************************* J. N. Reddy MEEN 673 ********************************* NONLINEAR FINITE ELEMENT ANALYSIS ********************************* J. N. Reddy e-mail: jnreddy@tamu.edu Texas A&M University College Station, TX 77843-3123 USA

More information

Chapter 4. Two-Dimensional Finite Element Analysis

Chapter 4. Two-Dimensional Finite Element Analysis Chapter 4. Two-Dimensional Finite Element Analysis general two-dimensional boundary-value problems 4.1 The Boundary-Value Problem 2nd-order differential equation to consider α α β φ Ω (4.1) Laplace, Poisson

More information

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

The dual reciprocity boundary element method for. two-dimensional Burgers equations using MATLAB. 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

More information

Computable representations of influence functions for multiply connected Kirchoff plates

Computable representations of influence functions for multiply connected Kirchoff plates Computable representations of influence functions for multiply connected Kirchoff plates Y.A. Melnikov Department of Mathematical Sciences Middle Tennessee State University, USA Abstract A modification

More information

Partial Differential Equations

Partial Differential Equations Next: Using Matlab Up: Numerical Analysis for Chemical Previous: Ordinary Differential Equations Subsections Finite Difference: Elliptic Equations The Laplace Equations Solution Techniques Boundary Conditions

More information

A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS

A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS JOURNAL OF MECHANICS OF MATERIALS AND STRUCTURES Vol., No., A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS CHRISTOPHER G. PROVATIDIS This paper proposes the use of a global collocation

More information

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Ming-Chih Lai Department of Applied Mathematics National Chiao Tung University 1001, Ta Hsueh Road, Hsinchu 30050 Taiwan Received 14 October

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

Chapter 1. Condition numbers and local errors in the boundary element method

Chapter 1. Condition numbers and local errors in the boundary element method Chapter 1 Condition numbers and local errors in the boundary element method W. Dijkstra, G. Kakuba and R. M. M. Mattheij Eindhoven University of Technology, Department of Mathematics and Computing Science,

More information

Finite-Elements Method 2

Finite-Elements Method 2 Finite-Elements Method 2 January 29, 2014 2 From Applied Numerical Analysis Gerald-Wheatley (2004), Chapter 9. Finite-Elements Method 3 Introduction Finite-element methods (FEM) are based on some mathematical

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

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

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

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

Numerical Analysis of Electromagnetic Fields

Numerical Analysis of Electromagnetic Fields Pei-bai Zhou Numerical Analysis of Electromagnetic Fields With 157 Figures Springer-Verlag Berlin Heidelberg New York London Paris Tokyo Hong Kong Barcelona Budapest Contents Part 1 Universal Concepts

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

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

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

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

PART IV Spectral Methods

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

More information

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

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

Math 302 Outcome Statements Winter 2013

Math 302 Outcome Statements Winter 2013 Math 302 Outcome Statements Winter 2013 1 Rectangular Space Coordinates; Vectors in the Three-Dimensional Space (a) Cartesian coordinates of a point (b) sphere (c) symmetry about a point, a line, and a

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

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

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b)

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b) Numerical Methods - PROBLEMS. The Taylor series, about the origin, for log( + x) is x x2 2 + x3 3 x4 4 + Find an upper bound on the magnitude of the truncation error on the interval x.5 when log( + x)

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

Boundary element method, finite element method and thefluxspline method: a performance comparison for scalar potential problems

Boundary element method, finite element method and thefluxspline method: a performance comparison for scalar potential problems Boundary element method, finite element method and thefluxspline method: a performance comparison for scalar potential problems A. BulcSo, C. F. Loeffler, P. C. Oliveira Departamento de Engenharia Mecdnica,

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

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

WRT in 2D: Poisson Example

WRT in 2D: Poisson Example WRT in 2D: Poisson Example Consider 2 u f on [, L x [, L y with u. WRT: For all v X N, find u X N a(v, u) such that v u dv v f dv. Follows from strong form plus integration by parts: ( ) 2 u v + 2 u dx

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 2014 Quiz #2 April 14, 2014 Name: SOLUTION ID#: PS1.:

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 03 Quiz # April 8, 03 Name: SOUTION ID#: PS.: A the

More information

D. Shepard, Shepard functions, late 1960s (application, surface modelling)

D. Shepard, Shepard functions, late 1960s (application, surface modelling) Chapter 1 Introduction 1.1 History and Outline Originally, the motivation for the basic meshfree approximation methods (radial basis functions and moving least squares methods) came from applications in

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Journal of Computational Physics 182, 337 345 (2002) doi:10.1006/jcph.2002.7172 A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Ming-Chih Lai Department of Applied Mathematics, National

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

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

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

PARTIAL DIFFERENTIAL EQUATIONS

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

More information

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

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

Recent developments in the dual receiprocity method using compactly supported radial basis functions

Recent developments in the dual receiprocity method using compactly supported radial basis functions Recent developments in the dual receiprocity method using compactly supported radial basis functions C.S. Chen, M.A. Golberg and R.A. Schaback 3 Department of Mathematical Sciences University of Nevada,

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

The Convergence of Mimetic Discretization

The Convergence of Mimetic Discretization The Convergence of Mimetic Discretization for Rough Grids James M. Hyman Los Alamos National Laboratory T-7, MS-B84 Los Alamos NM 87545 and Stanly Steinberg Department of Mathematics and Statistics University

More information

Y. M. TEMIS AND V. V. KARABAN 1

Y. M. TEMIS AND V. V. KARABAN 1 J. KSIAM Vol.5, No.2, 39-51, 2001 BOUNDARY ELEMENT TECHNIQUE IN TORSION PROBLEMS OF BEAMS WITH MULTIPLY CONNECTED CROSS-SECTIONS Y. M. TEMIS AND V. V. KARABAN 1 Abstract. This paper shows how boundary

More information

Chapter 3 Variational Formulation & the Galerkin Method

Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 1 Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 2 Today s Lecture Contents: Introduction Differential formulation

More information

3.1 Interpolation and the Lagrange Polynomial

3.1 Interpolation and the Lagrange Polynomial MATH 4073 Chapter 3 Interpolation and Polynomial Approximation Fall 2003 1 Consider a sample x x 0 x 1 x n y y 0 y 1 y n. Can we get a function out of discrete data above that gives a reasonable estimate

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems

Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems Copyright 2011 Tech Science Press SL, vol.6, no.2, pp.93-107, 2011 Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems T.-T. Hoang-Trieu 1, N. Mai-Duy 1 and T. Tran-Cong

More information

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

More information

Transient heat conduction by different versions of the Method of Fundamental Solutions a comparison study

Transient heat conduction by different versions of the Method of Fundamental Solutions a comparison study Computer Assisted Mechanics and Engineering Sciences, 17: 75 88, 2010. Copyright c 2010 by Institute of Fundamental Technological Research, Polish Academy of Sciences Transient heat conduction by different

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

Empirical Models Interpolation Polynomial Models

Empirical Models Interpolation Polynomial Models Mathematical Modeling Lia Vas Empirical Models Interpolation Polynomial Models Lagrange Polynomial. Recall that two points (x 1, y 1 ) and (x 2, y 2 ) determine a unique line y = ax + b passing them (obtained

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Numerical Integration (Quadrature) Another application for our interpolation tools!

Numerical Integration (Quadrature) Another application for our interpolation tools! Numerical Integration (Quadrature) Another application for our interpolation tools! Integration: Area under a curve Curve = data or function Integrating data Finite number of data points spacing specified

More information

Grade 11 Pre-Calculus Mathematics (1999) Grade 11 Pre-Calculus Mathematics (2009)

Grade 11 Pre-Calculus Mathematics (1999) Grade 11 Pre-Calculus Mathematics (2009) Use interval notation (A-1) Plot and describe data of quadratic form using appropriate scales (A-) Determine the following characteristics of a graph of a quadratic function: y a x p q Vertex Domain and

More information

International Journal of Advanced Engineering Technology E-ISSN

International Journal of Advanced Engineering Technology E-ISSN Research Article INTEGRATED FORCE METHOD FOR FIBER REINFORCED COMPOSITE PLATE BENDING PROBLEMS Doiphode G. S., Patodi S. C.* Address for Correspondence Assistant Professor, Applied Mechanics Department,

More information

MATHEMATICAL METHODS INTERPOLATION

MATHEMATICAL METHODS INTERPOLATION MATHEMATICAL METHODS INTERPOLATION I YEAR BTech By Mr Y Prabhaker Reddy Asst Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad SYLLABUS OF MATHEMATICAL METHODS (as per JNTU

More information

Self-adaptive Trefftz procedure for harmonic problems

Self-adaptive Trefftz procedure for harmonic problems Computer Assisted Mechanics and Engineering Sciences, 4: 491 500, 1997. Copyright c 1997 by Polska Akademia Nauk Self-adaptive Trefftz procedure for harmonic problems Jan A. Ko lodziej and Roman Starosta

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

DRBEM ANALYSIS OF COMBINED WAVE REFRACTION AND DIFFRACTION IN THE PRESENCE OF CURRENT

DRBEM ANALYSIS OF COMBINED WAVE REFRACTION AND DIFFRACTION IN THE PRESENCE OF CURRENT 54 Journal of Marine Science and Technology, Vol. 10, No. 1, pp. 54-60 (2002) DRBEM ANALYSIS OF COMBINED WAVE REFRACTION AND DIFFRACTION IN THE PRESENCE OF CURRENT Sung-Shan Hsiao*, Ming-Chung Lin**, and

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

Exact and Approximate Numbers:

Exact and Approximate Numbers: Eact and Approimate Numbers: The numbers that arise in technical applications are better described as eact numbers because there is not the sort of uncertainty in their values that was described above.

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

Boundary knot method: A meshless, exponential convergence, integration-free, Abstract

Boundary knot method: A meshless, exponential convergence, integration-free, Abstract Boundary knot method: A meshless, exponential convergence, integration-free, and boundary-only RBF technique W. Chen Department of Mechanical System Engineering, Shinshu University, Wakasato 4-17-1, Nagano

More information

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation A local-structure-preserving local discontinuous Galerkin method for the Laplace equation Fengyan Li 1 and Chi-Wang Shu 2 Abstract In this paper, we present a local-structure-preserving local discontinuous

More information

Appendix 1. Numerical Integration: Regular Integrals

Appendix 1. Numerical Integration: Regular Integrals The Dual Reciprocity 269 Appendix 1 Numerical Integration: Regular Integrals 1 Introduction The numerical integration formulae given in this Appendix are used for integration over boundary elements which

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

More information

Point interpolation method based on local residual formulation using radial basis functions

Point interpolation method based on local residual formulation using radial basis functions Structural Engineering and Mechanics, Vol. 14, No. 6 (2002) 713-732 713 Point interpolation method based on local residual formulation using radial basis functions G.R. Liu, L. Yan, J.G. Wang and Y.T.

More information

Meshfree Approximation Methods with MATLAB

Meshfree Approximation Methods with MATLAB Interdisciplinary Mathematical Sc Meshfree Approximation Methods with MATLAB Gregory E. Fasshauer Illinois Institute of Technology, USA Y f? World Scientific NEW JERSEY LONDON SINGAPORE BEIJING SHANGHAI

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

First-order overdetermined systems. for elliptic problems. John Strain Mathematics Department UC Berkeley July 2012

First-order overdetermined systems. for elliptic problems. John Strain Mathematics Department UC Berkeley July 2012 First-order overdetermined systems for elliptic problems John Strain Mathematics Department UC Berkeley July 2012 1 OVERVIEW Convert elliptic problems to first-order overdetermined form Control error via

More information

AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS

AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS th Pan-American Congress of Applied Mechanics January 04-08, 00, Foz do Iguaçu, PR, Brazil AN ALTERNATIVE TECHNIQUE FOR TANGENTIAL STRESS CALCULATION IN DISCONTINUOUS BOUNDARY ELEMENTS Otávio Augusto Alves

More information

Numerical Solutions of Laplacian Problems over L-Shaped Domains and Calculations of the Generalized Stress Intensity Factors

Numerical Solutions of Laplacian Problems over L-Shaped Domains and Calculations of the Generalized Stress Intensity Factors WCCM V Fifth World Congress on Computational Mechanics July 7-2, 2002, Vienna, Austria Eds.: H.A. Mang, F.G. Rammerstorfer, J. Eberhardsteiner Numerical Solutions of Laplacian Problems over L-Shaped Domains

More information

Curve Fitting. 1 Interpolation. 2 Composite Fitting. 1.1 Fitting f(x) 1.2 Hermite interpolation. 2.1 Parabolic and Cubic Splines

Curve Fitting. 1 Interpolation. 2 Composite Fitting. 1.1 Fitting f(x) 1.2 Hermite interpolation. 2.1 Parabolic and Cubic Splines Curve Fitting Why do we want to curve fit? In general, we fit data points to produce a smooth representation of the system whose response generated the data points We do this for a variety of reasons 1

More information

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

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

Algebraic. techniques1

Algebraic. techniques1 techniques Algebraic An electrician, a bank worker, a plumber and so on all have tools of their trade. Without these tools, and a good working knowledge of how to use them, it would be impossible for them

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Finite Element Method (FEM)

Finite Element Method (FEM) Finite Element Method (FEM) The finite element method (FEM) is the oldest numerical technique applied to engineering problems. FEM itself is not rigorous, but when combined with integral equation techniques

More information

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

More information

BOUNDARY PARTICLE METHOD FOR INVERSE CAUCHY PROBLEMS OF INHOMOGENEOUS HELMHOLTZ EQUATIONS

BOUNDARY PARTICLE METHOD FOR INVERSE CAUCHY PROBLEMS OF INHOMOGENEOUS HELMHOLTZ EQUATIONS Journal of Marine Science and Technology, Vol. 7, No. 3, pp. 57-63 (9) 57 BOUNDARY PARTICLE METHOD FOR INVERSE CAUCHY PROBLEMS OF INHOMOGENEOUS HELMHOLTZ EQUATIONS Wen Chen* and Zhuojia Fu* Key words:

More information

Advanced. Engineering Mathematics

Advanced. Engineering Mathematics Advanced Engineering Mathematics A new edition of Further Engineering Mathematics K. A. Stroud Formerly Principal Lecturer Department of Mathematics, Coventry University with additions by Dexter j. Booth

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

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

ELLIPSES. Problem: Find the points on the locus. Q(x, y) = 865x 2 294xy + 585y 2 = closest to, and farthest from, the origin. Answer.

ELLIPSES. Problem: Find the points on the locus. Q(x, y) = 865x 2 294xy + 585y 2 = closest to, and farthest from, the origin. Answer. ELLIPSES Problem: Find the points on the locus closest to, and farthest from, the origin. Answer. Q(x, y) 865x 2 294xy + 585y 2 1450 This is a Lagrange multiplier problem: we want to extremize f(x, y)

More information