Finite Element Lectures
Finite Element Lectures
1. INTRODUCTION:
. The finite element method is a numerical method for solving problems of engineering and
mathematical physics.
Typical problem areas of interest:
. Structural analysis, heat transfer, fluid flow, mass transport, and Electromagnetic
potential
. Useful for problems with complicated geometries, loadings, and material properties where
analytical solutions can not be obtained.
. The finite element formulation of the problem results in a system of simultaneous
algebraic equations for solution, rather than requiring the solution of differential equations.
. Process of modeling a body by dividing it into an equivalent system of smaller bodies or
units (finite elements) interconnected at points common to two or more elements (nodal
points or nodes) and/or boundary lines and/or surfaces is called discretization.
. The solution for structural problems typically refers to determining the displacements at
each node and the stresses within each element making up the structure that is subjected
to applied loads.
. In nonstructural problems, the nodal unknowns may, for instance, be temperatures or
fluid pressures due to thermal or fluid fluxes.
Contd
Brief History:
Mechanical/Aerospace/Civil/Automotive
Engineering
Structural/Stress Analysis
Static/Dynamic
Linear/Nonlinear
Fluid Flow
Heat Transfer
Electromagnetic Fields
Soil Mechanics
Acoustics
Biomechanics
1. Discretization:
The first step involves dividing the body into an equivalent system of finite elements with
associated nodes and choosing the most appropriate element type to model most closely the
actual physical behavior.
Model body by dividing it into an equivalent system of many smaller bodies or units (finite
elements) interconnected at points common to two or more elements (nodes or nodal
points) and/or boundary lines and/or surfaces.
Contd
Feature
Obtain a set of algebraic equations to solve for unknown (first) nodal quantity
(displacement).
Secondary quantities (stresses and strains) are expressed in terms of nodal values of
primary quantity.
Types of Elements:
The primary line elements consist of bar (or truss) and beam elements (1D). They have a
cross-sectional area but are usually represented by line segments. In general, the crosssectional area within the element can vary, but it will be considered to be constant for the
sake of this section.
These elements are often used to model trusses and frame structures. The simplest line
element (called a linear element) has two nodes, one at each end.
The basic two-dimensional (or plane) elements are loaded by forces in their own plane
(plane stress or plane strain conditions). They are triangular or quadrilateral elements.
The simplest two-dimensional elements have corner nodes only (linear elements) with
straight sides or boundaries The elements can have variable thicknesses throughout or be
constant.
The most common three-dimensional elements are tetrahedral and hexahedral (or
brick) elements; they are used when it becomes necessary to perform a threedimensional stress analysis. The basic three-dimensional elements have corner nodes
only and straight sides.
Principles of FEA:
The finite element method (FEM), or finite element analysis
(FEA), is a Computational technique used to obtain approximate
solutions of boundary value problems in engineering.
Boundary value problems are also called field problems. The field
is the domain of interest and most often represents a physical
structure.
The field variables are the dependent variables of interest governed
by the differential equation.
The boundary conditions are the specified values of the field
variables (or related variables such as derivatives) on the
boundaries of the field.
For simplicity, at this point, we assume a two-dimensional case
with a single field variable (x, y) to be determined at every point
P(x, y) such that a known governing equation (or equations) is
satisfied exactly at every such point.
PHYSICAL FEM:
The processes of idealization and discretization are carried out concurrently to
produce the discrete model.
Indeed FEM discretization may be constructed and adjusted without reference
to mathematical models, simply from experimental measurements.
The concept of error arises in the physical FEM in two ways, known as
verification and validation.
Verification is the same as in the Mathematical FEM: the discrete solution is
replaced into the discrete model to get the solution error. As noted above, this
error is not generally important.
Validation tries to compare the discrete solution against observation by
computing the simulation error, which combines modeling and solution errors.
Since the latter is typically insignificant, the simulation error in practice can be
identified with the modeling error.
Comparing the discrete solution with the ideal physical system would in
principle quantify the modeling errors.
Introduction:
Contd
Basic premise of the finite element method is to describe the continuous
variation of the field variable (physical displacement) in terms of discrete
values at the finite element nodes. In the interior of a finite element, as well as
along the boundaries (applicable to two- and three-dimensional problems), the
field variable is described via interpolation functions that must satisfy
prescribed conditions.
As introduction we present several such principles applicable to finite element
analysis. First, and foremost, for spring and bar systems, we utilize the
principle of static equilibrium butand this is essentialwe include
deformation in the development; that is, we are not dealing with rigid body
mechanics.
For extension of the finite element method to more complicated elastic structural
systems, we also state and apply the first theorem of Castiglianos and the more
widely used principle of minimum potential energy .
Both theorems relate displacements and applied forces to the equilibrium
conditions of a mechanical system in terms of mechanical energy.
Introduction:
The direct equilibrium approach, will be used to derive the stiffness matrix for a
one-dimensional linear springthat is, a spring that obeys Hookes law and
resists forces only in the direction of the spring.
Reference points 1 and 2 are located at the ends of the element. These reference
points are called the nodes of the spring element.
The local nodal forces are f1x and f2x for the spring element associated with the
local axis x. The local axis acts in the direction of the spring so that we can
directly measure displacements and forces along the spring.
The local nodal displacements are d1x and d2x for the spring element. These nodal
displacements are called the degrees of freedom at each node. Positive directions
for the forces and displacements at each node are taken in the positive x direction
as shown from node 1 to node 2 in the figure.
The symbol k is called the spring constant or stiffness of the spring.
Contd
know that a prismatic uniaxial bar has a spring constant , where A represents
We
the cross-sectional
area of the bar, E is the modulus of elasticity, and L is the bar
length.
Similarly, we know that a prismatic circular cross- section bar in torsion has a
spring constant , where J is the polar moment of inertia and G is the shear
modulus of the material.
For one-dimensional heat conduction, , where K xx is the thermal conductivity of
the material.
And for one- dimensional fluid flow through a porous medium, the stiffness ,
where Kxx is the permeability coefficient of the material.
Observe that the stiffness method can be applied to nonstructural problems, such
as heat transfer, fluid flow, and electrical networks, as well as structural
problems by simply applying the proper constitutive law (such as Hookes law
for structural problems, Fouriers law for heat transfer, Darcys law for fluid
flow and Ohms law for electrical networks) and a conservation principle such
as nodal equilibrium or conservation of energy.
In general, the total number of coefficients a is equal to the total number of degrees of
freedom associated with the element. Here the total number of degrees of freedom is two
an axial displacement at each of the two nodes of the element In matrix form,
becomes:
Contd
Where :
Contd
N1 and N2 are called the shape functions because the Nis express the shape of
the assumed displacement function over the domain (x coordinate) of the
element when the ith element degree of freedom has unit value and all other
degrees of freedom are zero.
In this case, N1 and N2 are linear functions that have the properties that N 1= 1 at
node 1 and N1 = 0 at node 2, whereas N2 = 1 at node 2 and N2 =0 at node 1.
Also, N1 + N2 =1 for any axial coordinate along the bar.
In addition, the Nis are often called interpolation functions because we are
interpolating to find the value of a function between given nodal values.
Fig. (a) Spring element showing plots of (b) displacement function u and
Shape functions (c) N1 and (d) N2 over domain of element
For a spring element, we can relate the force in the spring directly to the
deformation. Therefore, the strain/displacement relationship is not necessary
here.
The stress/strain relationship can be expressed in terms of the force/deformation
relationship instead as:
or
Here k is called the local stiffness matrix for the element. We observe from that k
is a symmetric (that is, kij = kji square matrix (the number of rows equals the
number of columns in k).
The main diagonal of the stiffness matrix is always positive. Otherwise, a positive
nodal force Fi could produce a negative displacement dia behavior contrary to
the physical behavior of any actual structure.
where k and f are now element stiffness and force matrices expressed in a global
reference frame. (the sign used in this context does not imply a simple summation
of element matrices but rather denotes that these element matrices must be
assembled properly according to the direct stiffness method.
6: Solve for the Nodal Displacements
The displacements are then determined by imposing boundary conditions, such
as support conditions, and solving a system of equations, F = Kd,
simultaneously.
7 :Solve for the Element Forces
Finally, the element forces are determined by back-substitution, applied to each
element, into equations
Contd
Fig. A bar (or truss) element with element coordinate system and nodal displacement
notation.
Contd
To determine the interpolation functions, we require that the boundary values of
u(x ) (the nodal displacements) be identically satisfied by the discretization
such that:
This lead to the following boundary (nodal) conditions:
As we have two conditions that must be satisfied by each of two onedimensional functions, the simplest forms for the interpolation functions are
polynomial forms:
Application of conditions represented by the previous Equation above yields a0
= 1, b0 = 0 while Equation above results in a1 = (1/L) and b1 = x/L. Therefore,
the interpolation functions are
And the continuous displacement function is represented by the discretization
Contd
The task remains to determine the relation between the nodal displacements and
applied forces to obtain the stiffness matrix for the bar element.
Recall from elementary strength of materials that the deflection of an elastic bar
of length L and uniform cross-sectional area A when subjected to axial load P is
given by:
where E is the modulus of elasticity of the material. Using the above Equation,
we obtain the equivalent spring constant of an elastic bar as.
Contd.
which shows that the spar element is a constant strain element. This is in accord
with strength of materials theory: The element has constant cross-sectional area
and is subjected to constant forces at the end points, so the strain does not vary
along the length. The axial stress, by Hookes law, is then
Lets now use it to relate the applied nodal forces f1 and f2 to the nodal
displacements u1 and u2.
Contd
The equations are expressed in matrix form as:
As is the case with the linear spring, we observe that the element stiffness matrix
for the bar element is symmetric, singular, and of order 2 2 in correspondence
with two nodal displacements or degrees of freedom.
It must be emphasized that the stiffness matrix given by the Equation above is
expressed in the element coordinate system, which in this case is onedimensional. Application of this element formulation to analysis of two- and
three-dimensional structures is considered in the next Topics.
Contd.
We will now relate i and j to i and j through use of the following Figure:
Contd
This yields :
Similarly:
So from
In matrix form:
Where:
Contd.
We will now use the transformation relationship to obtain the global stiffness
matrix for a bar element in truss. We need the global stiffness matrix of each
element to assemble the total global stiffness matrix of the structure.
We have shown that for a bar element in the local coordinate system,
We now want to relate the global element nodal forces f to the global nodal
displacements d for a bar element arbitrarily oriented with respect to the global
axes as was shown in Figure above. This relationship will yield the global
stiffness matrix k of the element. That is, we want to find a matrix k such that
Contd
where:
Contd
However, to write the final expression relating global nodal forces to global
nodal displacements for an element, we must invert T. This is not immediately
possible because T is not a square matrix. Therefore, we must expand d, f , and
k to the order that is consistent with the use of global coordinates even though
f1y and f2y are zero. Using vector transformation for each nodal displacement,
we thus obtain
Or
where:
Similarly we can write
Contd
Because f 1y and f 2y are zero, rows of zeros corresponding to the row numbers
f1y and f 2y appear in k.
Finally we obtain:
Solving for f:
where T-1 is the inverse of T. but it can be shown that T-1 is equal to TT .
where TT is the transpose of T. (Property of orthogonal Matrix)
Contd
Equating equations
and
The stiffness matrix and force matrix for each element can be summed by using
the direct stiffness method to obtain
K now relates the global nodal forces F to the global nodal displacements d for
the whole structure by:
For a bar, the local forces are related to the local displacements by the following
equation. This equation is repeated here for convenience.
The usual definition of axial tensile stress is axial force divided by crosssectional area. Therefore, axial stress is:
where f2x is used because it is the axial force that pulls on the bar.
In simpler form
where:
Contd
From basic calculus, the radius of curvature of a planar curve is given by:
Contd
such that the normal strain in the direction of the longitudinal axis as a result of
bending is:
where E is the modulus of elasticity of the beam material. Equation above shows
that, at a given cross section, the normal stress varies linearly with distance from
the neutral surface.
As no net axial force is acting on the beam cross section, the resultant force of the
stress distribution given by Equation above must be zero. Therefore, at any axial
position x along the length, we have:
Noting that at an arbitrary cross section the curvature is constant, Equation above
gives:
Contd
The above equation is satisfied if the xz plane (y = 0) passes through the centroid
of the area. Thus, we obtain the well-known result that the neutral surface is
perpendicular to the plane of bending and passes through the centroid of the
cross-sectional area.
Similarly, the internal bending moment at a cross section must be equivalent to
the resultant moment of the normal stress distribution, so
The integral term in the above equation represents the moment of inertia (I z ) of
the cross sectional area about the z axis, so the bending moment expression
becomes:
In the above equation as per the sign convention compressive (negative) and
tensile (positive) stress values are obtained correctly depending on the sign of the
y location value.
B. Beam stiffness
effects.
This bending deformation is measured as a transverse displacement and a
rotation. Hence, the degrees of freedom considered per node are a transverse
displacement and a rotation.
Consider the beam element shown in Figure below. The beam is of length L with
axial local coordinate and transverse local coordinate . The local transverse
nodal displacements are given by s and the rotations by s. The local nodal
forces are given by s and the bending moments by s as shown. We initially
neglect all axial effects.
2. Rotations
The differential equation is derived as follows. Consider the beam shown in Figure below
subjected to a distributed loading (force/length). From force and moment equilibrium of a
differential element of the beam, shown in the next Figure (c),we have:
The final form of the above equation relating the shear force to the bending
moment, is obtained by dividing the left equation by and then taking the limit of
the equation as approaches 0. The term then disappears.
Contd
Also, the curvature k of the beam is related to the moment by
where r is the radius of the deflected curve shown in Figure above (b), is the
transverse displacement function in the direction, E is the modulus of elasticity,
and I is the principal moment of inertia about theaxis.
The curvature for small slopes:
is given by:
Combining the above two equations:
Solving Eq. above for M and substituting this result into the shear force and the
distributed load equations found earlier we obtain.
For constant EI and only nodal forces and moments, the above equation becomes:
Now we will use the above equation to develop a stiffness matrix in direct method
just like we did for trusses and bars.
the beam by labeling nodes at each end and in general by labeling the
Represent
element number
(figure).
Contd..
where
for the assumed small rotation . Solving the above equations for
a1 through a4 in terms of the nodal degrees of freedom and substituting into the
transverse displacement equation we have:
Contd
In matrix form:
N1, N2, N3, and N4 are called the shape functions for a beam element. These
cubic shape (or interpolation) functions are known as Hermite cubic
interpolation (or cubic spline) functions.
where we should recall from elementary beam theory the basic assumption that
cross sections of the beam (such as cross section ABCD) that are planar before
bending deformation remain planar after deformation. and, in general, rotate
through a small angle
Contd
From elementary beam theory, the bending moment and shear force are related
to the transverse displacement function. Because we will use these relationships
in the derivation of the beam element stiffness matrix, we now present them as
Contd
Where the minus signs in the second and third of (the above equations) are the
result of opposite nodal and beam theory positive bending moment
conventions. In matrix form, the above equation becomes:
Note :This method doesnt include the effect of transverse axial shear deflections.
Castiglione's method for finding beam and frame deflections is a convenient
way to include the effects of the transverse shear term. E.g (Timoshenko beam)
Goal
is to ensure equivalent loads produce same strain energy
2
3
N1 ( x) 3 x 3 2 x 2 1
L
L
1
2
N 2 ( x) 2 x 3 x 2 x
L
L
2
3
N 3 ( x) 3 x 3 2 x 2
L
L
1
1
N 4 ( x) 2 x 3 x 2
L
L
W v ( x )qdx q v ( x ) dx
0
W q N 1 ( x )v1 N 2 ( x )1 N 3 ( x )v 2 N 4 ( x ) 2 dx
0
W q N 1 ( x ) v1dx q N 2 ( x )1 dx q N 3 ( x )v2 dx q N 4 ( x ) 2 dx
0
W q v1 N 1 ( x ) dx 1 N 2 ( x ) dx v2 N 3 ( x ) dx 2 N 4 ( x ) dx
0
0
0
0
L
1
L
1
W qL v1 1 v 2 2
12
2
12
2
L
F
M
L
1
L
1
qL v1 1 v 2 2
12
2
12
2
F
M
In the same way one can use the work equivalence method to analyze other type
of loadings.
General Formulation:
where F are the concentrated nodal forces and F o are called the equivalent nodal
forces,
Assume that concentrated nodal forces are not present , as we are solving beam
problems with distributed loading only.
For a uniformly distributed load w acting over a one-element beam, we have:
From the figure we can see that only a displacement in the direction of local
coordinate exists so we take only the second term in equation of the
transformation matrix and expand it to a three degree of freedom equation at each
node.
Contd
Where :
elements
Note:- Here the axial effect is not yet included. And that rotation is invariant with
respect to either coordinate system. For example, rotation , and moment
Recall a stiffness matrix for beam element in elemental coordinate system was
found earlier to be:
Contd
The above stiffness matrix is for beam element that includes shear and bending
resistance. Local axial effects are not yet included.
The element now has three degrees of freedom per each node.
Recall for axial loading of on bars:
Contd
Combining
we have. the axial loading, the shear and bending moment in local coordinate
The matrix in Eq. above now has three degrees of freedom per node and it
includes axial effects (in the direction), as well as shear force effects (in the
direction) and principal bending moment effects (about the axis).
Contd..
Next step is to relate the local displacement to the global by the transformation
matrix with 3 degrees of freedom at each node.
Contd
we obtain the general transformed global stiffness matrix for a beam element
that includes axial force, shear force, and bending moment effects as follows:
CHAPTER THREE:
Contd
Contd..
Contd
Contd..
Contd
Once the nodal displacements are determined these stress can be evaluated directly
Contd
Contd
Contd
Contd
Contd
Contd.
Contd
Contd
Contd..
Contd
Contd
Contd
Contd
Contd
Contd
Contd
Contd
Contd
Contd
Contd
Contd..
3.2 Rectangular plane stress Element:
Two advantages of the rectangular element over the triangular element are :
Ease of data input and
simpler interpretation of output stresses.
A disadvantage of the rectangular element is that the
simple linear-displacement rectangle with its associated straight sides poorly
approximates the real boundary condition edges.
Consider the rectangular element shown in Figure below (all interior angles are
90o)with corner nodes 14 (again labeled counterclockwise) and base and height
dimensions2b and 2h, respectively.
Contd
Contd
In terms of the shape functions and unknown nodal displacements:
And the Nis are again such that N1 = 1 at node 1 and N1 = 0 at all the other nodes, with
similar requirements for the other shape functions. In expanded form,
Contd
Step 3: Define the Strain/Displacement and Stress/Strain Relationships
Again the element strains for the two-dimensional stress state are given by
Using the interpolation function Eq. (in the above equation) and taking the
derivatives of u and v as indicated, we can express the strains in terms of the
unknown nodal displacements as
Contd
with [D]again given by the usual plane stress or plane strain conditions, of the
equation in chapter. Because the [B] matrix is a function of x and y, integration
must be performed. The [k] matrix for the rectangular element is now of order
8x 8. The element force matrix is determined by:
Contd
where [N] is the rectangular matrix of the shape functions N 1 through N4. The
element equations are then given by:
Steps 57
Steps 57, which involve assembling the global stiffness matrix and equations,
determining the unknown nodal displacements, and calculating the stress, are
identical to those in chapter 3 for the Constant strain triangular element.
Chapter Four
Contd
Contd
The element displacement functions u; v, and w must be linear along each edge
In the same manner as in 2D, we can express the a is in terms of the known
nodal coordinates (x1, y1, z1,. . . , z4) and the unknown nodal displacements (u1,
v1, w1,. . . w4) of the element. Skipping the straight forward but tedious details,
we obtain
Contd..
and V represents the volume of the tetrahedron. The coefficients 1,1, 1, and
i (i=1, 2, 3,4) are given by:
Contd
Contd.
Expressions for v and w are obtained by simply substituting vis for all uis and then
wis for all uis.
The displacement expression for u with similar expressions for v and w, can be
written equivalently in expanded form in terms of the shape functions and unknown
nodal displacements as
Contd
Step 3 : Define the Strain / Displacement and Stress / Strain Relationships
The element strains for the three-dimensional stress state are given by:
Contd
where, again, the comma after the subscript indicates differentiation with respect to
the variable that follows. Sub matrices B2; B3, and B4 are defined by simply
indexing the subscript in the above equation from 1 to 2, 3, and then 4, respectively.
Substituting the shape functions, B1 is expressed as:
Contd
Because both matrices [B] and [D] are constant for the simple tetrahedral element
where, again, V is the volume of the element. The element stiffness matrix is
now of order 12 x 12.
Body Forces:
The element body force matrix is given by
Contd
For constant body forces, the nodal components of the total resultant body forces
can be shown to be distributed to the nodes in four equal parts. That is,
Surface Forces:
Again, the surface forces are given by:
For example, consider the case of uniform pressure p acting on the face with
nodes 13; The resulting nodal forces become:
Contd.
Contd
The function use to describe the element geometry for x in terms of the generalized
degrees of freedom ais is:
The same form as the above equation is used for y and z as well. Just start with
a9 through a16 for y and a17 through a24 for z.
Now , we expand equation used in 2D to include the z coordinate as follows:
Contd
when, s1 = 1, t1 = 1, and z1 = +1 are used in the above equation we obtain:
Then evaluating all shape functions at node 8, we obtain N 8 = 1, and all other
shape functions equal zero at node 8. we see that N 1 = 0 when s = 1or when t = 1
Where:
Ein : is the energy entering the control volume, in units of joules (J)
U: is the change in stored energy, in units of kW h (kWh)
qx: is the heat conducted (heat flux) into the control volume at surface
edge x, in units of kW/m2
qx+dx : is the heat conducted out of the control volume at the surface edge x+dx.
t is time, in h or s.
Q : is the internal heat source (heat generated per unit time per unit volume is positive), in
kW/m3; (a heat sink, heat drawn out of the volume, is negative).
A: is the cross-sectional area perpendicular to heat flow q, in m 2
where
Kxx: is the thermal conductivity in the x direction, in kW/(m0C).
T: is the temperature, in 0 C.
Contd
where c is the specific heat in kW h/(kg 0 C)), and is the mass density in kg/m3.
simplifying, we have the one-dimensional heat conduction equation as:
For steady state, any differentiation with respect to time is equal to zero:
All terms have the same meaning as in previous, except the heat flow by
convective heat transfer is given by Newtons law of cooling:
Contd
we have:
are again the same shape functions as used for the bar element. The [N] matrix
is then given by
Contd
using the fact that the nodal temperatures {t} are independent of the general
coordinates x and y and can therefore be taken outside the integrals, we have
Contd
where the last term (hT)is a constant that drops out while minimizing .
Simplifying:
Contd
The first term {fQ}(heat source positive, sink negative) is of the same form as
the body-force term, and the second term {fq}(heat flux, positive into the
surface) and third term {fh}(heat transfer or convection) are similar to surface
tractions (distributed loading) in the stress analysis problem.
we have the element conduction matrix* for the heat-transfer problem:
where the first and second integrals are the contributions of conduction and
convection, respectively. for each element, we have:
The conduction part of the [k] matrix for the one-dimensional element becomes:
Contd
Contd
h is zero on the boundary of an element, the second term on the right side
When
(convection
portion of [k]) is zero. This corresponds, for instance, to an
insulated boundary.
The force matrix terms, on simplifying and assuming Q, q, and product hT to be
constant are:
Contd
equation above indicates that one-half of the assumed uniform heat source
The
Q goes
to each node, one-half of the prescribed uniform heat flux q (positive q
enters the body) goes to each node, and one-half of the convection from the
perimeter surface hT goes to each node of an element.
Finally, we must consider the convection from the free end of an element. For
simplicitys sake, we will assume convection occurs only from the right end of
the element, as shown:
The additional convection term contribution to the stiffness matrix is given by:
Contd
The convection force from the free end of the element is evaluated with the
shape functions now evaluated at the right end (where convection occurs) and
with S3 (the surface over which convection occurs) now equal to the crosssectional area A of the rod. Hence,
represents the convective force from the right end of an element where N 1(x=L)
represents N1 evaluated at x=L, and so on.
Step 5 : Assemble the Element Equations to Obtain the Global Equations and
Introduce Boundary Conditions
Contd
Contd