3. Numerical integration

Size: px
Start display at page:

Download "3. Numerical integration"

Transcription

1 3. Numerical integration One-dimensional quadratures Two- and three-dimensional quadratures Exact Integrals for Straight Sided Triangles Reduced and Selected Integration Summary Exercises Numerical integration 3. One-dimensional quadratures: Since the finite element method is based on integral relations it is logical to expect that one should strive to carry out the integrations as efficiently as possible. In some cases we will employ exact integration. In others we may find that the integrals can become too complicated to integrate exactly. In such cases the use of numerical integration will prove useful or essential. The important topics of local coordinate integration and Gaussian quadratures will be introduced here. They will prove useful when dealing with higher order interpolation functions in complicated element integrals and allow the whole process to be automated. I = F(r) dω = Ω F(r) J e n d q q= F(r q ) J e (r q ) w q (3.-) Numerical integration is simply a procedure that approximates an integral by a summation. However, it can yield the exact integral and often does when the integrand is a polynomial. The famous mathematician Gauss posed this question: What is the minimum number of points, say n q, required to exactly integrate a polynomial, and what are the corresponding non-dimensional abscissae (locations) and weights for those points? If we require the summation to be exact when the integrand f(x) is any one of the power functions, x, x,, x n, we obtain a set of n conditions that allow us to determine the n q, the abscissae, x k, and their corresponding weights, w k. The n q Gaussian one-dimensional quadrature points are symmetrically placed with respect to the center of the interval, and will exactly integrate a polynomial of degree (n q ). Gauss obtained the results as numbers defined by square roots or combinations thereof. For example, the two-point rule in natural coordinates gave a k = ± 3, w k =. For efficiency and fast access, all quadrature data are tabulated as finite numbers with many significant figures. The center point location is included in the abscissae list only when n q is odd, and the end points are never utilized in a Gauss rule. The Gauss rule data are usually tabulated for a non-dimensional unit coordinate range of r, or for a natural coordinate range of a, which are tabulated in Table 3.-. The first three integration points are sketched in Fig The unit coordinate values are

2 tabulated in function qp_rule_unit_gauss.m, a portion of which is shown in Fig The natural coordinate values of the quadrature data are stored in function qp_rule_gauss.m as seen in Fig The number of integration points is the input argument, and the arrays of positions and weights are the returned items, ready to be used in a loop over those integration points. A Matlab script for the same hard coded calculation is given in Fig That script can be easily generalized to any D Lagrangian elements by calling the element library and the quadrature library as shown in Fig At each stage in the integration loop the location, r, and the number of nodes per element, n_n n n, are supplied as arguments. The value of n_n is used to select which interpolation member of the element library is desired. Then that interpolation function, and its parametric derivative, is evaluated at the input local coordinate and those two arrays of numbers are the returned items from the function. The script in Fig is Figure 3.- Natural,, and 3 point quadrature points, ξ, on a line actually shorter that the hard coded script. By changing the third line data, any interpolated onedimensional cubic quantity can be integrated numerically. Next a few more examples of numerical integration of interpolation functions are presented. Note that in the above examples only four significant digits were used in the integrations to keep the examples simple. The actual data are tabulated to 4 significant figures. If the physical node spacing had not been equal (very undesirable except for the special case of linear fracture mechanics) in Ex the four term cubic interpolation would have been needed and then the square matrix would have been 4 x 4. Even in that case, if the x e input data were equally spaced the larger matrix products would yield exactly the same result.

3 Figure 3.- Portion of the unit coordinate line quadrature data Table 3.- Abscissas and Weights for Gaussian Quadrature in Unit Coordinates 3

4 Figure 3.-3 Portion of the natural coordinate tabulated data 4

5 Example 3.- Given: Using numerical integration determine the physical length of the cubic line element in Ex..- with straight line coordinates of x et = [ 4 8] cm. Solution: The length is L e x = dx = dx(r) dr J e (r) dr. x Recall that the interpolation function and its derivative are H(r) = [( r + 8r 9r 3 ) (8r 45r + 7r 3 ) ( 9r + 3r 7r 3 ) (r 9r + 9r 3 )] H(r) r = [( + 3r 7r ) (8 9r + 8r ) ( 9 + 7r 8r ) ( 8r + 7r )] dr Since the coordinate is interpolated by the above cubic polynomial, x(r) = H(r) x e, the degree of the integrand is 3 and the number of Gauss points is only n q = to get the exact answer. The numerical integration is L e = dx(r) dr = dr n q q= dx(r q) w dr q = n q q= 5 dh xe dr (r q ) w q = [ where the determinant of the Jacobian at each point in the summation is J e (r q ) = dx(r q) dr = dh dr (r q) x e n q q= dh dr (r q ) w q ] x e Here, that product will be evaluated at each quadrature point. The two tabulated quadrature locations in unit coordinates are r =.3, and r =.7888, and the two tabulated weights are the same w = w =.5. Set the sum total initially to zero, L=, and begin the summation loop: set q =, substituting r =.3 into the derivative the Jacobian is J(r ) e = [ ] { 4 } cm =. cm 8 Multiply by the tabulated weight and add to the sum: L e = + J(r ) e w = + (. cm).5 = 3. cm. At the second point the Jacobian is J(r ) e = [ ] { 4 } cm =. cm 8 Multiply this by the tabulated weight and add to the sum L e = 3. cm + J(r ) e w = 3. + (. cm).5 =. cm That yields the exact physical length of the cubic line element. However, since the physical nodes are equally spaced on a straight line the physical location only depends on the first and last node. In other words, the geometry mapping degenerates to a

6 linear interpolation x(r) = ( r)x + rx 4. For a linear polynomial or a constant the exact integration requires only one quadrature point. For a one-point rule the tabulated data are r =.5, w =.. Because the physical coordinates were equally spaced the element will have a constant Jacobian: J e (r) = dh(r) dr x e = ( )x + x 4 = (x 4 x ) = L. Continuing with the numerical evaluation of the length: L e = + [ ] {. } =. cm. 8. Example 3.- Given: Automate the integration in Ex. 3.- of the cubic solution with nodal values of u et = [ 3 ] and nodal coordinates of x et = [ 4 8]m by applying Gaussian quadrature in the unit coordinate space. Solution: The integral is I u = u(r)dx = L e u(r) J(r) dr = [ H(r) J(r) e dr ] u e. Previously, it was noted that the Jacobian in this example is constant ( L e ) but this example will treat it as a variable. The degree of the polynomial is 3. The number of necessary quadrature points is determined from Degree ( n q ), so two quadrature points are required (and more are okay). The integral becomes I u = [ H(r) J(r) e dr n q ] u e = [ H(r q ) J(r q ) w q ] u e where, in general, the Jacobian matrix at the quadrature point is calculated (numerically) as the product of the local derivative of the interpolation functions times the input nodal coordinate vector: J(r q ) e = x(r q) = H(r q) x e r r Here, that product will be evaluated at each quadrature point. The analytic expressions for H(r) and H(r q ) r are in Ex..-. Here the arrays are evaluated numerically at each point. The two tabulated quadrature locations in unit coordinates are r =.3, and r =.7888, and the two tabulated weights are the same w = w =.5. Begin the summation loop: set q =, the Jacobian there is J(r ) e = [ ] { 4 } cm =. cm 8 The function at the point is u(r ) = [ ] { 3 } = 3.45 and the contribution from this point is q=

7 I q = u(r ) J(r ) e w q = (. cm)(3.45 ).5 =.45 cm. Set q =, the Jacobian there is J(r ) e = [ ] { 4 } cm =. cm. The function at the point is u(r ) = [ ] { 3 } so u(r ) =.95 and the contribution from this point is I q = u(r ) J(r ) e w q = (. cm)(.95 ).5 =.745 cm. Therefore, the total integral is I u =.45 cm.745 cm = 7.5 cm, which agrees with the analytically integrated value given later in Ex Figure 3.-3 Evaluating Ex. 3.- by explicit numerical integration 7

8 Figure 3.-4 Numerical line integration using tables and the element library Example 3.-3 Given: Using numerical integration determine the physical y-moment of inertia of the cubic line element in prior Ex. 3.- with nodal coordinates of x et = [ 4 8] cm with respect to the first node. Solution: The definition of the moment of inertia with respect to the y-axis (x-origin) is I Y = x dx = x(r) dx(r) n L e dr dr = q x(r dx(r q) q ) w q= dr q The exact integral for a specific element is I e Y = L e x + L e x + L e3 3 = 8 cm 3. For equal spaced physical nodes on a straight line the geometry is linear: x(r) = ( r)x e + rx e 4 = [( r) r] { x x } e, and dx(r) = (x e 4 dr 4 x e ) L e. Since x(r) is degree one, and the Jacobian is constant (degree ) the total polynomial degree to be integrated is ( + + ) = so a two-point rule (n q = ) will exactly integrate the moment of inertia. Recalling that in matrix notation x(r) = x(r) T x(r) = [[( r) r] { x x 4 } e ] T [( r) r] { x x 4 } e x(r) = [x x 4] e ( { r) } [( r) r] { x r x } e = [x x 4] e [ ( r) ( r)r 4 ( r)r r ] { x x } e 4 Now, for the first time the integrand is a square matrix and the resultant scalar will come from a row matrix times the square matrix times a column matrix. Namely, 8

9 I e Y = x(r) Let S e be the square matrix: Lecture Notes, Finite Element Analysis, J.E. Akin, Rice University dx(r) dr dr = [ x x 4 ] e [ ( r) ( r)r ( r)r r ] S e = L e ( r) ( r)r [ ( r)r r ] dr = Le [ ] Then the matrix notation of the exact moment of inertia is I e Le Y = [x x 4 ] e [ ] {x x } e 4 ( ) = ( )( )( ) L e dr { x e x } 4 The given statement requires the integration (of S e )to be done numerically. n q S e = L e [ ( r q) ( r q )r q ] q= ( r q )r q r q Again, r =.3, and r =.7888, and w = w =.5. The numerical integral is S e = + L e (.3) [ (.3).3 (.3).3.3 ].5 + L e [ (.7888) (.7888).7888 symmetric.7888 ].5 = L e [ ] Finally, substituting the other numerical constants I e Y = [ 8]cm ( cm) [ ] { } cm = 8. cm3 8 Of course, if the interpolations are done using natural coordinate interpolations the exact same matrix integrals and results are obtained. w q Example 3.-4 Given: The generalized mass matrix for a line element is defined (later) as x 3 M e = H(r) T c(x) H(r) dx x where c(x) is a known property (like the mass per unit length). Evaluate this integral for a quadratic line element, with constant property c, by using exact numerical integration. Solution: In parametric coordinate space the definition of the matrix is x 3 M e = H(r) T c(x) H(r) dx = H(r) T c(r) H(r) J(r) e x dr 9

10 First, it is necessary to establish the polynomial degree of the integrand. Here, H(r) is of degree (quadratic): H(r) = [( 3r + r ) (4r 4r ) ( r + r )] The source term c(r) is constant (degree ). Require equal physical node spacing so the determinant of element Jacobian is also constant (degree ), J(r) e = L e. For these restrictions the degree of the polynomial to be integrated is Therefore n q Degree = ( ) = 4 (n q ) 5 n q, n q =.5, rounding up n q = 3 n q =3 w q= q M e = H(r q ) T c(r q ) H(r q ) J(r q ) e w q= q = c e L e H(r q ) T H(r q ) (3 3) = [(3 )( )( 3)( )] where the locations and weights are: e e r q = { 5.e }, w q = { e } e e Starting with M e =, loop over each Gaussian quadrature point, numerically form H(r q ), numerically calculate the matrix product, H(r q ) T H(r q ), add that matrix to M e. After that loop, multiply (numerically) the final square matrix by the element constants for the final result which approximates the exact integral: M e = c e L e [ ] ce L e 4 3 [ ] Note: In higher dimensions the Jacobian is usually not a constant. However, in practical problems where the mesh has many small elements the Jacobian will be very close to a constant. Thus, the number of quadrature points is often increased by one to account for a not exactly constant Jacobian. 3. Two- and three-dimensional quadratures: The quadrature rules for quadrilaterals and hexahedra are simply tensor products of the one-dimensional rule appropriate for the degree of polynomial in each direction (which are almost always the same degree). The products of twoand three-point rules (in each parametric direction) in a quadrilateral are illustrated in Fig The Matlab script qp_rule_nat_quad.m shown in Fig. 3.- creates the numerical integration data for a quadrilateral in natural coordinates. The only input argument is the total number of two-dimensional integration points. That value is the square of the number of one-dimensional integration points to be use in each parametric direction. The return items are the two parametric coordinates and the combined weight at each quadrature point. Only one line needs to be changed to create equivalent unit coordinate quadrature data. For a hexahedron a similar script

11 would just use three loops. Of course, its input argument would have to be the cube of the number of one-dimensional points used in each parametric direction. It is not unusual for a finite element analysis to include over a million elements. Then, the numerical integration loop involves a significant amount of computations. Therefore, some specialized integration rules have been developed that give the same accuracy with fewer points. For example, in a hexahedra element the Gauss process often requires 7 points, but there is a special rule that uses only 4 points for the same accuracy. Figure 3.- Tensor product of, and 3 quadrature point rules in a quadrilateral Figure 3.- Creating quadrilateral integration rule from the -D rule The quadrature rules for triangles and tetrahedra do not have a simple equation relating the number of quadrature points to the polynomial degree. The number of quadrature points in a triangle required to integrate polynomials from degree to 8 are, 3, 4,, 7,, 3, and, respectively are available from the function qp_rule_unit_tri.m (Fig. 3.-3), and data for higher degrees are in function qp_rule_high_unit_tri.m. In each case, the single argument to the script is

12 the total number of required quadrature points in the triangle (and not the degree of the polynomial being integrated). The quadrature points in triangles fall along the lines that bisect the corner angles of the element, as shown in Fig The two simplest quadrature rules are the internal (versus internal and boundary points) one-point rule (n q = ) located at the centroid with r = 3 = s and w = for integrating constant and linear functions; and the midangle symmetric three-point rule (for degree ) with r =, s = and r = 4, s =, r 3 =, s 3 = 4, and w = w = w 3 =. Figure 3.-3 Selected triangular quadrature data values

13 Degree n q Figure 3.-4 Some symmetric quadrature locations for unit triangle Example 3.- Given: For a four node quadrilateral element in local natural coordinates evaluate the local moment-of inertia with respect to the a-axis: I aa = b d by numerical integration and check it with handbook values for right angled rectangles. Solution: The integral is quadratic in b, so a two-point rule in each local direction will give the exact results. That is, use the four-point rule (n q = 4) like Fig. 3.3-: I aa = b d = b n q =4 da db = b q w q From the Introduction and Summary the points are at a q and b q are located a ± 3 and all have a weight of w q =. I aa = + ( 3 ) + ( 3 ) + ( 3 ) + ( 3 ) = 4 3 Checking a geometric properties table for common shapes gives the inertia of a right rectangle with respect to its centerline as I aa = base height 3 = () ()3 = = 4 3 q= Example 3.- Given: All straight side triangles have a constant Jacobian matrix and determinant. Use this fact to calculate the area of the triangle. Solution: The calculation of the area is simple. A e = da = dx dy = A e A e J e d = J e d = J e 3

14 and any constant can be integrated exactly by a one-point rule (n q = ). Here, the chapter summary shows that the one-point weight is one-half (and for linear functions is evaluated at the centroid of the parametric triangle) so the triangle physical area integral reduces to n q = A e = J e d = J e w q q= = J e Another way of saying this is that the determinant of the Jacobian of all straight sided triangles is just twice the physical area of the triangle J e = A e for straight triangles (only). In the following chapters it will be shown that the algebra reduces to J e = (x x ) e (y 3 y ) e (x 3 x ) e (y y ) e = A e when the corners are numbered counter-clockwise. Example 3.-3 Given: For a linear unit triangle element evaluate the local polar-moment-ofinertia I rs = r s d and check it with handbook values for right triangles. Solution: The integral is only linear in r and s, so both the one-point and three-point rules will give the exact results. Use the three-point rule (n q = 3): I rs = r s d I rs = + r = r s ds dr n q = r q s qw q q= = 9 = 4 Checking a geometric properties table for common shapes gives the polar inertia of a right triangle with respect to the right angle corner as I rs = 4 base height = 4 = 4 Example 3.-4 Given: For a four node quadrilateral element in local natural coordinates evaluate the local moment-of inertia with respect to the a-axis: I aa = b d 4

15 by numerical integration and check it with handbook values for right angled rectangles. Solution: The integral is quadratic in b, so a two-point rule in each local direction will give the exact results. That is, use the four-point rule (n q = 4) like Fig. 3.3-: I aa = b d = b n q =4 da db = b q w q q= From the Introduction and Summary the points are at a q and b q are located at ± 3 and all have a weight of w q =. I aa = + ( 3 ) + ( 3 ) + ( 3 ) + ( 3 ) = 4 3 Checking a geometric properties table for common shapes gives the inertia of a right rectangle with respect to its centerline as I aa = base height 3 = () ()3 = = Exact Integrals for Straight Sided Triangles:* Since straight sided triangles have a constant Jacobian integrals of parametric polynomial terms can be integrated in closed form. A typical polynomial integral can be expressed in terms of factorials of its exponents: I = A e r m s n da = Ae m! n! (+m+n)! Ae K m n (3.3-) where the constants K m n are listed in Table 3.3- for terms up to degree eight polynomials. The constant K m n which divides into the physical area can also be expressed as a simple Matlab script appended at the bottom of the table. A similar analytic volume integral is available for a straight edged tetrahedral element: I = r m s n t p dv V e = V e m! n! p! (3 + m + n + p)! Table 3.3- Exact integrals for polynomials in straight triangles 5

16 K(m, n) = factorial ( + m + n) / ( * factorial (m) * factorial (n)) Example 3.3- Given: The generalized mass matrix for a triangular element is defined (later) as M e = H(r, s) T c H(r, s) da A e where c is a known constant property (like the mass density). Evaluate this integral for a linear triangular element by exact integration using the above table of K mn values. Solution: In unit coordinate parametric space the interpolation functions are: H(r, s) = [( r s) (r) (s)]. The matrix to be integrated is H H H H H H 3 M e = c [ H H H H H H 3 ] da = M et A e H 3 H H 3 H H 3 H 3 Due to the symmetry of the matrix only six integrals need to be evaluated. The term M e = c H (r, s) H (r, s) da A e = c r da A e Since this triangle has straight sides Table 3.3- is valid to use. Using m =, n =, for this term the table gives K =, so exact area integral is M e = c A e. Likewise, the matrix term M e = c H (r, s) H (r, s) da A e and the table gives three terms M e = c r( r s) da A e = c ( Ae 3 Ae Ae = c (r r rs) da A e Ae ) = c. The final mass matrix result is

17 M e = cae [ ] = M e T 3.4 Reduced and selective integration*: Since the numerical integration of the element square matrix can represent a large part of the total cost it is desirable to use the lowest order integration rules. Care must be taken when selecting the minimal order of integration. Usually the integrand will contain global derivatives so that in the limit, as the element size h approaches zero, the integrand can be assumed to be constant, and then only the volume integral V = dv V = J 7 dr ds dt remains to be integrated exactly. Such a rule could be considered the minimal order. However, that order is often too low to be practical since it may lead to a rank deficient element (and system) square matrix, if the rule does not exactly integrate the equations. Typical integrands involve terms such as the strain energy density per unit volume: B T E B. Let n q denote the number of element quadrature points while n r represents the number of independent relations at each of the integration points. The rank of the element is R = n q n r. Generally, n r corresponds to the number of rows in the B matrix in the usual triple product integrand of the element square matrix: B T E B. For a typical element with n c constraint equations on the n i element degrees of freedom the number of quadrature points needs to be selected such that n q (n r n c ) n i. (3.4-) For a non-singular system square matrix, assembled from n e elements, a similar requirement is n e (n q n r n c ) (n d n EBC ) (3.4-) where n EBC denotes the number of essential boundary conditions. These relations can be used as guides in selecting a minimal value of integration points, n q, in the element. It has long been known that a finite element model gives a stiffness which is too high. Using reduced integration so as to underestimate the element stiffness has been accepted as one way to improve the results. A danger of low order integration rules is that zero energy modes may arise in an element. That is, the element energy is δ et S e δ e = for δ e. Usually these zero energy modes, δ e, are incompatible with the same modes in an adjacent element. Thus, the assembly of elements may have no zero energy modes (except for the standard rigid body modes). An eigen-analysis of the element can be used as a check since eigenvalues of zero correspond to zero energy modes. For element formulations involving element constraints, or penalties, it is considered best to employ selective integration rules. For penalty formulations, such as incompressible materials, it is common to have equations of the form (S + αs )δ = c where the global constant α in the limit where the penalty constraint is exactly satisfied. In the limit as α the system degenerates to S δ = c α where the solution approaches the trivial result, δ =. That behavior is called solution locking. To obtain a non-trivial solution in this limit it is necessary for the square matrix S to be singular (rank deficient) and the matrix S to be non-

18 singular. Therefore, the two contributing element parts, S and S, are selectively integrated. That is, S matrix is under integrated so as to be rank deficient (singular) while S is integrated with a rule which renders S non-singular. A typical application of selective integration is plate bending where the bending stiffness contributions are in S while the shear stiffness contributions are in S which have the constant α = /t where t is the plate thickness. 8

19 3.5 Summary Notation n e Number of elements n m Number of mesh nodes n p Dimension of parametric space n s Dimension of physical space n g Number of generalized DOF per node n n Number of nodes per element n q Number of total quadrature points Element interpolations utilized in this chapter Element Type Example Number Polynomial Degree n p n g n n n i = n g n n Continuity Level Lagrange L C Lagrange L4 3.-,, C Lagrange T3 3.-, C Lagrange Q4 3.-,4 4 4 C Definition of Jacobian: [J] [ Numerical integration: (x, y, z) (r, s, t) ], -D: [J] [ x(r)], -D: [J] [ x r y r r x s y s ] F(r) n d q q= F(r q ) w q F(r) dω = F(r) Ω Je d n q q= F(r q ) J e (r q ) w q Exact unit coordinate integral for straight triangle (only): I = A e r m s n da = A e m! n! ( + m + n)! Number of points for exact -D polynomial numerical integration: Degree (n q ) Gaussian -D one-point line rule data, in unit coordinates and natural coordinates: r =.5, w = ; a =, w = Gaussian -D two-point line rule data, in unit coordinates and natural coordinates: r = ( 3) =.3, r = ( + 3) =.7887, w = w =.5 9

20 a = 3 =.57735, a = 3 =.57735, w = w =. Number of points needed for integrating polynomials on triangles: Degree n q Quadrature unit triangle one-point rule (for degree ): r = 3, s = 3, w = Quadrature unit triangle three-point rule (for degree ) r =, s =, w = r = 4, s =, w = r 3 =, s 3 = 4, w 3 = Lagrange linear C line interpolations (n p = ), in unit coordinates:, local nodes at (r = ) and (r = ), n n =, n g =, δ et = [u u ], H(r) = [( r) r], H(r) r = [ ] Lagrange quadratic C line interpolations (n p = ), in unit coordinates: local nodes at (r = ), (r = /) and (r = ), n n = 3, n g =, δ et = [u u u 3 ] H(r) = [( 3r + r ) (4r 4r ) ( r + r )], H(r) r = [(3 + 4r) (4 8r) ( + 4r)] Lagrange cubic C line interpolations (n p =, n n = 4), in unit coordinates: with local nodes at (r = ), (r = /3),(r = /3) and (r = ). DOF, δ et = [u u u 3 u 4 ] H(r) = [( r + 8r 9r 3 ) (8r 45r + 7r 3 ) ( 9r + 3r 7r 3 ) (r 9r + 9r 3 )] H(r) r = [( + 3r 7r ) (8 9r + 8r ) ( 9 + 7r 8r ) ( 8r + 7r )]. Lagrange linear triangle C interpolation (n p =, n n = 3, n g = ), in unit coordinates: with local nodes at (r =, s = ), (r =, s = ), and (r =, s = ). H(r, s) = [( r s) (r) (s)] H r [ H s ] = [ ]. Lagrange linear line element consistent mass matrix: M e = ρe A e L e [ ]

21 4 4 Lagrange quadratic line consistent mass: M e = ρe A e L e [ ] = me [ ] Lagrange cubic line element consistent mass matrix: M e = ρe A e L e 8 [ ] Lagrange linear triangle consistent mass matrix: M e = ρe A e t e [ ] = me [ ]

22 3. Exercises. Repeat Ex using a one-point quadrature rule.. Use numerical integration to verify that the local inertia of a unit triangle, with respect to the r- axis is I rr = s d = 3. Use numerical integration to verify that the local inertia of a unit triangle, with respect to the s- axis is I ss = r d = 4. Use numerical integration to form the Lagrange linear line element consistent mass matrix given in the summary. 5. Use numerical integration to form the 4 4 Lagrange cubic line element consistent mass matrix given in the summary. Index case, 3 consistent mass matrix, 9 constant Jacobian, 3, 4 cubic interpolation, 5 element constraints, else, elseif, exact integrals, 5 factorial, 5 for, 8, fracture mechanics, Gaussian quadrature, generalized mass matrix, 5 hexahedra, incompressible materials, integration loop, Jacobian, 5,, L4_C, 5, 8, 9 Lagrange_D_libary.m, 8 locking, 7 mass matrix, 9, minimal order integration, moment of inertia, 8, 9 natural coordinates, 8 number of independent relations, number of quadrature points,, numerical integration,, 5, 7, 8, 9, 8 physical length, 5 plate bending, 7 polar-moment-of- inertia, 3 Q4_C,, 4, 8 qp_rule_gauss.m,, 4 qp_rule_nat_quad.m,, qp_rule_unit_gauss.m,, 3, 8 qp_rule_unit_tri.m, quadratic interpolation, 9 quadrature, quadrature abscissas, 3, 4 quadrature point locations,, quadrature weights, 4 quadratures, quadrilateral quadrature, rank deficient, reduced integration, rigid body modes, selective integration rules, straight edged tetrahedral, 4 straight side triangle, 3 straight sided triangle, 4, 8 straight triangles, 3 strain energy density per unit volume, Summary, 8 switch, 3 T3_C, 9 tensor product, three-point rule, 3, 9 triangle quadrature, 3 triangular quadrature rule selection, 9 two-point rule, unit coordinates, 4, 5,, 5 unit triangle, 3 zero energy mode,

Chapter 10 INTEGRATION METHODS Introduction Unit Coordinate Integration

Chapter 10 INTEGRATION METHODS Introduction Unit Coordinate Integration Chapter 0 INTEGRATION METHODS 0. Introduction The finite element analysis techniques are always based on an integral formulation. At the very minimum it will always be necessary to integrate at least an

More information

2. Polynomial interpolation

2. Polynomial interpolation 2. Polynomial interpolation Contents 2. POLYNOMIAL INTERPOLATION... 1 2.1 TYPES OF INTERPOLATION... 1 2.2 LAGRANGE ONE-DIMENSIONAL INTERPOLATION... 2 2.3 NATURAL COORDINATES*... 15 2.4 HERMITE ONE-DIMENSIONAL

More information

ONE - DIMENSIONAL INTEGRATION

ONE - DIMENSIONAL INTEGRATION Chapter 4 ONE - DIMENSIONA INTEGRATION 4. Introduction Since the finite element method is based on integral relations it is logical to expect that one should strive to carry out the integrations as efficiently

More information

xm y n dx dy so that similar expressions could be used to evaluate the volume integrals.

xm y n dx dy so that similar expressions could be used to evaluate the volume integrals. Chapter Integration methods. Introduction The finite element analysis techniques are always based on an integral formulation. At the very minimum it will always be necessary to integrate at least an element

More information

General elastic beam with an elastic foundation

General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

10. Applications of 1-D Hermite elements

10. Applications of 1-D Hermite elements 10. Applications of 1-D Hermite elements... 1 10.1 Introduction... 1 10.2 General case fourth-order beam equation... 3 10.3 Integral form... 5 10.4 Element Arrays... 7 10.5 C1 Element models... 8 10.6

More information

12. Thermal and scalar field analysis

12. Thermal and scalar field analysis 2. THERMAL AND SCALAR FIELD ANALYSIS... 2. INTRODUCTION... 2.2 GENERAL FIELD PROBLEM... 2 2.3 COMMON FLUX COMPONENTS... 5 2. GALERKIN INTEGRAL FORM... 6 2.5 GALERKIN INTEGRAL FORM*... 7 2.6 ORTHOTROPIC

More information

Section 6.6 Gaussian Quadrature

Section 6.6 Gaussian Quadrature Section 6.6 Gaussian Quadrature Key Terms: Method of undetermined coefficients Nonlinear systems Gaussian quadrature Error Legendre polynomials Inner product Adapted from http://pathfinder.scar.utoronto.ca/~dyer/csca57/book_p/node44.html

More information

Contents as of 12/8/2017. Preface. 1. Overview...1

Contents as of 12/8/2017. Preface. 1. Overview...1 Contents as of 12/8/2017 Preface 1. Overview...1 1.1 Introduction...1 1.2 Finite element data...1 1.3 Matrix notation...3 1.4 Matrix partitions...8 1.5 Special finite element matrix notations...9 1.6 Finite

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

Interpolation Functions for General Element Formulation

Interpolation Functions for General Element Formulation CHPTER 6 Interpolation Functions 6.1 INTRODUCTION The structural elements introduced in the previous chapters were formulated on the basis of known principles from elementary strength of materials theory.

More information

Chapter 3. Formulation of FEM for Two-Dimensional Problems

Chapter 3. Formulation of FEM for Two-Dimensional Problems Chapter Formulation of FEM for Two-Dimensional Problems.1 Two-Dimensional FEM Formulation Many details of 1D and 2D formulations are the same. To demonstrate how a 2D formulation works we ll use the following

More information

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen CIV-E16 Engineering Computation and Simulation Examination, December 12, 217 / Niiranen This examination consists of 3 problems rated by the standard scale 1...6. Problem 1 Let us consider a long and tall

More information

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS The Q4 element has four nodes and eight nodal dof. The shape can be any quadrilateral; we ll concentrate on a rectangle now. The displacement field in terms

More information

CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE

CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE 4.1 Introduction Many applications in science and engineering require the solution of three dimensional

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

NUMERICAL METHODS. x n+1 = 2x n x 2 n. In particular: which of them gives faster convergence, and why? [Work to four decimal places.

NUMERICAL METHODS. x n+1 = 2x n x 2 n. In particular: which of them gives faster convergence, and why? [Work to four decimal places. NUMERICAL METHODS 1. Rearranging the equation x 3 =.5 gives the iterative formula x n+1 = g(x n ), where g(x) = (2x 2 ) 1. (a) Starting with x = 1, compute the x n up to n = 6, and describe what is happening.

More information

Triangular Plate Displacement Elements

Triangular Plate Displacement Elements Triangular Plate Displacement Elements Chapter : TRIANGULAR PLATE DISPLACEMENT ELEMENTS TABLE OF CONTENTS Page. Introduction...................... Triangular Element Properties................ Triangle

More information

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup,

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup, Introduction to Finite Element Analysis Using MATLAB and Abaqus Amar Khennane Taylor & Francis Croup Boca Raton London New York CRC Press is an imprint of the Taylor & Francis Croup, an informa business

More information

. D CR Nomenclature D 1

. D CR Nomenclature D 1 . D CR Nomenclature D 1 Appendix D: CR NOMENCLATURE D 2 The notation used by different investigators working in CR formulations has not coalesced, since the topic is in flux. This Appendix identifies the

More information

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Introduction Till now we dealt only with finite elements having straight edges.

More information

Finite Element Modeling and Analysis. CE 595: Course Part 2 Amit H. Varma

Finite Element Modeling and Analysis. CE 595: Course Part 2 Amit H. Varma Finite Element Modeling and Analysis CE 595: Course Part 2 Amit H. Varma Discussion of planar elements Constant Strain Triangle (CST) - easiest and simplest finite element Displacement field in terms of

More information

ENGI 4430 Multiple Integration Cartesian Double Integrals Page 3-01

ENGI 4430 Multiple Integration Cartesian Double Integrals Page 3-01 ENGI 4430 Multiple Integration Cartesian Double Integrals Page 3-01 3. Multiple Integration This chapter provides only a very brief introduction to the major topic of multiple integration. Uses of multiple

More information

Converting Plane Stress Statics to 2D Natural Frequencies, changes in red

Converting Plane Stress Statics to 2D Natural Frequencies, changes in red The following illustrates typical modifications for converting any plane stress static formulation into a plane stress natural frequency and mode shape calculation. The changes and additions to a prior

More information

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen Steps in the Finite Element Method Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen General Idea Engineers are interested in evaluating effects such as deformations, stresses,

More information

Integration using Gaussian Quadrature

Integration using Gaussian Quadrature Integration using Gaussian Quadrature Tutorials November 25, 2017 Department of Aeronautics, Imperial College London, UK Scientific Computing and Imaging Institute, University of Utah, USA 2 Chapter 1

More information

Code No: RT41033 R13 Set No. 1 IV B.Tech I Semester Regular Examinations, November - 2016 FINITE ELEMENT METHODS (Common to Mechanical Engineering, Aeronautical Engineering and Automobile Engineering)

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

Lecture Notes in Mathematics. Arkansas Tech University Department of Mathematics. The Basics of Linear Algebra

Lecture Notes in Mathematics. Arkansas Tech University Department of Mathematics. The Basics of Linear Algebra Lecture Notes in Mathematics Arkansas Tech University Department of Mathematics The Basics of Linear Algebra Marcel B. Finan c All Rights Reserved Last Updated November 30, 2015 2 Preface Linear algebra

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

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

Introduction Linear system Nonlinear equation Interpolation

Introduction Linear system Nonlinear equation Interpolation Interpolation Interpolation is the process of estimating an intermediate value from a set of discrete or tabulated values. Suppose we have the following tabulated values: y y 0 y 1 y 2?? y 3 y 4 y 5 x

More information

ENGI Multiple Integration Page 8-01

ENGI Multiple Integration Page 8-01 ENGI 345 8. Multiple Integration Page 8-01 8. Multiple Integration This chapter provides only a very brief introduction to the major topic of multiple integration. Uses of multiple integration include

More information

Lecture 20: Isoparametric Formulations.

Lecture 20: Isoparametric Formulations. Chapter #0 Isoparametric Formulation. Isoparametric formulations help us solve two problems. Help simplify the definition of the approimate displacement field for more comple planar elements (4-sided elements,

More information

CIVL 7/8117 Chapter 4 - Development of Beam Equations - Part 2 1/34. Chapter 4b Development of Beam Equations. Learning Objectives

CIVL 7/8117 Chapter 4 - Development of Beam Equations - Part 2 1/34. Chapter 4b Development of Beam Equations. Learning Objectives CIV 7/87 Chapter 4 - Development of Beam Equations - Part /4 Chapter 4b Development of Beam Equations earning Objectives To introduce the work-equivalence method for replacing distributed loading by a

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 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

Engg. Math. II (Unit-IV) Numerical Analysis

Engg. Math. II (Unit-IV) Numerical Analysis Dr. Satish Shukla of 33 Engg. Math. II (Unit-IV) Numerical Analysis Syllabus. Interpolation and Curve Fitting: Introduction to Interpolation; Calculus of Finite Differences; Finite Difference and Divided

More information

Applications in Solid Mechanics

Applications in Solid Mechanics Companies, 4 CHAPTER 9 Applications in Solid 9. INTRODUCTION The bar and beam elements discussed in Chapters 4 are line elements, as only a single coordinate axis is required to define the element reference

More information

Part D: Frames and Plates

Part D: Frames and Plates Part D: Frames and Plates Plane Frames and Thin Plates A Beam with General Boundary Conditions The Stiffness Method Thin Plates Initial Imperfections The Ritz and Finite Element Approaches A Beam with

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES A Thesis by WOORAM KIM Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 06

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 06 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 06 In the last lecture, we have seen a boundary value problem, using the formal

More information

Lagrange Interpolation and Neville s Algorithm. Ron Goldman Department of Computer Science Rice University

Lagrange Interpolation and Neville s Algorithm. Ron Goldman Department of Computer Science Rice University Lagrange Interpolation and Neville s Algorithm Ron Goldman Department of Computer Science Rice University Tension between Mathematics and Engineering 1. How do Mathematicians actually represent curves

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

JEPPIAAR ENGINEERING COLLEGE

JEPPIAAR ENGINEERING COLLEGE JEPPIAAR ENGINEERING COLLEGE Jeppiaar Nagar, Rajiv Gandhi Salai 600 119 DEPARTMENT OFMECHANICAL ENGINEERING QUESTION BANK VI SEMESTER ME6603 FINITE ELEMENT ANALYSIS Regulation 013 SUBJECT YEAR /SEM: III

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

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

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

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

5.1 Polynomial Functions

5.1 Polynomial Functions 5.1 Polynomial Functions In this section, we will study the following topics: Identifying polynomial functions and their degree Determining end behavior of polynomial graphs Finding real zeros of polynomial

More information

Finite element modelling of structural mechanics problems

Finite element modelling of structural mechanics problems 1 Finite element modelling of structural mechanics problems Kjell Magne Mathisen Department of Structural Engineering Norwegian University of Science and Technology Lecture 10: Geilo Winter School - January,

More information

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

More information

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass

CIVL 8/7117 Chapter 12 - Structural Dynamics 1/75. To discuss the dynamics of a single-degree-of freedom springmass CIV 8/77 Chapter - /75 Introduction To discuss the dynamics of a single-degree-of freedom springmass system. To derive the finite element equations for the time-dependent stress analysis of the one-dimensional

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 11

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 11 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Module - 01 Lecture - 11 Last class, what we did is, we looked at a method called superposition

More information

CIVL4332 L1 Introduction to Finite Element Method

CIVL4332 L1 Introduction to Finite Element Method CIVL L Introduction to Finite Element Method CIVL L Introduction to Finite Element Method by Joe Gattas, Faris Albermani Introduction The FEM is a numerical technique for solving physical problems such

More information

Institut de Recherche MAthématique de Rennes

Institut de Recherche MAthématique de Rennes LMS Durham Symposium: Computational methods for wave propagation in direct scattering. - July, Durham, UK The hp version of the Weighted Regularization Method for Maxwell Equations Martin COSTABEL & Monique

More information

Lecture 21: Isoparametric Formulation of Plane Elements.

Lecture 21: Isoparametric Formulation of Plane Elements. 6.6. Rectangular Plane Stress/Strain Element. he CS element uses a triangular shape. he 3 nodes of the CS element allow us to employ linear multivariate approximations to the u and v displacements. he

More information

Gauss Legendre quadrature over a parabolic region

Gauss Legendre quadrature over a parabolic region Gauss Legendre quadrature over a parabolic region K. T. Shivaram Department of Mathematics, Dayananda sagar college of Engineering, Bangalore, India Abstract In this paper, we introduce a Gauss Legendre

More information

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

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

Brief Review of Vector Algebra

Brief Review of Vector Algebra APPENDIX Brief Review of Vector Algebra A.0 Introduction Vector algebra is used extensively in computational mechanics. The student must thus understand the concepts associated with this subject. The current

More information

Truss Structures: The Direct Stiffness Method

Truss Structures: The Direct Stiffness Method . Truss Structures: The Companies, CHAPTER Truss Structures: The Direct Stiffness Method. INTRODUCTION The simple line elements discussed in Chapter introduced the concepts of nodes, nodal displacements,

More information

ENGI 4430 Advanced Calculus for Engineering Faculty of Engineering and Applied Science Problem Set 3 Solutions [Multiple Integration; Lines of Force]

ENGI 4430 Advanced Calculus for Engineering Faculty of Engineering and Applied Science Problem Set 3 Solutions [Multiple Integration; Lines of Force] ENGI 44 Advanced Calculus for Engineering Facult of Engineering and Applied Science Problem Set Solutions [Multiple Integration; Lines of Force]. Evaluate D da over the triangular region D that is bounded

More information

Elementary Linear Algebra

Elementary Linear Algebra Matrices J MUSCAT Elementary Linear Algebra Matrices Definition Dr J Muscat 2002 A matrix is a rectangular array of numbers, arranged in rows and columns a a 2 a 3 a n a 2 a 22 a 23 a 2n A = a m a mn We

More information

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015 Multiple Integrals and Vector Calculus (Oxford Physics) Ramin Golestanian Synopsis and Problem Sets; Hilary 215 The outline of the material, which will be covered in 14 lectures, is as follows: 1. Introduction

More information

MAE 323: Chapter 6. Structural Models

MAE 323: Chapter 6. Structural Models Common element types for structural analyis: oplane stress/strain, Axisymmetric obeam, truss,spring oplate/shell elements o3d solid ospecial: Usually used for contact or other constraints What you need

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

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

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

Numerical interpolation, extrapolation and fi tting of data

Numerical interpolation, extrapolation and fi tting of data Chapter 6 Numerical interpolation, extrapolation and fi tting of data 6.1 Introduction Numerical interpolation and extrapolation is perhaps one of the most used tools in numerical applications to physics.

More information

B553 Lecture 5: Matrix Algebra Review

B553 Lecture 5: Matrix Algebra Review B553 Lecture 5: Matrix Algebra Review Kris Hauser January 19, 2012 We have seen in prior lectures how vectors represent points in R n and gradients of functions. Matrices represent linear transformations

More information

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes).

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes). CE 025 - Lecture 6 LECTURE 6 GAUSS QUADRATURE In general for ewton-cotes (equispaced interpolation points/ data points/ integration points/ nodes). x E x S fx dx hw' o f o + w' f + + w' f + E 84 f 0 f

More information

Efficient hp-finite elements

Efficient hp-finite elements Efficient hp-finite elements Ammon Washburn July 31, 2015 Abstract Ways to make an hp-finite element method efficient are presented. Standard FEMs and hp-fems with their various strengths and weaknesses

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 13

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 13 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras (Refer Slide Time: 00:25) Module - 01 Lecture - 13 In the last class, we have seen how

More information

Back Matter Index The McGraw Hill Companies, 2004

Back Matter Index The McGraw Hill Companies, 2004 INDEX A Absolute viscosity, 294 Active zone, 468 Adjoint, 452 Admissible functions, 132 Air, 294 ALGOR, 12 Amplitude, 389, 391 Amplitude ratio, 396 ANSYS, 12 Applications fluid mechanics, 293 326. See

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Spring Exam 3 Review Solutions Exercise. We utilize the general solution to the Dirichlet problem in rectangle given in the textbook on page 68. In the notation used there

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

Chapter 2 Convergence

Chapter 2 Convergence Chapter 2 Convergence The usage of computational electromagnetics in engineering and science more or less always originates from a physical situation that features a particular problem. Here, some examples

More information

Lecture Notes, Finite Element Analysis, J.E. Akin, Rice University

Lecture Notes, Finite Element Analysis, J.E. Akin, Rice University 3. Elasticity... 3. Introduction... 3.2 Linear springs... 4 3.3 Mechanical Work... 6 3.5 Strain energy... 9 3.6 Material properties... 3.7 Simplified elasticity models*... 2 3.8 Interpolating displacement

More information

Slow Growth for Gauss Legendre Sparse Grids

Slow Growth for Gauss Legendre Sparse Grids Slow Growth for Gauss Legendre Sparse Grids John Burkardt, Clayton Webster April 4, 2014 Abstract A sparse grid for multidimensional quadrature can be constructed from products of 1D rules. For multidimensional

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

A technique for DDA seed shifting and scaling

A technique for DDA seed shifting and scaling A technique for DDA seed shifting and scaling John Kerl Feb 8, 2001 Abstract This paper describes a simple, unified technique for DDA seed shifting and scaling. As well, the terms DDA, seed, shifting and

More information

Method of Finite Elements I

Method of Finite Elements I Method of Finite Elements I PhD Candidate - Charilaos Mylonas HIL H33.1 and Boundary Conditions, 26 March, 2018 Institute of Structural Engineering Method of Finite Elements I 1 Outline 1 2 Penalty method

More information

Analytical Mechanics: Elastic Deformation

Analytical Mechanics: Elastic Deformation Analytical Mechanics: Elastic Deformation Shinichi Hirai Dept. Robotics, Ritsumeikan Univ. Shinichi Hirai (Dept. Robotics, Ritsumeikan Univ.) Analytical Mechanics: Elastic Deformation 1 / 60 Agenda Agenda

More information

Chapter 3 Numerical Methods

Chapter 3 Numerical Methods Chapter 3 Numerical Methods Part 2 3.2 Systems of Equations 3.3 Nonlinear and Constrained Optimization 1 Outline 3.2 Systems of Equations 3.3 Nonlinear and Constrained Optimization Summary 2 Outline 3.2

More information

Lectures 9-10: Polynomial and piecewise polynomial interpolation

Lectures 9-10: Polynomial and piecewise polynomial interpolation Lectures 9-1: Polynomial and piecewise polynomial interpolation Let f be a function, which is only known at the nodes x 1, x,, x n, ie, all we know about the function f are its values y j = f(x j ), j

More information

Chapter 11 Three-Dimensional Stress Analysis. Chapter 11 Three-Dimensional Stress Analysis

Chapter 11 Three-Dimensional Stress Analysis. Chapter 11 Three-Dimensional Stress Analysis CIVL 7/87 Chapter - /39 Chapter Learning Objectives To introduce concepts of three-dimensional stress and strain. To develop the tetrahedral solid-element stiffness matri. To describe how bod and surface

More information

Multiple Integrals and Vector Calculus: Synopsis

Multiple Integrals and Vector Calculus: Synopsis Multiple Integrals and Vector Calculus: Synopsis Hilary Term 28: 14 lectures. Steve Rawlings. 1. Vectors - recap of basic principles. Things which are (and are not) vectors. Differentiation and integration

More information

8 th Grade Essential Learnings

8 th Grade Essential Learnings 8 th Grade Essential Learnings Subject: Math Grade/Course: 8 th Grade AG1 EL # Ex 1 Essential Learning Benchmark (framed by Standard) Learning Goal Topic (Report Card) NCTM Focal Points (Grade Level and/or

More information

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 1 x 2. x n 8 (4) 3 4 2

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 1 x 2. x n 8 (4) 3 4 2 MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS SYSTEMS OF EQUATIONS AND MATRICES Representation of a linear system The general system of m equations in n unknowns can be written a x + a 2 x 2 + + a n x n b a

More information

MATH Topics in Applied Mathematics Lecture 2-6: Isomorphism. Linear independence (revisited).

MATH Topics in Applied Mathematics Lecture 2-6: Isomorphism. Linear independence (revisited). MATH 311-504 Topics in Applied Mathematics Lecture 2-6: Isomorphism. Linear independence (revisited). Definition. A mapping f : V 1 V 2 is one-to-one if it maps different elements from V 1 to different

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

CHAPTER 3 Further properties of splines and B-splines

CHAPTER 3 Further properties of splines and B-splines CHAPTER 3 Further properties of splines and B-splines In Chapter 2 we established some of the most elementary properties of B-splines. In this chapter our focus is on the question What kind of functions

More information

42. Change of Variables: The Jacobian

42. Change of Variables: The Jacobian . Change of Variables: The Jacobian It is common to change the variable(s) of integration, the main goal being to rewrite a complicated integrand into a simpler equivalent form. However, in doing so, the

More information

BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I

BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I 635 8 54. Third Year M E C H A NICAL VI S E M ES TER QUE S T I ON B ANK Subject: ME 6 603 FIN I T E E LE ME N T A N A L YSIS UNI T - I INTRODUCTION

More information

49. Green s Theorem. The following table will help you plan your calculation accordingly. C is a simple closed loop 0 Use Green s Theorem

49. Green s Theorem. The following table will help you plan your calculation accordingly. C is a simple closed loop 0 Use Green s Theorem 49. Green s Theorem Let F(x, y) = M(x, y), N(x, y) be a vector field in, and suppose is a path that starts and ends at the same point such that it does not cross itself. Such a path is called a simple

More information

Numerical Modelling in Geosciences

Numerical Modelling in Geosciences Numerical Modelling in Geosciences Dave A. May (ETHZ) dave.may@erdw.ethz.ch Laetitia Le Pourhiet (UPMC) Jonas Ruh (UPMC) Liang Zheng (ETHZ) Zooming In between Plates (FP7 64713) ZIP WP5.1 Short-course

More information

Polynomials and Rational Functions (2.1) The shape of the graph of a polynomial function is related to the degree of the polynomial

Polynomials and Rational Functions (2.1) The shape of the graph of a polynomial function is related to the degree of the polynomial Polynomials and Rational Functions (2.1) The shape of the graph of a polynomial function is related to the degree of the polynomial Shapes of Polynomials Look at the shape of the odd degree polynomials

More information