Tutorial 5
Tutorial 5
ME in Structural Engineering
Finite Element Method (MSTR 515)
1. Figure 1 shows a four-node quadrilateral. The (x, y) coordinates of each node are given in the figure. The
element displacement vector q is given as q = [0,0,0.20,0,0.15,0.10,0, 0.05]T
2. In Figure 2, a half-symmetry model of a culvert is shown. The pavement load is a uniformly distributed load of 5000
N/m2. Determine the location and magnitude of maximum principal stress. (hint: develop a finite element mesh with
four-node quadrilateral elements)
Axisymmetric Solid Elements
1. An axisymmetric body with a linearly distributed load on the -conical surface is shown in Figure 1. Determine the
equivalent point loads at nodes 2, 4, and 6.
2. In Figure 2, a long cylinder of inside diameter 80 mm and outside diameter 120 mm snugly fits in a hole over its full
length. The cylinder is then subjected to an internal pressure of 2 MPa. Using two elements on the 10-mm length shown,
find the displacements at the inner radius.
3. The steel water tank shown in Figure 3 is bolted to a 5-m circular support. If the water is at a height of 3 m as shown,
find the defamed shape and stress distribution. (Note: Pressure = pgh, water density p = 1 Mg/m]. and g = 9.8m/s2.)
4. Find the deformed configuration and the stress distribution in the walls of the closed cylinder shown in Figure 4.
5. Determine the diameters after deformations and distribution of principal stresses along the radius of the infinite
cylinder subjected to the internal pressure as shown Figure 5.
Three-Dimensional Element
1. Figure 1 shows a four-node tetrahedral object. The coordinate dimensions shown are in inches. The material
is steel with E =' 30 X 106 psi and" = 0.3, Nodes 2, 3, and 4 are fixed, and a 1000 lb load is applied at node 1
as shown. Determine the displacement of node 1 using a single element.
2. Determine the deflections at the corner points of the steel cantilever beam shown in Figure 2.
clear
% material matrix
E=200*10^6; % N/mm2
mew=0.3;
E1= E*(1-mew);
E2= (1+mew)*(1-2*mew);
Eb=mew/(1-mew);
Ec=(1-2*mew)/(2*(1-mew));
D=(E1/E2)*[1 Eb 0 Eb;
Eb 1 0 Eb;
0 0 Ec 0;
Eb Eb 0 1];
K=zeros(ndof,ndof); % allocate memory for stiffness matrix
F=zeros(ndof,1);% fpr the right hand side(forces)
Dis=zeros(ndof,1);% and the displacements
%vector and rotation matrix
kel_store=cell(nel,1);
index_store=cell(nel,1);
F(1)= 5340.72/2;
F(7)= 5340.72;
F(13)= 5340.72;
F(19)= 5340.72;
F(25)= 5340.72/2;
F_ext_load=F;
%% index vector, used for populating local stiffness matrix into global
matrix
% Global stiffness matrix assembly
F_reaction=F(s)
%% Stress in element
for i=1:nel
Db=DB{i};
id=transpose(index_store{i});
dp=Dis(id);
stress{i,1}=Db*dp;
end
for i=1:nel
S=stress{i,1};
S_1(i)=S(1);
S_2(i)=S(2);
S_3(i)=S(3);
S_4(i)=S(4);
Sigma_1(i)=(S_1(i)+S_2(i))/2+sqrt((S_1(i)-S_2(i))^2/4+S_3(i)^2);
Sigma_2(i)=(S_1(i)+S_2(i))/2-sqrt((S_1(i)-S_2(i))^2/4+S_3(i)^2);
Sigma(i)=sqrt((Sigma_1(i))^2+(Sigma_2(i))^2);
end
Sigma_1=transpose(Sigma_1);
Sigma_2=transpose(Sigma_2);
Si(1)=Sigma(1)+Sigma(5)+Sigma(9)+Sigma(13)
Si(2)=Sigma(2)+Sigma(6)+Sigma(10)+Sigma(14)
Si(3)=Sigma(3)+Sigma(7)+Sigma(11)+Sigma(15)
Si(4)=Sigma(4)+Sigma(8)+Sigma(12)+Sigma(16)
Element=[1:16]'
R=transpose(r_bar(1:4));
figure (1)
plot(R,Si)
xlabel('R')
ylabel('Stress')
for i=1:ndof
if(rem(i,2)==0)
Z_dis(i)=Dis(i);
else
R_dis(i)=Dis(i);
end
end
%% for graph
for i=1:5
j=6*i-6+1;
R_displacement(i)=R_dis(j);
k=6*i-6+2;
Z_displacement(i)=Z_dis(k);
end
R_displacement=transpose(R_displacement);
Z_displacement=transpose(Z_displacement);
Node=[1;;4;7;10;13]
T1=table(Node,R_displacement,Z_displacement)
T2=table(Element,Sigma_1,Sigma_2)
5. Determine the diameter after deformations and distribution of principal
stress along the radius of the infinite cylinder subjected to the internal
pressure as shown in fig 5.
Solution:
The area of revolution to be modeled as shown below, after considering a 16mm
long piece of shaft.
clear
% material matrix
E=200*10^6; % N/mm2
mew=0.3;
E1= E*(1-mew);
E2= (1+mew)*(1-2*mew);
Eb=mew/(1-mew);
Ec=(1-2*mew)/(2*(1-mew));
D=(E1/E2)*[1 Eb 0 Eb;
Eb 1 0 Eb;
0 0 Ec 0;
Eb Eb 0 1];
F(1)= 3419.42/2;
F(7)= 3419.42;
F(13)= 3419.42;
F(19)= 3419.42;
F(25)= 3419.42/2;
F_ext_load=F;
%% index vector, used for populating local stiffness matrix into global
matrix
% Global stiffness matrix assembly
F_reaction=F(s)
%% Stress in element
for i=1:nel
Db=DB{i};
id=transpose(index_store{i});
dp=Dis(id);
stress{i,1}=Db*dp;
end
for i=1:nel
S=stress{i,1};
S_1(i)=S(1);
S_2(i)=S(2);
S_3(i)=S(3);
S_4(i)=S(4);
Sigma_1(i)=(S_1(i)+S_2(i))/2+sqrt((S_1(i)-S_2(i))^2/4+S_3(i)^2);
Sigma_2(i)=(S_1(i)+S_2(i))/2-sqrt((S_1(i)-S_2(i))^2/4+S_3(i)^2);
Sigma(i)=sqrt((Sigma_1(i))^2+(Sigma_2(i))^2);
end
Sigma_1=transpose(Sigma_1);
Sigma_2=transpose(Sigma_2);
Si(1)=Sigma(1)+Sigma(5)+Sigma(9)+Sigma(13)
Si(2)=Sigma(2)+Sigma(6)+Sigma(10)+Sigma(14)
Si(3)=Sigma(3)+Sigma(7)+Sigma(11)+Sigma(15)
Si(4)=Sigma(4)+Sigma(8)+Sigma(12)+Sigma(16)
Element=[1:16]'
R=transpose(r_bar(1:4));
figure (1)
plot(R,Si)
xlabel('R')
ylabel('Stress')
for i=1:ndof
if(rem(i,2)==0)
Z_dis(i)=Dis(i);
else
R_dis(i)=Dis(i);
end
end
%% for graph
for i=1:5
j=6*i-6+1;
R_displacement(i)=R_dis(j);
k=6*i-6+2;
Z_displacement(i)=Z_dis(k);
end
R_displacement=transpose(R_displacement);
Z_displacement=transpose(Z_displacement);
Node=[1;;4;7;10;13]
T1=table(Node,R_displacement,Z_displacement)
T2=table(Element,Sigma_1,Sigma_2)
Output:
T1 =
1 3.5448e-07 0
4 3.5362e-07 0
7 3.5446e-07 0
10 3.5532e-07 0
13 3.5455e-07 0
T2 =
1 0.96359 0.74617
2 0.86996 0.61312
3 0.64532 0.21883
4 0.59428 0.14498
5 0.93528 0.67856
6 0.87102 0.61185
7 0.63236 0.18353
8 0.59582 0.14454
9 0.93627 0.67713
10 0.87196 0.61035
11 0.63317 0.18191
12 0.59667 0.14306
13 0.93556 0.67402
14 0.84547 0.54669
15 0.63425 0.18062
16 0.58436 0.10878
Thus the outer diameter is 100mm before deformation and 107.8 mm after
deformation.