0% found this document useful (0 votes)
90 views

C I V 5 0 3 Finite Element Analysis: DR Zubair Syed, Mieaust

This document provides an overview of a finite element analysis course. The course will cover 1) analyzing systems using the direct stiffness method, 2) developing weak forms, 3) using Galerkin and Rayleigh-Ritz methods, 4) solving 1D boundary value problems, 5) using beam and frame elements, 6) applying 2D elements, 7) determining stresses and strains, and 8) using software like MATLAB and ANSYS. The instructor is Dr. Zubair Syed and the contact details are provided. An outline of weekly topics is given along with required textbooks and assessment details.
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
90 views

C I V 5 0 3 Finite Element Analysis: DR Zubair Syed, Mieaust

This document provides an overview of a finite element analysis course. The course will cover 1) analyzing systems using the direct stiffness method, 2) developing weak forms, 3) using Galerkin and Rayleigh-Ritz methods, 4) solving 1D boundary value problems, 5) using beam and frame elements, 6) applying 2D elements, 7) determining stresses and strains, and 8) using software like MATLAB and ANSYS. The instructor is Dr. Zubair Syed and the contact details are provided. An outline of weekly topics is given along with required textbooks and assessment details.
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 57

CIV 503

F I N I T E E L E M E N T A N A LY S I S

Lecture 1

I N S T RU C TO R

D R Z U B A I R S Y E D, M I E a u s t .
EMAIL: [email protected] .AE
Course Learning Outcomes
At the end of this course, students should be able to:
1. Analyze a system using the direct stiffness method including discretization,
assembly, boundary conditions.
2. Develop the weak form for approximate solution of differential equations.
3. Use Glarekin and/or Rayleigh-Riz methods for approximate solution of
differential equations.
4. Solve one-dimensional BVP using finite element methods.
5. Form finite elements for standard beam and frame elements and solve
related structural problems
6. Apply standard two-dimensional elements for solution of typical FEA
problems such as 2D BVP
7. Determine stresses and strains in elastic solids and use isoparametric
elements for plane elasticity problems
8. Create finite element models using various software to analyze engineering
systems; examples such as MATLAB and ANSYS
CONTACT HOURS
Day Time Room
Wednesdays 6:30 pm – 10:00 pm B-G35

Contact Details
Email: [email protected]
Ph: 02 501 5871
Office Location: D 2F 251

Blackboard will be one of the main mode of


communication
Weekly Outline
Week Topic Chapter

Finite Element Method - The big picture: Finite element procedure, discretization,
1, 2 element equations, assembly, boundary conditions, solution of primary unknowns Chapter 1
and element quantities, reactions, solution validity.
Mathematical Foundation of the Finite Element Method: Weak form for
approximate solutions of differential equations, Galerkin method, approximate
3, 4 solutions using Rayleigh-Ritz method, comparison of Glarekin and Rayleigh-Ritz Chapter 2
methods, Lagrange and Hermite interpolation, axial deformation element using
Rayleigh-Ritz and Galerkin methods
One-Dimensional Boundary Value Problem: 1D BVD, FEA Solution of BVP, 1D
5, 6 Chapter 3
BVP applications
Trusses, Beams, and Frames: Finite Elements for beam bending, beam applications,
7, 8 Chapter 4
structural frames
Two-Dimensional Elements: Finite elements for two-dimensional and three-
8, 9 dimensional problems, linear triangular element for second-order 2D BVP, 2D Chapter 5
fluid flow and torsion problems
Mapped Elements: Two-dimensional Lagrange and serendipity shape functions,
10, 11 mapped elements, evaluation of area integrals for 2D mapped elements, Chapter 6
evaluation of line integrals for 2D mapped elements
Analysis of Elastic Solids: Stresses and strains in solids, finite element analysis of
12 Chapter 7
elastic solids, CST and isoparametric elements for plane elasticity
13 Project presentations
Textbooks and Learning Material
Required Text:

Fundamental Finite Element Analysis and Applications with Mathematica


and MATLAB Computations by M. Asghar Bhatti, ISBN 0-471-64808-6, John
Wiley and Sons, 2005.

Additional Readings:
• Concepts and Application of Finite Element Analysis, 4th Edition, by Robert
D. Cook, David S. Malkus, Michael E. Plesha, and Robert J. Wittt, ISBN
0-471-35605-0, John Wiley and Sons, 2002.
• Introduction to Matlab for Engineers by W. J. Palm III, ISBN 0-07-234983-
2, McGraw-Hill Higher Education, 2001.
• Applied Numerical Methods for Engineers and Scientists by S. S. Rao, ISBN 0-
13-089480-X, Prentice Hall, Inc., 2002.
Assessment Tools and Descriptions

Assessment Tool Percentage Description

Homework assignments Selected theoretical and


20 computer problems from course
textbook and other resources

Semester exam(s) 1 or 2 exams during the


25 semester

Research project Project related to the course


20
Final Exam Comprehensive exam
35
Introduction

Why we need to learn Finite Element


Analysis?
The field of Mechanics can be subdivided into 3 major
areas:
Theoretical
Applied
Mechanics
Computational

Nano and Micromechanics


Computational Continuum Mechanics:
Mechanics Solids and structures
Fluids Multiphysics Systems

Solid and Structural Statics Linear


Mechanics (CSM) Dynamics Nonlinear
Finite Element Method
Finite Difference Method

CSM Linear Boundary Element Method


Statics Finite Volume Method
Spectral Method
Mesh-Free Method

CSM Linear Statics by FEM

Having selected the FEM for discretization, we must next pick a formulation and
a solution method:
Displacement
Equilibrium
Formulation of FEM Model
Mixed
Hybrid

Stiffness
Solution of FEM Model
Flexibility
Mixed
This Course Covers:

Computational structural mechanics

Linear static problems

Spatially discretized by displacement-

formulated FEM

Solved by the stiffness method


11
Concept

• A physical problem is broken in to small elements.


• Finite elements are small interconnected geometrical
entities connected to other elements through nodes
(1D), boundary lines (2D), and boundary surfaces (3D).
• Mathematical formulation are derived for each element.
• Elements contain the material information and
determine how the loads are transferred into
displacements for all connected nodes.
12
Finite Element Method
FEM is a numerical method for solving a system of governing
equations over the domain of a continuous physical system,
which is discretized into simple geometric shapes called finite
element.

Continuous system Discrete system


Time-independent PDE Linear algebraic eq.
Time-dependent PDE ODE
Finite Element Method
• The Finite Element Method (FEM) is a numerical
method of solving systems of partial differential
equations (PDEs)
• It reduces a PDE system to a system of algebraic
equations that can be solved using traditional linear
algebra techniques.
• In simple terms, FEM is a method for dividing up a
very complicated problem into small elements that
can be solved in relation to each other.
Chronicle of Finite Element Method

Year Scholar Theory

1941 Hrennikoff Presented a solution of elasticity problem using one-dimensional


elements.
1943 McHenry Same as above.

1943 Courant Introduced shape functions over triangular subregions to model the
whole region.
1947 Levy Developed the force (flexibility) method for structure problem.

1953 Levy Developed the displacement (stiffness) method for structure


problem.
1954 Argyris & Kelsey Developed matrix structural analysis methods using energy
principles.
1956 Turner, Clough, Derived stiffness matrices for truss, beam and 2D plane stress
Martin,Topp elements. Direct stiffness method.
1960 Clough Introduced the phrase finite element .

1960 Turner et. al Large deflection and thermal analysis.

1961 Melosh Developed plate bending element stiffness matrix.

1961 Martin Developed the tetrahedral stiffness matrix for 3D problems.

1962 Gallagher et al Material nonlinearity.


Chronicle of Finite Element Method

Year Scholar Theory

1963 Grafton, Strome Developed curved-shell bending element stiffness matrix.

1963 Melosh Applied variational formulation to solve nonstructural problems.

1965 Clough et. al 3D elements of axisymmetric solids.

1967 Zienkiewicz et. Published the first book on finite element.

1968 Zienkiewicz et. Visco-elasticity problems.

1969 Szabo & Lee Adapted weighted residual methods in structural analysis.

1972 Oden Book on nonlinear continua.

1976 Belytschko Large-displacement nonlinear dynamic behavior.

~1997 New element development, convergence studies, the developments


of supercomputers, the availability of powerful microcomputers, the
development of user-friendly general-purpose finite element
software packages.
APPLICATIONS OF FINITE ELEMENT METHODS

 Structural & Stress Analysis


 Thermal Analysis
 Dynamic Analysis
 Acoustic Analysis
 Electro-Magnetic Analysis
 Manufacturing Processes
 Fluid Dynamics
 Financial Analysis
Biomedical
APPLICATIONS: CIVIL ENGINEERING
APPLICATIONS : AEROSPACE ENGINEERING

19
APPLICATIONS: ELECTRICAL ENGINEERING

20
APPLICATIONS: BIOMEDICAL ENGINEERING

21
THE FUTURE – VIRTUAL ENGINEERING
Stress Analysis of Geer Tooth
IUPUI Electric Race Car Components

Structural Analysis
TRAILER HITCH

• Design Constraints

2,950 lbf

0.35 sq in

8,450 psi
TRAILER HITCH (CON’T)

• ANSYS Modeling
• Proposed Trailer Design
Car Crash Simulations
-- Ford Taurus --
Car Crash Simulations
Thermal Fatigue of a Surface Mount Assembly

Low-cycle thermal fatigue of solder joints connecting electronic


chips to the printed circuit board due to solder creep is of
concern.
DIFFERENT TYPES OF INTERCONNECTION METHODS
IN ELECTRONIC PACKAGES

chip carrier solder

copper pad

PWB

Schematic of a LLCC type


TYPICAL 2D LLCC AND LDCC CASES USED
FOR CURVE FITTING

X
Finite element mesh for 20-pin LLCC
Biomedical Application -- Hip Implant

-- Interaction of a hip implant with the femur


-- Computed stresses
Mesh for Flow Around an Oscillating Missile
Mach Number Contours Around an Oscillating
Missile (Unsteady Flow)
Biomedical Application --
Prosthetic Cardiac Valve Simulations
Patient Specific Three-Dimensional Finite
Element Models of Defibrillation

•Ventricular fibrillation characterized by


unsynchronized contraction of heart - deadly
if not reversed
•Defibrillate by delivering an electrical shock
to reset heart
•Implantable cardioverter defibrillator (ICD)
for patients who are at high risk
Rib Cage

Lungs Heart
HVAC/Climate control in a passenger car, showing
transient ice melting on the windscreen
ADVANTAGES OF FINITE ELEMENT ANALYSIS
- Models Bodies of Complex Shape
- Can Handle General Loading/Boundary Conditions
- Models Bodies Composed of Composite and Multiphase
Materials
- Model is Easily Refined for Improved Accuracy by Varying
Element Size and Type (Approximation Scheme)
- Time Dependent and Dynamic Effects Can Be Included
- Can Handle a Variety Nonlinear Effects Including Material
Behavior, Large Deformations, Boundary Conditions, Etc.

38
Six Steps in the Finite Element Analysis

 Development of Element Equations: Done once for


each different problem type
 Discretization of solution domain into a Finite Element
Mesh
 Assembly of Element Equations
 Introduction of Boundary Conditions
 Solution for Nodal Unknowns
 Computation of Solution and Related Quantities Over
Each Element
GENERAL STEPS
1) Discretize the domain

a) Divide domain into finite elements using appropriate element


types (1-D, 2-D, 3-D, or Axisymmetric)
2) Select a Displacement Function
a) Define a function within each element using the nodal values
3) Define the Strain/Displacement and Stress/strain
Relationships
4) Derive the Element Stiffness Matrix and Equations
a)Derive the equations within each element
40
GENERAL STEPS
5) Assemble the Element Equations to Obtain the Global or Total
Equations and Introduce Boundary Conditions
a)Add element equations by method of superposition to obtain global
equation
Assemble Element Equations to Form Global System
[K]{U} = {F}
[K] = Stiffness or Property Matrix
{u} = Nodal Displacement Vector
{F} = Nodal Force Vector

6) Solve for the Unknown Degrees of Freedom (i.e primary unknowns)


7) Solve for the Element Strains and Stresses
8) Interpret the Results

41
Common Terms associated:
• Node
• Element
• Meshing
• Boundary conditions
• Geometric Properties
• Material Properties
• Analysis Type
• Degree of freedom

42
COMMON TERMS
• Node - a generalized joint
- connection point at which equations are written

• Element - connection between a group of nodes representing


stiffness or other properties approximately
- interpolation of displacement between the nodal values is
used - this becomes more accurate as element size is reduced

• Meshing – dividing the problem domain with finite elements

• Boundary conditions – conditions represent the problem


boundary and environment.
• Degree of freedom- unknowns associated with one node

43
Discretization
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.


Types of finite elements
Object

Elements
Nodes
Examples of FEA – 1D (beams)

Examples of FEA - 2D Examples of FEA – 3D


Shape Functions
The values of the field variable computed at the nodes are used
to approximate the values at non-nodal points (that is, in the
element interior) by interpolation of the nodal values. For the
three-node triangle example, the field variable is described by the
approximate relation

φ(x, y) = N1(x, y) φ1 + N2(x, y) φ2 + N3(x, y) φ3


where φ1, φ2, and φ3 are the values of the field variable at the
nodes, and
N1, N2, and N3 are the interpolation functions, also known as
shape functions or blending functions.
Finite Element Method (FEM) or
Finite Element Analysis (FEA)

Widely used numerical tool to solve engineering and


technology related problems.
Few warnings:
All models are wrong!! Some are useful.

An FEA program allows an engineer to make mistakes


at a rapid rate of speed ( R. Miller).

An error caused by misunderstanding or oversight is no


correctible by mesh refinement or by use of a more
powerful computer (Cook).
50
51
SIMPLE EXAMPLE
E 2E

Aa A b P

L L

Determine displacements of materials a and


b if the load P is applied to the end of the
bar given the above information.
52
EXAMPLE CON’T.

1) Discretize the domain with appropriate


elements.

Element a Element b
f1 f3 = P
1 2 3
u1 u2 u3

f1 f21 f22 f3 = P
1 2 2 3
u1 u2 u2 u3

53
EXAMPLE CON’T.

2) Select a displacement function

u1 u2 u3

1 2 3

u(x) = a1 + a2x + a3x2

54
EXAMPLE CON’T.
3) Define stress/displacement and stress/strain relationships
σx = Eεx εx = du/dx
4) Derive the element stiffness matrix and element
equations
{F} = [k]{d} [k] = stiffness matrix

{F} = Force [k] = EA 1 -1


L
{d} = displacement -1 1
a b
f1 EA 1 -1 u1 EA
f22 2 -2 u2
f21 = L , =
u2 f3 L u3
-1 1 -2 2

55
EXAMPLE CON’T.

5) Construct Global equation and introduce boundary


conditions and known variables.

f1 EA 1 -1 0 u1
f21+f22 = L u2
-1 3 -2 Global Equation
f3 u3
0 -2 2

B.C.: (x =0) u1 = 0
Known variables: f3 = P and f2 = f21+f22 = 0
56
EXAMPLE CON’T.

6) Solve for unknowns.

1 -1 0
f1 = EA 0
0 L u2
-1 3 -2
P u3
0 -2 2
f1 = -EAu2 0 = EA(3u2-2u3) P = EA(2u3-2u2)
L L L

u2 = PL u3 = 3PL
EA 2EA f1 = -P

57

You might also like