Lectures in Finite Element Method Ph. D. Students Course/ Structures Engineering 2hours/week
Lectures in Finite Element Method Ph. D. Students Course/ Structures Engineering 2hours/week
1
Syllabus
Ch.1: Finite element method: Description and application
References
1- Davies, A. J. (2011) "The Finite Element Method: An Introduction with
Partial Differential Equations", 2nd Ed., Oxford University Press.
2- Fish, J. and Belytschko, T. (2007) " A First Course in Finite Elements",
JohnWiley & Sons, Ltd.
3- Hutton, D. V. (2004) "Fundamentals of Finite Element Analysis",
McGraw−Hill Companies.
4- Kwon, Y. W. and Bang, H. (1997) "The Finite Element Programming
Using MATLAB", CRC Press LLC.
5- Liu, G. R. and Quek, S. S. (2003) "The Finite Element Method: A
Practical Course", Elsevier Science Ltd.
6- Rao, S. S. (2011) "The Finite Element Method in Engineering", 5th Ed.,
Elsevier Inc.
7- Pinder, G. F. and Gray W. G. (1977) "Finite Element Simulation in
Surface and Subsurface Hydrology", ACADEMIC PRESS, INC.
8- Zienkiewicz, O. C. and Taylor, R. L. (2000)" The Finite Element Method:
Fluid Dynamics", 5th , published by Butterworth-Heinemann.
2
Chapter 1
1.1 Introduction
The behavior of a phenomenon in a system depends upon the geometry or
domain of the system, the property of the material or medium, and the
boundary, initial and loading conditions. For an engineering system, the
geometry or domain can be very complex. Further, the boundary and initial
conditions can also be complicated. It is therefore, in general, very difficult to
solve the governing differential equation via analytical means. In practice, most
of the problems are solved using numerical methods. These methods include;
finite element method (FEM), finite difference method, finite volume method,
and boundary element method.
It is one of numerical methods that can be used to solve ordinary and partial
differential equations. In FEM, the actual continuous body of matter like solid,
liquid or gas is represented as an assemblage of subdivisions called finite
elements. These elements are considered to be interconnected at specified joints
which are called nodes or nodal points. The nodes usually lay on the element
boundaries where elements are connected. Since the actual variation of the field
variable (like stress, displacement, temperature, pressure, or velocity) inside the
continuum is not known, it is assumed that the variation of the field variable
inside a finite element can be approximated by simple function. These
approximating functions (also called interpolation models) are defined in terms
of the values of the field variables at the nodes. When field equations for the
whole body are written, the unknowns will be the nodal values of the field
3
variable. By solving the field equations, which are generally in the form of
matrix equations, the nodal values of the field variable will be known.
The discretization of the domain or solution region into sub regions (finite
element) is the first step in the FEM. By this step, the domain having an infinite
number of degrees of freedom is replaced by a system having finite number of
degrees of freedom. Here, the finite element mesh (or finite element grid map)
is formed. In discretization, the followings must be considered:
The type of the elements depends on the number of the independent variables of
the problem. It may be one-, two- or three-dimensional element.
4
One- dimensional element
For example if we have a beam, the beam is usually discretized into a number of
one-dimensional elements.
1 2 3 4 5
The order of one-dimensional elements may be;
5
Three- dimensional elements
B- Size of elements
6
T2
T1
C- Number of elements
Accuracy desired.
Element size.
Number of degrees of freedom.
Generally, at first a number of elements is chosen then solution is obtained.
After that, the number of elements is increased. If the results are not the same,
then, there is a need for increasing the elements number. This operation is called
mesh refinement.
Field variable value
No significant improvement
beyond Ne Use Ne
Ne
Number of elements
D- Location of nodes
If the body has no abrupt changes in geometry, material properties and external
conditions (like load, temp., etc..), the body can be divided into equal elements
and hence the spacing of nodes can be uniform. On the other hand if there are
7
any discontinuities in the problem, nodes have to be introduced at these
discontinuities.
E- Nodes numbering
B=(R+1)×f
8
Where R is the max largest difference in the node numbers occurring for all
elements of the assemblage and f is the number of degrees of freedom at each
node.
e.g.
2 7
if f=3
B= 7×3=21 1 6
F- Mesh generation
Nodes generation
Elements generation
Nodes generation produces a list contains the number and coordinates of each
node in the finite element mesh. In 2-D (Cartesian coordinates system) FE mesh
it will include;
Elements generation produces a list contains element numbers of the mesh and
the numbers of nodes associated with each element. For example, if the problem
domain is discretized using linear quadrilateral elements as shown below;
9
6 9
3
4
2
5 8
2
1
1
4 3
4
4 7
1
After the division of the problem domain into subdomains or elements, the
variation of the variable is defined approximately over the element in terms of
an interpolation function. The most used function type is polynomial
interpolation function. For example if we have a 1-D problem and one variable
say Ø, then;
Øe = α1+ α2 x …(1.1)
Quadratic elements;
Øe = α1+ α2 x+ α3 x2 … (1.2)
10
Cubic elements;
Øe = α1+ α2 x+ α3 y …(1.4)
Where; α1, α2 , α3 …and α6 are constants (or the coefficient for the monomials)
11
1.3.2.1 Interpolation functions in terms of nodal values
{α}=
{ }
[D]= …(1.7)
[ ]
12
We want the values of α1, α2, …….and α6
{ } [ ] { } …(1.8)
[ ][ ] { } …(1.9)
[ ]{ }
or;
[ ]
{ }
The variation of the field variable Ø over the element e is approximated as;
Where;
The variations of u and v over the element (e) are approximated as;
13
∑ & ∑
{ } [ ]
{ }
j
i
x
𝑙
[ ]{ }
14
Where;
Hints:
…(1.16)
+
Ø
+
+
Øk
Øi k x
Øj
i
y j
[( ) ( ) ]
[( ) ( ) ]
[( ) ( ) ]
| |
15
By substituting the values of α into Eq.(1.16) and arranging the results;
Where;
( )
Hints;
Ni =1 at node i and Ni =0 at the other nodes and so on.
Where; Øi, Øj, and Øk are the nodal values of Ø and they are independent on x
or y. A constant value of and over an element means that many small
elements have to be used in locations where rapid changes of Ø are expected.
Linear interpolation polynomials in terms of local coordinates
The derivation of element matrices and vectors involves the integration of the
shape functions or their derivatives or both over the element. These integrals
16
can be evaluated easily if the interpolation functions are written in terms of a
local coordinates system. A local coordinates system is one which is located on
or within the boundaries of the element and it is different for different elements.
( )
( )
H.W.1 Show that;
(̅ ̅ ̅ )
(̅ ̅ ̅ )
(̅ ̅ ̅ )
where;
̅ ̅ ̅ ⁄
̅ ̅ ̅
̅ ̅ ̅
H.W.2 Show that the integral of shape function in global coordinates system is
the same as the integral of shape function in local coordinates system.
17
1-D linear element
Any point in the element (p) is identified by two natural coordinates L 1 and L2
which are defined as;
and l
l2 l1
or; and 01 x 1 p 2
where; L1+L2=1 (L1,L2)
(1,0) (0,1)
; ;
3
y
𝐴 p𝐴
𝐴 2
1
x
where A1 is the area of the triangle formed by the points P, 2 and 3; A 2 is the
area of the triangle formed by the points P, 1 and 3; A3 is the area of the triangle
formed by the points P, 1 and 2; and A is the area of the triangle 123. Because
Li are defined in terms of areas, they are also known as area coordinates. Since
18
A1 + A2 +A3 = A, then;
L1 + L2 +L3 = 1 …(1.17)
A study of the properties of L1, L2, and L3 shows that they are also the shape
functions for the 2-D triangular element:
; ;
To every set of natural coordinates (L1, L2, L3), there corresponds a unique set
of Cartesian coordinates (x, y). The relation between the natural and Cartesian
coordinates is given by;
x = x1L1 +x2L2 + x3L3 …(1.18)
y = y1L1 + y2L2 + y3L3 …(1.19)
At node 1, L1 = l and L2 = L3 = 0, and so on. The linear relationship between Li
(i = 1, 2, 3) and (x, y) implies that the contours of L1 are equally placed straight
lines parallel to the side 2, 3 of the triangle (on which L1 = 0), and so on.
19
Equations (1.17), (1.18) and (1.19) can be written in a matrix form as;
…(1.20)
Then;
…(1.21)
Where A is the area of the triangle 1, 2, 3 given by;
…(1.22)
Or;
{ } { }
Thus at any point (p) in the element there is a value of N1, N2 and N3. If f is a
function of L1, L2 and L3, the differentiation with respect to x and y can be
performed as;
Derive as an example
Note: any point locates on the edge between points 1 and 3, as an example, has
coordinates in terms of L1 and L3. While a point inside the triangle has three
coordinates L1, L2 and L3.
∫ ∫
; ;
where Vi is the volume of the tetrahedron formed by the points P and the
vertices other than the vertex i (i = 1, 2, 3, 4), and V is the volume of the
tetrahedron element defined by the vertices 1, 2, 3, and 4 (Figure 3.15). Because
the natural coordinates are defined in terms of volumes, they are also known as
volume or tetrahedral coordinates. Since;
21
V1 +V2 + V3 +V4 = V
Then;
L1 +L2 + L3 +L4 = 1
The volume coordinates L1, L2, L3, and L4 are also the shape functions for a
three-dimensional simplex element:
; ; ;
22
Then;
Where;
23
Also;
∫ 5
; ;
5
6
2
4
1
and s = ±1.
24
1- Linear quadrilateral elements
; i=1, 2, 3, 4 …(1.26)
…(1.28)
Nodes Mapping
The nodes in r-s plane may be mapped into corresponding nodes in x- y plain
using the following relations;
∑ [ ]{ } …(a)
∑ [ ]{ } …(b)
25
Where {xi} and {yi} are list the nodal coordinates x and y and Ni (i=1, 2, … n)
are shape functions in terms of natural coordinates.
Based on the order of shape function used to describe the geometry, the
elements are classified into three types:
Or;
{ } [ ]
{ }
26
Let [J] =[ ]
Then;
{ } [ ]
{ }
{ } [ ] { } …(1.30)
Similarly;
| |
Where | | [ ]
27
Chapter two
The set of the equations (2.1) and (2.2) are the governing equations of the
system.
In the finite element procedure, once the mesh for the solution domain is
decided, the behavior of the field variables over the domain is approximated as;
̂ ∑
Where the circumflex distinguishes the approximation ̂ from the true solution
Øi and are the nodal values of Øie.
or;
̂ [ ]{ } k=1,l …(2.4)
28
{̂ } ∑ [ ]{ } …(2.5)
When ̂ is substituted into Eq.2.1, the equation will not be satisfied, that is;
(̂ )
29
∫ ∫ (̂ )
Collection method.
Subdomain collection method.
Galerkin method.
Least squares method.
Galerkin method is generally the most used one and gives the best approximate
solution.
H.W:
Write a brief report about collection, subdomain collection and least squares
methods.
2.2.1 Galerkin WRM
According to this method the weighting functions are chosen to be the same as
the shape functions used to represent Øi, that is Wk=Nk for k=1, 2, 3,…,nn. Thus
Eq.(2.8) becomes;
∫ (̂ ) . …(2.9)
∫ (̂ )
30
∑ ∫ (̂ ) …(2.11)
For example when the highest order derivative is second order ( , then, C1
…(2.12)
…(2.13)
where θ is the angle of the outwards normal on the boundary Γe of the
element with respect to the x-axis.
31
2.3 Variational Principle Method
In this method the variation of the dependent variable over the whole
domain is represented in terms of an integral functional (I). The term
"functional" means function of group of functions and I usually has a clear
physical meaning in most of the applications.
∫ ( ) ∫ ( ) …(2.14)
For example, in structural and solid mechanics, the potential energy (п) plays
the role of functional (п is a function of the displacement vector Ø, whose
components are u, v and w, which is a function of coordinates x, y and z).
Here, we are looking for an exact solution to satisfy the boundary conditions
and make the integral functional minimum. From mathematical point of view,
the solution that satisfies the boundary conditions and minimizes the integral
functional will satisfy the partial differential equation (i.e., solution to the
P.D.E.).
32
4- The solution is that makes I minimum;
…(2.16)
where i=1, 2, ……, n and n=total number of degrees of freedom for the
whole domain.
That means;
∑
∑ …(1)
∑ …(2)
∑ …(3)
∑ …(n)
The unknowns are the nodal values so we get the matrix equation for the whole
domain.
33
Total potential energy (п)
Strain energy
Strain energy (пs) for an elastic body of volume dv under an initial strain of
is;
{ } { }- { } { }
{ } { }
{ } { }
∫ [{ } { } { } { }]
or;
34
∫ [{ } { } { } { }] …(2.17)
{ } [ ]{ } [ ]{ } …(2.18)
[ ]
For 2-D problems, we have displacement in x-dir. (u) and displacement in y-dir.
(v). Approximate ue and ve using an interpolation function;
[ ]{ } & [ ]{ }
[[ ]{ }] [ ]{ }
35
[[ ]{ }] [ ]{ }
[[ ]{ }] [[ ]{ }]
Generally,
[ ]{ }
∫ [{ } [ ] [ ][ ]{ } { } [ ] [ ]{ }
{ } [ ]{ }]
Properties
(1) { } [ ]{ } (2) { } { } { } { }
{ } { } [ ]
Term-2 Wp
Let X, Y, and Z are body forces in x-, y-, and z-directions, respectively, then;
∫ { } [ ] { }
36
Since the body forces are variable for each element;
∫ { } [ ] { }
{ } { } { } { }
∑
{ } { }
{ } { }
37
∑ [∫[ ] [ ][ ] { } ∫ [ ] [ ]{ }
{ }
∫ [ ] { } ∫ [ ] { } ] { }
[ ]{ } { } { }
Where;
[ ] ∑ ∫[ ] [ ][ ]
But
[ ] ∑ [ ]
[ ] ∫[ ] [ ][ ]
{ } ∑ { }
{ } ∫ [ ] [ ]{ } ∫ [ ] { } ∫ [ ] { }
{ } { }
38
[{ } [ ]{ }] [ ]{ }
{ }
39
Fig.(2.1) Plane stress problem. Fig.(2.2): Plane strain problem.
∫ { } { }
The potential energy of the external forces, being opposite in sign from the
external work expression because the potential energy of external forces is lost
when the work is done by the external forces, is given by;
∫ ∫ ∑
Where; the first, second, and third terms on the right side of the above equation
represent the potential energy of (1) body forces, typically from the self-weight
of the bar (in units of force per unit volume) moving through displacement
function u, (2) surface loading or traction Tx, typically from distributed loading
acting along the surface of the element (in units of force per unit surface area)
moving through displacements us, where us are the displacements occurring
over surface S, and (3) nodal concentrated forces fix moving through nodal
displacements uix. The three forces are considered to act in x- direction of the
bar as shown in Fig.(2.3). V is the volume of the body and S1 is the part of the
surface S on which surface loading acts. For a bar element with two nodes and
one degree of freedom per
40
node, m =2.
{ } [ ]{ }
∑ [ ∫[ ] [ ][ ] { } ∫ [ ] { }
{ }
∫ [ ] { } ] { }
[ ]{ } { } { }
Where;
[ ] ∑ ∫[ ] [ ][ ]
But
[ ] ∑ [ ]
[ ] ∫[ ] [ ][ ]
41
[ ] element stiffness matrix
{ } ∑ { }
{ } ∫ [ ] { } ∫ [ ] { }
{ } { }
H.W.1: Solve the following problem using Galerkin weighted residual method
and variational principle method.
For the bar subjected to the linear varying axial load shown below, determine
the nodal displacements and axial stress distribution using (a) two equal-length
elements and (b) four equal-length elements. Take E=210 GPa and A=4×10-4 m2
10x kN/m
4m
Hint: for the simple two-noded bar element subjected to a linearly varying load
(triangular loading), place one-third of the total load at the node where the
distributed loading begins (zero end of the load) and two-thirds of the total load
at the node where the peak value of the distributed load ends.
42
Chapter Three
3.1 General
A truss is one of the simplest and most widely used structural members. It is a
straight bar that is designed to take only axial forces, therefore it deforms only
in its axial direction. The cross-section of the bar can be arbitrary, but the
dimensions of the cross-section should be much smaller than that in the axial
direction. Finite element equations for such truss members will be developed in
this chapter. The element developed is commonly known as the truss element or
bar element. Such elements are applicable for analysis of the skeletal type of
truss structural systems both in two-dimensional planes and in three-
dimensional space.
In planar trusses there are two components in the x and y directions for the
displacements as well as for the forces. For space trusses, however, there will be
three components in the x, y and z directions for both displacements and
forces. In skeletal structures consisting of truss members, the truss members are
joined together by pins or hinges (not by welding), so that there are only forces
(not moments) transmitted between the bars.
3.2 FEM Equations
Consider a structure consisting of a number of trusses or bar members. Each of
the members can be considered as a truss/bar element of uniform cross-section
bounded by two nodes. Consider a bar element with nodes 1 and 2 at each end
of the element, as shown in Fig.(3.1). The length of the element is le. The local
x- axis is taken in the axial direction of the element with the origin at node 1. In
the local coordinate system, there is only one DOF at each node of the element,
43
and that is the axial displacement (u). Therefore, there is a total of two DOFs for
the element.
[ ] 3.1)
[ ] ∫ [ ] [ ]
∫ [ ] [ ]
44
To find the nodal force vector for truss elements, suppose the element is
loaded by an evenly distributed force fx along the x-axis, and two concentrated
forces fs1and fs2, respectively, at two nodes 1 and 2, as shown in Fig.1; the total
nodal force vector becomes;
{ } ∫ [ ] { } ∫ [ ] { }
{ }
45
{ } [ ]{ } …(3.4)
Where;
{ }
{ }
and [T] is the transformation matrix for the truss element, given by;
In which;
are the direction cosines of the axial axis of the element. The length of the
element, le, can be calculated using the global coordinates of the two nodes of
the element by;
The matrix [T] for a truss element transforms a 6 × 1 vector in the global
coordinate system into a 2 × 1 vector in the local coordinate system. The
transformation matrix is, also, applied to the force vectors between the local and
global coordinate systems:
{ } [ ]{ }
46
{ }
{ }
in which F3i−2, F3i−1 and F3i stand for the three components of the force vector at
node i based on the global coordinate system.
The element equation based on the global coordinate system can be
written as:
[ ][ ]{ } [ ]{ }
Multiply both side by [T]T;
[ ] [ ][ ]{ } [ ] [ ]{ }
Let [Ke] = element stiffness matrix in global coordinates system, then;
[Ke]= [ ] [ ][ ]
Since[ ] [ ] = identity matrix ; Prove?
then;
[ ]{ } { } …(3.5)
Where [Ke]=
Where [Ke]=
47
and {Fe}=
Note that the element stiffness matrix [Ke] has a dimension of 6 × 6 in the three-
dimensional global coordinate system, and the displacement {D} and the force
vector {Fe} have a dimension of 6 × 1.
B- Planar trusses
For a planar truss, the global coordinates X–Y can be employed to represent the
plane of the truss. All the formulations of coordinate transformation can be
obtained from the counterpart of those for spatial trusses by simply removing
the rows and/or columns corresponding to the z- (or Z-) axis. The displacement
at the global node i should have two components in the X and Y directions only:
D2i−1 and D2i . The coordinate transformation, which gives the relationship
between the displacement vector {U} based on the local coordinate system and
the displacement vector {De}, has the same form as Eq. (3.4), except that {De}
and {Fe} are 4×1 vectors and [T] is 2×4 matrix.
3.3 Boundary Conditions
The stiffness matrix [Ke] in Eq. (3.5) is usually singular, because the whole
structure can perform rigid body movements. There are two DOFs of rigid
movement for planer trusses and three DOFs for space trusses. These rigid body
movements are constrained by supports or displacement constraints. In practice,
truss structures are fixed somehow to the ground or to a fixed main structure at
a number of the nodes. When a node is fixed, the displacement at the node must
be zero. This fixed displacement boundary condition can be imposed on Eq.
48
(3.5). The imposition leads to a cancellation of the corresponding rows and
columns in the stiffness matrix.
3.4 Determination of Stress and Strain
Eq. (3.5) can be solved using standard routines and the displacements at all the
nodes can be obtained after imposing the boundary conditions. The
displacements at any position other than the nodal positions can also be
obtained using interpolation by the shape functions. The stress in a truss
element can also be determined using the following equation:
σx = E[B]{U} = E[B][T]{De}
In deriving the above equation, Hooke’s law in the form of σ = Eε is used.
49
Chapter Four
4.1 General
A beam is another simple but commonly used structural component. It is also
geometrically a straight bar of an arbitrary cross-section, but it deforms only in
directions perpendicular to its axis. Note that the main difference between the
beam and the truss is the type of load they carry. Beams are subjected to
transverse loading, including transverse forces and moments that result in
transverse deformation. Herein, the cross-section of the beam structure is
assumed uniform. If a beam has a varying cross-section, the beam should be
divided into shorter beams, where each can be treated as a beam with a uniform
cross-section.
4.2 FEM Equations
In planar beam elements there are two degrees of freedom (DOFs) at a node in
its local coordinate system. They are deflection in the y direction, v, and rotation
in the x–y plane, θz with respect to the z-axis. Therefore, each beam element has
a total of four DOFs.
4.3 Shape Function Construction
Consider a beam element of length l with nodes 1 and 2 at each end of the
element, as shown in Fig.1. The local x-axis is taken in the axial direction of the
element with its origin at the beginning of the beam. Similar to all other
structures, to develop the FEM equations, shape functions for the interpolation
of the variables from the nodal variables would first have to be developed. The
transverse displacement model for the beam element is assumed to be a cubic
polynomial involving four constants.
50
V
(x)
0 x
Node Node
1 l 2
The cubic interpolation function for the displacement of a beam element
is expressed as;
v)x( = α1 +α2x+α3x2 +α4x3
And the displacement function for the element e can be written as;
[ ]{ } …(4.1)
Where {d} is displacement vector defined as;
{ } { }
After the obtaining of the shape functions, the next step would be to obtain the
element strain matrix. The relationship between the strain (εXX) and the
deflection (v) is;
…(4.2)
51
Substituting Eq. (4.1) into Eq. (4.2), which gives the relationship between the
strain and the deflection;
[ ]{ }
where the strain matrix B is given by;
[ ] [ ]
[ ] [ ]
[ ] ∫ [ ] [ ][ ] …(4.4)
By substituting Eq. (4.3) into Eq. (4.4), the stiffness matrix can be obtained as;
[ ] ∫ [ ] [ ][ ] ∫ ∫ [ ] [ ]
∫ [ ] [ ] …(4.5)
[ ] ∫
[ ]
52
Evaluating the integrals in the above equation leads to;
6 3L 6 3L
3L 2L2 3L L2
2EI
K e 3 Z …(4.6)
L 6 3L 6 3L
3L L
2
3L 2L 2
{ } ∫ [ ] { } ∫ [ ] { }
{ ⁄ }
4.7 Beam Finite Element Equation
[ ]{ } { } …(4.8)
Where [ke] and { } are defined using Eqs. (4.6) and (4.7), respectively.
53
Chapter Five
Frame elements are applicable for the analysis of skeletal type systems of
both planar frames (two-dimensional frames) and space frames (three-
dimensional frames). Frame members in a frame structure are joined together by
welding so that both forces and moments can be transmitted between members.
Herein, it is assumed that the frame elements have a uniform cross sectional
area. If a structure of varying cross-section is to be modeled using the
formulation given below, then the structure must be divided into smaller
elements of different constant cross-sectional area so as to simulate the varying
cross-section. If the variation in cross-section is too severe for accurate
approximation, then the equations for a varying cross-sectional area can also be
formulated without much difficulty using the same concepts and procedure.
54
Fig.(5.1). They are the axial deformation in the x direction, u; deflection in the y
direction, v; and the rotation in the x–y plane and with respect to the z-axis, θz.
Therefore, each element with two nodes will have a total of six DOFs.
55
…(5.1)
To construct the stiffness matrix, the stiffness matrix for truss elements is
…(5.2)
Next, the stiffness matrix for the beam element is also extended to a 6×6
matrix corresponding to the order of the degrees of freedom of the frame
element in Eq. (5.1):
…(5.3)
56
The two matrices in Eqs. (5.2) and (5.3) are now superimposed together
to obtain the stiffness matrix for the frame element:
…(5.4)
The same simple procedure can be applied to the force vector as well.
The element force vectors for the truss and beam elements are extended into
6×1 vectors corresponding to their respective DOFs and added together. If the
element is loaded by external distributed forces fx and fy along the x-axis;
concentrated forces fsx1, fsx2, fsy1 and fsy2; and concentrated moments ms1 and ms2,
respectively, at nodes 1 and 2, the total nodal force vector becomes;
…(5.5)
The matrices formulated in the previous section are for a particular frame
element in a specific orientation. A full frame structure usually comprises
numerous frame elements of different orientations joined together. As such,
57
their local coordinate system would vary from one orientation to another. To
assemble the element matrices together, all the matrices must first be expressed
in a common coordinate system, which is the global coordinate system. The
coordinate transformation process is the same as that described for truss
structures.
Assume that local nodes 1 and 2 correspond to the global nodes i and j,
respectively. The displacement at a local node should have two translational
components in the x and y directions and one rotational deformation. They are
numbered sequentially by u, v and θz at each of the two nodes, as shown in Fig.
(5.2). The displacement at a global node should also have two translational
components in the X and Y directions and one rotational deformation. They are
numbered sequentially by D3i−2, D3i−1 and D3i for the ith node, as shown in
Fig.(5.2). The same sign convention also applies to node j. The coordinate
transformation gives the relationship between the displacement vector de based
on the local coordinate system and the displacement vector De for the same
element, but based on the global coordinate system:
58
5 6)
Where;
…(5.7)
and T is the transformation matrix for the frame element given by;
…(5.8)
in which;
…(5.9)
where α is the angle between the x-axis and the X-axis, as shown in Fig.(5.2),
and;
…(5.10)
Note that the coordinate transformation in the X–Y plane does not affect
the rotational DOF, as its direction is in the z direction (normal to the x–y
59
plane), which still remains the same as the Z direction in the global coordinate
system. The length of the element, le, can be calculated by;
…(5.11)
Note that there is no change in dimension between the matrices and vectors in
the local and global coordinate systems.
60
Chapter Six
…(6.1)
…(6.2)
62
where ϑx and ϑy are, respectively, the rotations of the fiber of the plate
with respect to the x and y axes. The in-plane strains can then be given as;
{ } { } …(6.3)
{ } { } 5
{ }
The potential (strain) energy expression for a thick plate element is;
∫ [{ } { } { } { }] …(6.6)
or;
63
∫ ∫ { } { } ∫ ∫ { } { } …(6.8)
The first term on the right-hand side of the above equation is for the in-
plane stresses and strains, whereas the second term is for the transverse stresses
and strains. {τ} is the average shear stresses vector relating to the shear strain in
the form;
{ } { } [ ]{ } [ ]{ }
∫ { } [ ]{ } ∫ { } [ ]{ } …(6.10)
∑ …(6.11-a)
∑ …(6.11-b)
∑ …(6.11-c)
…(6.12)
64
{ }=[ ]{ } …(6.13)
where {d} is the displacement vector for all the nodes in the element, arranged
in the order;
{ }
{ }
To obtain the stiffness matrix [ke], Eq. (6.13) is substituted into Eq.
(6.10);
[ ] ∫ [ ] [ ][ ] ∫ [ ] [ ][ ]
The first term in the above equation represents the strain energy
associated with the in-plane stress and strains. The strain matrix [BI ] has the
form of ;
[ ] [ ]
where;
⁄
[ ⁄ ], j=1,…,4
⁄ ⁄
65
The strain matrix [Bo] has the form;
[ ] [ ]
where;
⁄
[ ], j=1,…,4
⁄
{ } ∫ [ ] { }dA
66