Introduction To FEM
Introduction To FEM
2
Introduction
• It is originated in the aerospace industry as a tool to study stresses in
complex air- frame structure.
• It is numerical technique for obtaining approximate solution to a wide
variety of engineering problem.
• Analytical methods provide accurate solution with applications limited to
simple geometries.
• Experimental methods are used to test prototypes or full scale models.
• And they are costly and may not be feasible in some cases.
• But Numerical methods are most efficient technique for engineering
analysis which can treat complex geometries also.
3
• Historical Background
12
• Depending on the type of physical problem being analyzed, the field
variables may include physical displacement, temperature, heat flux, fluid
velocity, etc.
• FEM allows for descretizing the intricate geometries in to small fundamental
volumes called finite elements.
• It is then possible to write the governing equations & material properties for
these elements &this will be in terms of unknown values at points called
nodes.
• These equations are then assembled by taking proper care to loads &
constraints which results in a set of equation which are to be solved & the
results describe the behavior of the original complex body being analyzed.
The solution to these equations would provide an exact closed form solution
to the particular problem being studied.
13
Why Finite Element Method?
20
Advantages of FEM
Increase productivity (reduce uncertainty)
Minimize physical prototyping (optimize performance before
prototyping)
Innovative products in less time & less costs (reduced testing and
redesign costs thereby shortening the product development time)
Applicable to linear and non linear problem
Easily applied to complex, irregular shaped objects composed of several
different materials and having complex boundary conditions
Applicable to steady state, time dependant and eigenvalue problems
One method can solve a wide variety of problems, including problems in
solid mechanics, chemical reaction, electromagnetics, biomechanics, heat
transfer and acoustics.
22
Eg. Stress Analysis
23
Disadvantages of FEM
Experience and judgment are needed in order to construct a good
finite element model
A powerful computer and reliable FEM software are essential.
Input and output data may be large and tedious to prepare and
interpret.
The FEM is applied to an approximation of the mathematical model
of a system(the source of so called inherited error)
Susceptible to user introduced modeling error:
1. poor choice of elements types
2. distorted elements
3. geometry not sufficiently modeled
24
Application of FEM in Engineering
FEM is not limited to mechanical system alone but to a range of engineering
problems such as
• Mechanical/Aerospace/Civil/Automobile Engineering
• Structure analysis (static/dynamic, linear/nonlinear)
• Stress analysis
• Dynamic analysis
• Deformation studies
• Thermal /Heat flow analysis
• Fluid flow analysis
• Electromagnetic / Magnetic flux studies
• Geo-mechanics
• Biomechanics 25
Available Commercial FEM Software Packages
• ANSYS (General purpose, PC and workstations)
26
BASIC STEPS IN THE FINITE ELEMENT METHOD
The basic steps involved in any finite element analysis consist of the following:
Preprocessing Phase
1. Create and discretize the solution domain into finite elements; that is, subdivide the problem into
nodes and elements.
2. Assume a shape function to represent the physical behavior of an element; that is, an approximate
continuous function is assumed to represent the solution of an element.
3. Develop equations for an element.
4. Assemble the elements to present the entire problem. Construct the global stiffness matrix.
5. Apply boundary conditions, initial conditions, and loading.
Solution Phase
6. Solve a set of linear or nonlinear algebraic equations simultaneously to obtain nodal results, such as
displacement values at different nodes or temperature values at different nodes in a heat transfer
problem.
Post processing Phase
7. Obtain other important information. At this point, you may be interested in values of principal
stresses, heat fluxes, etc.
27
In the finite element modeling process there are Six Steps
Step 3 - Assembly: The element equations for each element in the FEM
mesh are assembled into a set of global equations that model the
properties of the entire system.
28
The six steps…
Step 4 - Application of Boundary Conditions: Solution cannot be obtained unless
boundary conditions are applied. They reflect the known values for certain primary
unknowns. Imposing the boundary conditions modifies the global equations.
Step 5 - Solve for Primary Unknowns: The modified global equations are solved for the
primary unknowns (Elemental Displacements) at the nodes.
And this six steps, categorized in the FEA program to three main stages as follows:
29
FEM in Structural Analysis Procedures:
30
Computer Implementations
• Preprocessing (build FE model, loads and constraints)
31
Typical elements commonly used in finite Element analysis
• The type of elements to be used for generating the mesh depends upon the actual
geometry and the type of problem being considered. Some typical elements generally
found in most of the FE software are shown below
a) One dimensional
Linear quadratic
4 - Node linear
Quadratic
quadrilateral
33
35
Modeling recommendations
• Band width of matrix is the number of columns from first to the last non-zero column.
• The element band width = max. Difference between the largest and smallest node
Numbers of the element
12
14 21
40
Formulation of finite element problems
In general, there are several approaches to formulating finite element problems:
Again, it is important to note that the basic steps involved in any finite element
analysis, regardless of how we general the finite element model, will be tile same
as those listed above.
41
46
47
48
DIRECT FORMULATION
The following problem illustrates the steps and the
procedure involved in direct formulation.
50
DIRECT FORMULATION
EXAMPLE 1.0
Consider a bar with a variable cross section supporting a load P, as
shown in Figure 1.0 The bar is fixed at one end and carries the load P at
the other end. Let us designate the width of the bar at the top by w1, at
the bottom by w2, its thickness by t, and its length by L. The bar's
modulus of elasticity will be denoted by E. We are interested in
determining how much the bar will deflect at various points along its
length when it is subjected to the load P. We will neglect the weight of
the bar in the following analysis, assuming that the applied load is
considerably larger than the weight of the bar:
Figure 1.0 A bar under axial lodaing
Preprocessing Phase
1. Discretize the solution domain into finite elements.
The given bar is modeled using four individual segments,with
each segment having a uniform cross section.The cross-
sectional area of each element is represented by an average
area of the cross sections at the nodes that define the
element.This model is shown in Figure2.
Figure 2.0 Subdividing the bar in to elements and nodes
(6)
where the equivalent element stiffness is given
by
Keq = ( Ai +1 + Ai )
2l
E (7)
node2:kl(U2-Ul)-k2(u3-u2)=0 (8)
Node 1
K1(U2-U1)
K2(U3-U2)
node 5: k4(us-u4) – P = O
K3(U4-U3)
Node 4
K4(U5-U4)
Node 5
k1 − k1 0 0 0 u1 − R1
− k1 k1 + k 2 − k2 0 0 u2 0
0 − k2 k 2 + k3 − k3 0
u3 =
0
(10)
0 0 − k3 k3 + k 4 − k 4 u4 0
0 0 0 − k4 k4
u5
P
It is also important to distinguish between the reaction
forces and the applied loads in the load matrix.
Therefore, the matrix relation of Eq. (10) can be written
as:
− R1 k1 − k1 0 0 0 u1 0
0 − k1 k1 + k 2 − k2 0 0 u2 0
0 = 0 − k2 k 2 + k3 − k3 0 u3 − 0
(11)
0
0 0 − k 3 k 3 + k 4 − k 4 u4 0
0 0 0 0 − k4 k 4 u 5 P
We can readily show that under additional nodal loads and other fixed boundary
conditions, the relationship given by Eq. (11) can be put into the general form
{R} = [K] {u} – {F} (12)
which stands for:
{reaction matrix} = [stiffness matrix] {displacement matrix} - {load matrix}
fi
=
f
k eq − k eq ui
(15)
i+1 eq eq ui+1
− k k
Figure 5.0 Internally transmitted forces through an
arbitrary element.
k1 − k1 0 0 0
− k1
k1 0 0 0
[k ](1G ) = 0 0 0 0 0
0 0 0 0 0
0 0 0 0 0
0 0 0 0 0
0 0 0 0 0
[k ](3G ) = 0 0 k3 − k3 0
0 0 − k3 k3 0
0 0 0 0 0
k4 − k4
[k ]( 4) = and its position in the global matrix
− k 4 k 4
0 0 0 0 0
0 0 0 0 0
[k ](4G ) = 0 0 0 0 0
0 0 0 k 4 − k 4
0 0 0 − k 4 k 4
The final global stiffness matrix is obtained by assembling, or adding, together each
element's position in the global stiffness matrix:
k1 − k1 0 0 0
− k1
k1 + k 2 − k2 0 0
[k ](G ) = 0 − k2 k 2 + k3 − k3 0 (16)
0 0 − k3 k3 + k 4 − k 4
0 0 0 − k4 k 4
The gobal stiffness matrix obtained using elemental description is identical to the global
matrix we obtained earlier from the analysis of the FBD of the nodes, as given by the left
hand side of Eq. (10).
k − k2 3 845 − 845
[ k ] (2 ) = 2 = 10 − 845 845
− k 2 k 2
k3 − k3 3 715 − 715
[ k ] (3 ) = = 10 − 715 715
− k .3 k 3
k4 − k4 3 585 − 585
[k ] (4 )
= = 10 − 585 585
− k 4 k 4
Assembling the elemental matrices leads to the generation of the global stiffness matrix:
975 − 975 0 0 0
− 975 975 + 845 − 845 0 0
[k ](G ) 3
= 10 0 − 845 845 + 715 − 715 0
0 0 − 715 715 + 585 − 585
0 0 0 − 585 585
Applying the boundary condition u1 = 0 and the load P = 1000 lb, we get
1 0 0 0 0 u1
0
− 975 1820
− 845 0 0 u2
3 0
10 0 − 845 1560 − 715 0 u3 =
0
0 0 − 715 1300 − 585 u4 3
10
0 0 0 − 585 585 u 5
Because in the second row, the -975 coefficient gets multiplied by u1 = 0, we need only to
solve the following 4 x 4 matrix:
1820 − 845 0 0 u2 0
− 845 1560 − 715 0
u 3 0
10 3 =
0 − 715 1300 − 585 u4 0
0 0 − 585 585 u 5 10 3
Therfoer the displacement solution is: u1 = 0, u2 = 0.001026 in, u3 = 0.002210 in, u4 = 0.003608
in, and u5 = 0.005317 in.
Postprocessing Phase, Obtain other information.
For the given example 1.0, we may be interested in obtaining other information, such as the
average normal stresses in each element. These values can be determined from the equation
Aavg E
f (u − u ) (ui +1 − ui ) (ui +1 − ui )
σ= = k eq i +1 i = =E (19)
Aavg Aavg Aavg
Since the displacements of different nodes are known, Eq. (1.19) could have been obtained
directly from the relationship between the stresses and strains,
(ui +1 − ui ) (20)
σ = Eε = E
Employing Eq. (20) , we compute the average normal stress for each element is
σ (1)
=E
(u 2 − u1 )
=
(10.4 x 10 ) (0.001026 − 0) = 4268 b
6
2.5 in 2
(u 3 − u 2 )
σ (2 ) = E = 4925 b
in 2
(u 4 − u 3 )
σ (3 ) = E = 5816 b
in 2
(u 5 − u 4 )
σ (4 ) = E = 7109 b
in 2
f=p
f=p
y
P p
P
Figure 6.0 The internal forces
In the above figure, we note that for the given problem,
regardless of where we cut a section through the bar,
the internal force at the section is equal to 1000 lb. So,
f 1000
σ (1) = = = 4267 b 2
Aav 0.234375 in
f 1000
σ (2 ) = = = 4923 b 2
Aav 0.203125 in
f 1000
σ (3 ) = = = 5818 b 2
Aav 0.171875 in
f 1000
σ (4 ) = = = 7111 b 2
Aav 0.140625 in
Ignoring the errors we get from rounding off our answers, we find that these
results are identical to the element stresses computed from the displacement
information. This comparison tells us that our displacement calculations are
good for this problem.
Reaction Forces
For the above problem, the reaction force may be computed in a
number of ways. First, referring to Figure 4, we note that the statics
equilibrium at node 1 requires
R1 = k1 (u2 - ul) = 975 x 103(0.001026 - 0) = 1000 lb
The statics equilibrium for the entire bar also requires that
R1 =P = 1000lb
As you may recall, we can also compute the reaction forces from the
general reaction equation
{R} = [K]{u} - (F}
{reaction malrlx} = [stiffness matrix] {displacemenl matrix} -
{load matrix}
below
below
uU
Temperature effect
Temperature effect
Thank you
yishaktamiru777@gmail.com 88