Chapter 1 - Introduction
Chapter 1 - Introduction
• Mathematic Model
• Finite Element Method
• Historical Background
• Analytical Process of FEM
• Applications of FEM
• Computer Programs for FEM
1. Mathematical Model
(1) Modeling
Physical Mathematica Solution
Problems l Model
Exact Sol. ◎ ◎
Approx. Sol. ◎ ◎
(3) Methods of Solution
(3) Method of Solution
A. Classical methods
They offer a high degree of insight, but the problems are
difficult or impossible to solve for anything but simple
geometries and loadings.
B. Numerical methods
(I) Energy: Minimize an expression for the potential energy of the
structure over the whole domain.
(II) Boundary element: Approximates functions satisfying the
governing differential equations not the boundary
conditions.
(III) Finite difference: Replaces governing differential equations
and boundary conditions with algebraic finite difference
equations.
(IV) Finite element: Approximates the behavior of an irregular,
continuous structure under general loadings and constraints
with an assembly of discrete elements.
2. Finite Element Method
(1) Definition
Element Node
Finite element Element
Cantilever plate
model Mesh
in plane strain
Discretization
Node
Problem: Obtain the
stresses/strains in the
plate
Fundamental Concept of FEM
• A continuous field of a certain domain
having infinite degrees of freedom is
approximated by a set of piecewise
continuous models with a number of finite
regions called elements. The number of
unknowns defined as nodes are determined
using a given relationship
i.e.{F}=[K]*{U}.
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
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
6) Solve for the Unknown Degrees of Freedom (i.e
primary unknowns)
7) Solve for the Element Strains and Stresses
8) Interpret the Results
3. Historical Background
Chronicle of Finite Element Method
Year Scholar Theory
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 elements. Direct
Martin, Topp stiffness method.
1969 Szabo & Lee Adapted weighted residual methods in structural analysis.
B. Approach
a. Force (flexibility) method: internal forces as unknowns.
b. Displacement (stiffness) method: nodal disp. As unknowns.
For computational purpose, the displacement method is more
desirable because its formulation is simple. A vast majority of
general purpose FE softwares have incorporated the displacement
method for solving structural problems.
(2) Analysis procedures of linear static structural analysis
x1 = 0, x2 and x3 are the distances to the nodes and u1, u2, and u3 are the
displacements.
a 1 a2 a3 a4
A column vector of length ‘m’ is a mx1 matrix
a1
a
2
a3
Special matrices
0 0 0 0
03x 4
= 0 0 0 0
0 0 0 0
Identity matrix: A square matrix which has ‘1’ s on
the diagonal and zeros everywhere else.
1 0 0
I3x 3
= 0 1 0
0 0 1
Matrix operations
Equality of matrices
1 2 4 a b c
A = − 3 0 7
B = d e f
9 1 5 g h i
a = 1, b = 2, c = 4,
A = B d = −3, e = 0, f = 7,
g = 9, h = 1, i = 5.
Matrix operations Addition of two
matrices
1 2 4 − 1 3 10
A = − 3 0 7 B = − 3 1 0
9 1 5 1 0 6
0 5 14
C = A + B = − 6 1 7
10 1 11
Addition of matrices
Matrix operations
Properties
A + (B + C ) = ( A + B ) + C
3.Addition of the zero matrix
A+0=0+A = A
Matrix operations Multiplication by a
scalar
1 2 4
A = − 3 0 7 c = 3
9 1 5
3 6 12
cA = − 9 0 21
27 3 15
Multiplication by a
scalar
Matrix operations
Special case
1 2 4
A = − 3 0 7 c = −1
9 1 5
−1 −2 − 4
cA = -A = 3 0 − 7
− 9 −1 − 5
Matrix operations Subtraction
1 2 4 − 1 3 10
A = − 3 0 7 B = − 3 1 0
9 1 5 1 0 6
2 − 1 − 6
C = A − B = 0 − 1 7
8 1 − 1
Note that A - A = 0 and 0 - A = -A
Transpose
Special
operations
If A is a mxn matrix, then the transpose of A is
the nxm matrix whose first column is the first
row of A, whose second column is the second
column of A and so on.
1 2 4 1 − 3 9
A = − 3 0
7 A = 2
T
0 1
9 1 5 4 7 5
Transpose
Special
operations
A =A T
Matrix operations Scalar (dot) product of
two vectors
If a and b are two vectors of the same size
a1 b1
a = a 2 ; b = b 2
a 3 b 3
The scalar (dot) product of a and b is a scalar obtained by
adding the products of corresponding entries of the two
vectors
a b = ( a 1b1 + a 2 b 2 + a 3 b 3 )
T
Matrix operations Matrix multiplication
A B = AB
mxr rxn mxn
inside
outside
Matrix operations Matrix multiplication
1 2 4 −1 3
A 3x3
= −3 0 7 B3x2
= −3 1
9 1 5 1 0
−3 −1
T
5 1
C3x2
= AB = 10
−9 notice 2 −3 = −3
−7 28 4 1
Multiplication of
Matrix operations matrices
Properties
A B = BA = I
Then
(a)The matrix A is called invertible, and
(b) the matrix B is the inverse of A and is
denoted as A-1.
AB = BA = I
AC = CA = I
(BA)C = IC = C
B(AC) = BI = B
B=C
Hence a matrix cannot have two or more
inverses.
Some properties
Inverse of a
matrix
(k A ) −1 1 -1
= A
k
Inverse of a Properties
matrix
Property 3: If A and B are invertible square
matrices then
−1
(A B ) −1
=B A
-1
(AB) (AB )
−1
=I
Premultiplying both sides by A-1
A (AB) (AB ) = A −1
-1 −1
(A A)B(AB )
-1 −1
= A −1
B(AB ) = A −1
−1
a 11 a 12
A= ; det( A ) = a 11a 22 − a 12 a 21
a 21 a 22
1 3
det( A ) = = 1 7 − 3 5 = −8
5 7
2 4 - 3 2 4 − 3 2 4
A = 1 0 4 1
0 4 1 0
2 - 1 2
2 − 1 2 2 −1
0 -8 8 0 32 3
2 7 8
3 2 4 =0
−2 −7 −8
a 21 a 23 a 21 a 23
M 12 = = a 21a 33 − a 23a 31 C12 = − M 12 = −
a 31 a 33 a 31 a 33
What is a cofactor?
Sign of cofactor + - +
- + -
+
- +
Find the minor and cofactor of a33
2 4 - 3
A = 1 0 4
Minor 2 4
2 - 1 2 M 33 = = 2 0 − 4 1 = −4
1 0
Cofactor C = ( − 1 ) ( 3 + 3 ) M = M = − 4
33 33 33
Cofactor method of obtaining the
determinant of a matrix
d e t( A ) = a 1 j C 1 j + a 2 j C 2 j + + a n j C n j
det( A ) = a i 1C i 1 + a i 2 C i 2 + + a i n C i n
Example: evaluate det(A) for:
1 0 2 -3
A= 3 4 0 1
det(A) = a11C11 +a12C12 + a13C13 +a14C14
-1 5 2 -2
0 1 1 3
4 0 1 3 0 1 3 4 1
det(A)=(1) 5 2 -2 - (0) -1 2 -2 +2 -1 5 -2
1 1 3 0 1 3 0 1 3
3 4 0
- (-3) -1 5 2 = (1)(35)-0+(2)(62)-(-3)(13)=198
0 1 1
Example : evaluate
1 5 -3
det(A)= 1 0 2
3 -1 2
By a cofactor along the third column
det(A)=a13C13 +a23C23+a33C33
-3* (-1) 4 1 0 1 5 1 5
det(A)= +2*(-1)5 +2*(-1)6
3 -1 3 -1 1 0
= det(A)= -3(-1-0)+2(-1)5(-1-15)+2(0-5)=25
Quadratic form
The scalar U =d k d
T d = vector
k = square matrix
Is known as a quadratic form
d1 k 11 k 12
Let d = k =
Symmetric
d 2 k 21 k 22 matrix
Then
k11 k12 d 1
U = d k d = d1 d 2
T
k12 k 22 d 2
k11d1 + k12 d 2
= d1 d 2
k12 d 1 + k 22 d 2
= d1 (k11d1 + k12 d 2 ) + d 2 (k12 d 1 + k 22 d 2 )
= k11d1 + 2k12 d1 d 2 + k 22 d 2
2 2
Differentiation of quadratic form
Differentiate U wrt d1
U
= 2 k 11 d 1 + 2 k 12 d 2
d 1
Differentiate U wrt d2
U
= 2 k 12 d 1 + 2 k 22 d 2
d 2
Differentiation of quadratic form
Hence
U
U d 1 k11 k12 d 1
= 2
d U k12 k 22 d 2
d 2
=2k d
Drag Force Analysis
of Aircraft
• Question
What is the drag force distribution on the aircraft?
• Solve
– Navier-Stokes Partial Differential Equations.
• Recent Developments
– Multigrid Methods for Unstructured Grids
San Francisco Oakland Bay Bridge
Picture from
http://www.adina.com
• Question
– What is the temperature distribution in the engine block?
• Solve
– Poisson Partial Differential Equation.
• Recent Developments
– Fast Integral Equation Solvers, Monte-Carlo Methods
Electromagnetic
Analysis of Packages
Thanks to
Coventor
http://www.cov
entor.com
• Solve
– Maxwell’s Partial Differential Equations
• Recent Developments
– Fast Solvers for Integral Formulations
Example
E 2E
a A b A P
L L