Thanks to visit codestin.com
Credit goes to www.scribd.com

0% found this document useful (0 votes)
45 views42 pages

2 D (Traingular Element) Shape Functions

The document discusses the shape functions for two-dimensional triangular elements used in finite element analysis, covering their formulation in both Cartesian and natural coordinates. It explains the properties of 2D solid elements, the polynomial representation of shape functions, and the construction of shape functions based on the geometry of triangular elements. Additionally, it addresses the importance of distinct node coordinates for matrix invertibility and the implications for numerical computations in finite element meshes.

Uploaded by

DHRUV KALBHOR
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
45 views42 pages

2 D (Traingular Element) Shape Functions

The document discusses the shape functions for two-dimensional triangular elements used in finite element analysis, covering their formulation in both Cartesian and natural coordinates. It explains the properties of 2D solid elements, the polynomial representation of shape functions, and the construction of shape functions based on the geometry of triangular elements. Additionally, it addresses the importance of distinct node coordinates for matrix invertibility and the implications for numerical computations in finite element meshes.

Uploaded by

DHRUV KALBHOR
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 42

Shape function - Triangular

Element
2 D( Triangular Element) shape
Functions
1. Shape function in Cartesian coordinate &
in natural coordinates
2.Higher order elements in
natural coordinates and cartesian
coordinates
3. Strain displacement matrix for 2D
Traingular elements
2D Elements
• 2D solid elements are applicable for the analysis of
plane strain and plane stress problems.
• A 2D solid element can have a triangular, rectangular
or quadrilateral shape with straight or curved edges.
• A 2D solid element can deform only in the plane of
the 2D solid.
• At any point, there are two components in the x and
y directions for the displacement as well as forces.

3
Two Dimentional Polynomial Shape function
A general form form of two dimentional polynomial model is

ϕ(x,y) = a1+ a2x + a3y +a4x2 + a5xy + a6y2 +a7x3+……+ amyn

It may be observed that in two dimensional problem, total


number of terms m in a complete nth degree polynomial is

The First Three terms are a1+ a2x + a3y


We know that first six a1+ a2x + a3y +a4x2 +a 5xy + a 6y2
terms are

Another convenient way to remember complete two


dimensional polynomial is in the form of Pascal Triangle
ϕ(x,y) = a1+ a2x + a3y

Domain of
problem
The complete linear polynomial in x and y in Ωe is of the form
ϕ(x,y) = a1+ a2x + a3y

The set {1, x, y} is linearly independent and complete


Thus, if u(x, y) is a curved surface, approximates the surface by a
plane three nodes are placed at the vertices of the triangle so that
the geometry of the triangle is uniquely defined, and the nodes are
numbered in counter clockwise direction, as shown in Fig. , so that
the unit normal always points upward from the domain.
Let

where (xi , yi ) denote the coordinates of the ith vertex of the


triangle. Note that the triangle is uniquely defined by the three
pairs of coordinates (xi , yi )
polynomial associated with a triangular element and there are three
nodes identified, namely, the vertices of the triangle.
∅𝑖 = ∅𝑖 (𝑥𝑖 , 𝑦𝑖 ) = 𝑎1 + 𝑎2 𝑥𝑖 + 𝑎3 𝑦𝑖
∅𝑗 = ∅𝑗 (𝑥𝑗 , 𝑦𝑗 ) = 𝑎1 + 𝑎2 𝑥𝑗 + 𝑎3 𝑦𝑗
∅𝑘 = ∅𝑘 (𝑥𝑘 , 𝑦𝑘 ) = 𝑎1 + 𝑎2 𝑥𝑘 + 𝑎3 𝑦𝑘
∅𝑖 1 𝑥𝑖 𝑦𝑖 𝑎1
∅𝑗 = 1 𝑥𝑗 𝑦𝑗 𝑎2 …… (a)
∅𝑘 1 𝑥𝑘 𝑦𝑘 𝑎3

{}e = [xx] {a}e {a}e = [xx] -1{}e


−1
𝑎1 1 𝑥𝑖 𝑦𝑖 ∅𝑖
𝑎2 = 1 𝑥𝑗 𝑦𝑗 ∅𝑗
𝑎3 1 𝑥𝑘 𝑦𝑘 ∅𝑘
➢for ai (i = 1, 2, 3) requires the inversion of the coefficient
matrix A.
➢The inverse ceases to exist whenever any two rows or columns
are the same.
➢Two rows or columns of the coefficient matrix will be the
same only when any two nodes have the same coordinates.
➢Thus, in theory, as long as the three vertices of the triangle are
distinct and do not lie on a line, the coefficient matrix is
invertible.
➢es.
➢However, in actual computations, if any two of the three nodes are very
close to each other or the three nodes are almost on a line, the coefficient
matrix can be nearly singular and numerically noninvertible.

➢Hence one should avoid elements with narrow geometries (see Fig.) in
finite element mesh
−1
1 𝑥𝑖 𝑦𝑖
𝑎𝑑𝑗𝑜𝑖𝑛𝑡 (𝑥𝑥)
1 𝑥𝑗 𝑦𝑗 =
det 𝑜𝑓 [𝑥𝑥]
1 𝑥𝑘 𝑦𝑘
adj [ xx] = (cofactor matrix of xx )T
𝑥𝑗 𝑦𝑗 𝑦𝑖 𝑥𝑖 𝑥𝑖 𝑦𝑖
𝑥𝑘 𝑦𝑘 𝑦𝑘 𝑥𝑘 𝑥𝑗 𝑦𝑗
1
𝑥𝑗 1 1 𝑦𝑖 𝑦𝑖 1
−1
[𝑥𝑥] = 𝑦𝑘 1 1 𝑦𝑘 𝑦𝑗 1
det 𝑜𝑓 [𝑥𝑥]
1 𝑥𝑗 𝑥𝑖 1 1 𝑥𝑖
1 𝑥𝑘 𝑥𝑘 1 1 𝑥𝑗
Area of triangle = A;
Determinant of (xx) = 2 * A
det. |xx| = (𝒙𝒋 𝒚𝒌 - 𝒙𝒌 𝒚𝒋 ) − (𝒙𝒊 𝒚𝒌 − 𝒙𝒌 𝒚𝒊 ) − (𝒙𝒊 𝒚𝒋 − 𝒙𝒋 𝒚𝒊 )
𝑥𝑗 𝑦𝑘 − 𝑥𝑘 𝑦𝑗 𝑥𝑘 𝑦𝑖 − 𝑥𝑖 𝑦𝑘 𝑥𝑖 𝑦𝑗 − 𝑥𝑗 𝑦𝑖
1
[𝑥𝑥]−1 = 𝑦𝑗 − 𝑦𝑘 𝑦𝑘 − 𝑦𝑖 𝑦𝑖 − 𝑦𝑗
2𝐴 𝑥𝑘 − 𝑥𝑗 𝑥𝑖 − 𝑥𝑘 𝑥𝑗 − 𝑥𝑖
The nodal points should always be taken in the counter-clockwise direction, as expressed
through the sequence i, j and k. However, we may equally well take the sequences j, k, i
or k, i, j which are obtained from the sequence i, j, k by a so-called cyclic permutationThe
reason is that each cyclic permutation does not change det [xx]
𝛼𝑖 𝛼𝑗 𝛼𝑘
1
The inverse of the [𝑥𝑥]−1 = 𝛽𝑖 𝛽𝑗 𝛽𝑘
coefficient matrix [ xx] 2𝐴 𝛾𝑖 𝛾𝑗 𝛾𝑘
αi , βi , and γi are constants which depend only on the global
coordinates of element nodes (xi , yi ):
2 𝐴 = 𝛼𝑖 + 𝛼𝑗 + 𝛼𝑘
det. |xx| = 2A = (𝑥𝑗 𝑦𝑘 - 𝑥𝑘 𝑦𝑗 ) − (𝑥𝑖 𝑦𝑘 − 𝑥𝑘 𝑦𝑖 ) − (𝑥𝑖 𝑦𝑗 − 𝑥𝑗 𝑦𝑖 )
𝜶𝒊 = (𝒙𝒋 𝒚𝒌 − 𝒙𝒌 𝒚𝒋 )
𝜷𝒊 = 𝒚𝒋 − 𝒚𝒌
𝜸𝒊 = − (𝒙𝒋 − 𝒙𝒌 )

𝜶𝟏 = 𝒙𝟐 𝒚𝟑 − 𝒙𝟑 𝒚𝟐 ; 𝜷𝟏 = 𝒚𝟐 − 𝒚𝟑 ; 𝜸𝟏 = − (𝒙𝟑 − 𝒙𝟐 )
Other coefficients &
Are obtained by cyclic symmetric permutations of subscripts 1, 2, 3 viz., in
parallelism with i, j, k.
α1 = ( x2y3 – x3 y2 ) α2 = ( x3y1 – x1 y3 ) α3 = ( x1y2 – x2y1 )

β1 = ( y2 - y3 ) β2 = ( y3 - y1 ) β2 = ( y1 - y2 )

γ1 = ( x3 – x2 ) γ2 = ( x1 – x3 ) γ3 = ( x2 – x1 )
Solving Eq. (a) for c (i.e., {a} = [xx]−1 {}), we obtain
1
𝑎1 = 𝛼𝑖 ∅𝑖 + 𝛼𝑗 ∅𝑗 + 𝛼𝑘 ∅𝑘
2𝐴
1
𝑎2 = 𝛽𝑖 ∅𝑖 + 𝛽𝑗 ∅𝑗 + 𝛽𝑘 ∅𝑘
2𝐴
1
𝑎3 = 𝛼𝑖 ∅𝑖 + 𝛼𝑗 ∅𝑗 + 𝛾𝑘 ∅𝑘
2𝐴

Where 2A is determinant of [A]

1 𝑥1 𝑦1
2𝐴 = 1 𝑥2 𝑦2 = 2 (𝐴𝑟𝑒𝑎 𝑜𝑓 𝑡𝑟𝑖𝑎𝑛𝑔𝑙𝑒)
1 𝑥3 𝑦3
Shape functions construction
1 x1 y1
1 1 1
Ae = P = 1 x2 y2 = [( x2 y3 − x3 y2 ) + ( y2 − y3 ) x1 + ( x3 − x2 ) y1 ]
2 2 2
1 x3 y3

Area of triangle Moment matrix

α1 + α2 + α3 = ( x2y3 – x3 y2 ) + ( x3y1 – x1 y3 )+ ( x1y2 – x2y1 )


Therefore : Ae = ½(α1 + α2 + α3 )

17
Substitute 1, b1 and c1 back into N1 = a1 + b1x + c1y:
∅𝑒ℎ 𝑥, 𝑦 = 𝑎1𝑒 + 𝑎2𝑒 𝑥 + 𝑎3𝑒 𝑦

1
𝑎1 = 𝛼𝑖 ∅𝑖 + 𝛼𝑗 ∅𝑗 + 𝛼𝑘 ∅𝑘
2𝐴
1
𝑤ℎ𝑒𝑟𝑒, 𝑎2 = 𝛽𝑖 ∅𝑖 + 𝛽𝑗 ∅𝑗 + 𝛽𝑘 ∅𝑘
2𝐴
1
𝑎3 = 𝛼𝑖 ∅𝑖 + 𝛼𝑗 ∅𝑗 + 𝛾𝑘 ∅𝑘
2𝐴

𝛼𝑖 + 𝛽𝑖 𝑥 + 𝛾𝑖 𝑦 𝛼𝑗 + 𝛽𝑗 𝑥 + 𝛾𝑗 𝑦 𝛼𝑘 + 𝛽𝑘 𝑥 + 𝛾𝑘 𝑦
∅ 𝑥, 𝑦 = ∅𝑖 + ∅𝑗 + ∅𝑘
2𝐴 2𝐴 2𝐴

∅ 𝑥, 𝑦 = ෍ ∅𝑒𝑖 𝑁𝑖𝑒 (𝑥, 𝑦)


𝑖 =1
Properties of shape function

1
N1 = [( y2 − y3 )( x − x2 ) + ( x3 − x2 )( y − y2 )]
2 Ae
Shape functions construction
Similarly,
N 2 ( x1 , y1 ) = 0 1
N2 = [( x3 y1 − x1 y3 ) + ( y3 − y1 ) x + ( x1 − x3 ) y ]
N 2 ( x2 , y2 ) = 1 2 Ae
N 2 ( x3 , y3 ) = 0 1
= [( y3 − y1 )( x − x3 ) + ( x1 − x3 )( y − y3 )]
2 Ae
N 3 ( x1 , y1 ) = 0 1
N3 = [( x1 y2 − x1 y1 ) + ( y1 − y2 ) x + ( x2 − x1 ) y ]
N 3 ( x2 , y2 ) = 0 2 Ae
N 3 ( x3 , y3 ) = 1 1
= [( y1 − y2 )( x − x1 ) + ( x2 − x1 )( y − y1 )]
2 Ae

1, 𝑎𝑡 𝑛𝑜𝑑𝑎𝑙 𝑝𝑜𝑖𝑛𝑡𝑠 𝑖
𝑁𝑖 𝑒 = ቊ
0, 𝑎𝑡 𝑎𝑙𝑙 𝑜𝑡ℎ𝑒𝑒𝑟 𝑛𝑜𝑑𝑎𝑙 𝑝𝑜𝑖𝑛𝑡𝑠

21
1, 𝑎𝑡 𝑛𝑜𝑑𝑎𝑙 𝑝𝑜𝑖𝑛𝑡𝑠 𝑖
𝑁𝑖 𝑒 = ቊ
0, 𝑎𝑡 𝑎𝑙𝑙 𝑜𝑡ℎ𝑒𝑒𝑟 𝑛𝑜𝑑𝑎𝑙 𝑝𝑜𝑖𝑛𝑡𝑠
In the weak formulation of the two-dimensional heat flow problem ,
the temperature gradient VT enters the expression.
Therefore,

T = T1N1+ T2N2 +T3N3 +…….. TnNn

𝑇 = 𝑁𝑒 𝑇 𝑒 𝑇1
where
𝑇2
.
𝑁𝑒 = 𝑁1 𝑁2 … … … . 𝑁𝑛 e
T=
.
.
𝑇𝑛
𝜕𝑇 𝜕𝑁 𝑒 𝑒
𝑇
𝜕𝑥 𝜕𝑥
∇𝑇 = 𝜕𝑇 =
𝜕𝑁 𝑒 𝑒
𝑇
𝜕𝑦 𝜕𝑦
𝜕𝑇 𝜕𝑁 𝑒 𝑒
𝑇
𝜕𝑥 𝜕𝑥 ∇𝑇 = ∇𝑁 𝑒 𝑇 𝑒
∇𝑇 = 𝜕𝑇 =
𝜕𝑁 𝑒 𝑒
𝑇
𝜕𝑦 𝜕𝑦
where VN• is defined according to

For Traingle temperatute distributiontion

T = T1N1+ T2N2 +T3N3

𝜵𝑻 = 𝑩𝒆 𝑻𝒆

𝝏𝑵𝒊 𝒆 𝝏𝑵𝒋 𝒆 𝝏𝑵𝒌 𝒆


𝝏𝒙 𝝏𝒙 𝝏𝒙 𝟏 𝒚𝒋 − 𝒚𝒌 𝒚𝒌 − 𝒚𝒊 𝒚𝒊 − 𝒚𝒋
𝑩𝒆 = 𝑩𝒆
𝝏𝑵𝒊 𝒆 𝝏𝑵𝒋 𝒆 𝝏𝑵𝒌 𝒆 =
𝟐𝑨 𝒙𝒌 − 𝒙𝒋 𝒙𝒊 − 𝒙𝒌 𝒙𝒋 − 𝒙𝒊
𝝏𝒚 𝝏𝒚 𝝏𝒚
From the global shape functions defined above, the temperature
approximation over the entire body can be written as
𝑇 = 𝑁𝑇
𝑇1
T = T1N1+ T2N2 +T3N3 +…….. TnNn 𝑇2
.
𝑁 = 𝑁1 𝑁2 … … … . 𝑁𝑛 T=
.
.
VT=BT
𝑇𝑛
𝜕𝑁1 𝜕𝑁2 𝜕𝑁𝑛
…………….
𝜕𝑥 𝜕𝑥 𝜕𝑥
𝐵 = ∇𝑁 = 𝜕𝑁 𝜕𝑁2 𝜕𝑁𝑛
1
…………….
𝜕𝑦 𝜕𝑦 𝜕𝑦
1
• 𝑁1 𝑒 = 𝑥 − 𝑥2 𝑦 − 𝑦4
4𝑎𝑏
1
• 𝑁2 𝑒 = − 𝑥 − 𝑥1 𝑦 − 𝑦3
4𝑎𝑏
1
• 𝑁3 𝑒 = 𝑥 − 𝑥4 𝑦 − 𝑦2
4𝑎𝑏
1
• 𝑁4 𝑒 = − 𝑥 − 𝑥3 𝑦 − 𝑦1
4𝑎𝑏

𝜕𝑁 𝑒 𝜕𝑁1 𝑒 𝜕𝑁2 𝑒 𝜕𝑁3 𝑒 𝜕𝑁4 𝑒


𝜕𝑥 𝜕𝑥 𝜕𝑥 𝜕𝑥 𝜕𝑥
𝐵𝑒 = ∇𝑁 𝑒 = 𝜕𝑁 𝑒 =
𝜕𝑁1 𝑒 𝜕𝑁2 𝑒 𝜕𝑁3 𝑒 𝜕𝑁4 𝑒
𝜕𝑦 𝜕𝑦 𝜕𝑦 𝜕𝑦 𝜕𝑦

1 𝑦 − 𝑦4 𝑦3 − 𝑦 𝑦 − 𝑦2 𝑦1 − 𝑦
𝐵𝑒 = ∇𝑁 =
4𝑎𝑏 𝑥 − 𝑥2 𝑥1 − 𝑥 𝑥 − 𝑥4 𝑥3 − 𝑥
fig shows a point
P(x,y) that divides the
whole triangle into
three subtriangles
with areas A1, A2,
and A3 opposite to
points P1, P2, and P3,
respectively
N1 + N 2 + N 3 = 1
The strain displacement equations for
triangular element
{ε} = [B]{u}
Triangular elements
Area coordinates or barycentric coordinates, denoted by Li.
Where the dimensionless coordinates Li (i = 1, 2, 3) or (L1, L2, L3)
1
At any point P(x,y) inside
y P A2 the triangle, we define
A3 A1
A1 L1 =
3 A
A2
L2 =
2 A
x A3
L3 =
A

Total area of the triangle A=A1+A2+A3


Note: Only 2 of the three area coordinates are independent, since
L1+L2+L3=1
Check that

L1 + L2 + L3 = 1

L1 x1 + L2 x2 + L3 x3 = x
L1 y1 + L2 y 2 + L3 y3 = y
1
L1= constant
P’
y P
A1
3
2
x

Lines parallel to the base of the triangle are lines of constant ‘L’
L1= 1
1

y P L1= 0
A1
3
2 L2= 0
L3= 1
x L =1
2
L3= 0

We will develop the shape functions of triangular elements in


terms of the area coordinates
For a 3-noded triangle

N1 = L1
N 2 = L2
N 3 = L3
How to write down the expression for N1?
Realize the N1 must be zero along edge 2-3 (i.e., L1=0) and at
nodes 4&6 (which lie on L1=1/2)

N1 = c(L1 − 0 )(L1 − 1 / 2 )
Determine the constant ‘c’ from the condition that N1=1 at
node 1 (i.e., L1=1)

N1 ( at L1 = 1) = c(1)(1 − 1 / 2 ) = 1
c=2
 N1 = 2 L1 (L1 − 1 / 2 )
quadratic interpolation functions in terms of the area
coordinates for a triangular element.

N1 = 2 L1 ( L1 − 1 / 2)
N 2 = 2 L2 ( L2 − 1 / 2)
N 3 = 2 L3 ( L3 − 1 / 2)
N 4 = 4 L1 L2
N 5 = 4 L3 L2
N 6 = 4 L3 L1
Cubic interpolation functions in terms of the area coordinates
for a triangular element( For a 10-noded triangle)

L2= 0 L1= 1
L2= 1/3 1 L1= 2/3
9
L2= 2/3 4 L1= 1/3
8
y 10 L1= 0
L2= 1 5
3
7
2 6
x
L3= 0 L3= 1/3 L3= 2/3 L3= 1
9
N1 = L1 ( L1 − 1 / 3)( L1 − 2 / 3)
2
9
N2 = L2 ( L2 − 1 / 3)( L2 − 2 / 3)
2
9
N3 = L3 ( L3 − 1 / 3)( L3 − 2 / 3)
2
27
N4 = L1 L2 ( L1 − 1 / 3)
2
27
N5 = L1 L2 ( L2 − 1 / 3)
2
27
N6 = L2 L3 ( L2 − 1 / 3)
2
27
N7 = L2 L3 ( L3 − 1 / 3)
2
:
N 10 = 27 L1 L2 L3

You might also like