You are on page 1of 43

Question Repository for JUNE/JULY 2022 Examinations

Subject Code 19ME411 Subject Name Finite Element analysis Common To


Faculty Mechanical Engineering
G.R.RAM PRASATH Department Mechanical Engineering
Name
(PART A – 2
Marks)
UNIT - I
Q. No Questions Scheme of Evaluation
State the three phases of finite element method.
QA101 ANS: Answer – 2 Marks
1. Preprocessing 2. Analysis 3. Post Processing
What is meant by degrees of freedom?
ANS:
QA102 Answer – 2 Marks
When the force or reaction act at nodal point node is subjected to deformation. The deformation
includes displacement rotation, and or strains. These are collectively known as degrees of freedom
Name the weighted residual method
ANS:
QA103 1. Point collocation method 2. Sub domain collocation method 3. Least squares method 4. Galerkins Answer – 2 Marks
method.
What is Aspect ratio?
ANS:
QA104 It is defined as the ratio of the largest dimension of the element to the smallest dimension. In many Answer – 2 Marks
cases, as the aspect ratio increases the in accuracy of the solution increases. The conclusion of many
researches is that the aspect ratio
What is meant by discretization and assemblage?
ANS:
QA105 The art of subdividing a structure in to convenient number of smaller components is known as Answer – 2 Marks
discretization. These smaller components are then put together. The process of uniting the various
elements together is called assemblage

UNIT - II
Q. No Questions Scheme of Evaluation
Write down the general finite element equation.
QA201 ANS: Answer – 2 Marks
{F }=[K ]{u}
Define shape function.
ANS:
In finite element method, field variables within an element are generally expressed by the
following approximate relation:
QA202 Answer – 2 Marks
u (x,y) = N1(x,y) u1+N2 (x,y) u2+ N3(x,y) u3
Where u1 u2, u3 are the values of the field variable at the nodes and N1 N2 N3 are interpolation function.
N1 N2 N3 is called shape functions because they are used to express the geometry or shape of the
element.
How do you calculate the size of the global stiffness matrix?
QA203 ANS: Answer – 2 Marks
Global stiffness matrix size = Number of nodes X Degrees of freedom per node.
State the properties of a stiffness matrix
ANS:
The properties of the stiffness matrix [K] are,
QA204 Answer – 2 Marks
1. It is a symmetric matrix
2. The sum of the elements in any column must be equal to zero.
3. It is an unstable element, so the determinant is equal to zero.
Why polynomials are generally used as shape function?
ANS:
Polynomials are generally used as shape functions due to the following reasons:
QA205 Answer – 2 Marks
1. Differentiation and integration of polynomials are quite easy.
2. The accuracy of the results can be improved by increasing the order of the Polynomial.
3. It is easy to formulate and computerize the finite element equations.

UNIT - III
Q. No Questions Scheme of Evaluation
How do you define two dimensional elements?
ANS:
QA301 Answer – 2 Marks
Two dimensional elements are define by three or more nodes in a two dimensional plane. The basic element
useful for two dimensional analysis is the triangular element.
QA302 Differentiate CST and LST elements. Answer –
ANS: CST-1 Mark
Three nodded triangular element is known as constant strain triangular element. It has 6 unknown degrees LST-1 Mark
of freedom called u1, v1, u2, v2, u3, v3. The displacement function for the element are linear as in the CST such
element is called CST because it has constant strain throughout it.
Six nodded triangular element is known as Linear Strain Triangular element. It has 12 unknown
displacement degrees of freedom. The displacement function for the element are quadratic.
What is QST element?
ANS:
QA303 Answer – 2 Marks
Ten nodded triangular elements are known as Quadratic strain triangle. It is also called as cubic displacement
triangle.
What meant by plane stress and plane strain analysis?
ANS:
1. Plane stress is defined to be a state of stress in which the normal stress and shear stress directed
QA304 Answer – 2 Marks
perpendicular to the plane are assumed to be zero.
2. Plane strain is defined to be state of strain normal to the xy plane and the shear strains are assumed
to be zero.
Write the strain displacement relation for CST element.
ANS:

QA305 Answer – 2 Marks

UNIT - IV

Q. No Questions Scheme of Evaluation

Write down the stiffness matrix equation for two dimensional CST elements.
ANS:
QA401 Answer – 2 Marks
Stiffness matrix [K ]=[B ]T [D ][B ]At
[B]T -Strain displacement [D]-Stress strain matrix [B]-Strain displacement matrix
What is axisymmetric element?
ANS:
QA402 Answer – 2 Marks
Many three dimensional problem in engineering exhibit symmetry about an axis of rotation such type of
problem are solved by special two dimensional element called the axisymmetric element
QA403 What is meant by Isoparametric element? Answer – 2 Marks
ANS:
If the number of nodes used for defining the geometry is same as number of nodes used for defining the
displacement is known as Isoparametric element.
What is meant by axisymmetric field problem? Give example.
ANS:
In some of the three dimensional solids like flywheel, turbine, discs etc, the material is symmetric with
QA404 Answer – 2 Marks
respect to their axes. Hence the stress developed is also symmetric. Such solids are known as
axisymmetric solids. Due to this condition, three dimensional solids can be treated as two dimensional
elements.
Give the stiffness matrix equation for an axisymmetric triangular element.
ANS:
QA405 Answer – 2 Marks
Stiffness matrix [K ]=[B ]T [D ][B ]2π.r.A

UNIT - V
Q. No Questions Scheme of Evaluation
What is natural coordinates?
ANS:
QA501 Natural coordinate system is basically a local coordinate system which allows the specification of a point Answer – 2 Marks
within the element by a set of dimensionless numbers whose magnitude never exceeds unity.
A simple natural coordinate is one whose value between -1 and 1.
What do you mean by iso parametric formulation?
ANS:
The principal concept of isoparametric finite element formulation is to express the element coordinates
QA502 and element displacements in the form of interpolations using the natural coordinate system of the Answer – 2 Marks
element. These isoparametric elements of simple shapes expressed in natural coordinate system,
known as master elements, are the transformed shapes of some arbitrary curves sided actual elements
expressed in Cartesian coordinate system.
QA503 What is a Jacobian matrix of transformation? Answer – 2 Marks
ANS:
It’s the transformation between two different co-ordinate system. This transformation is used to evaluate
the integral expression involving ‘x’ interms of expressions involving ε.
The differential element dx in the global co-ordinate system x is related to differential element dε in
natural co-ordinate system ε by
dx = dx/ dε . dε
dx = J . dε
Jacobian matrix of transformation J =dx/ dε

J=
Explain Gauss quadrature rule?
ANS:
The idea of Gauss Quadrature is to select “n” Gauss points and “n” weight functions such that the
integral provides an exact answer for the polynomial f(x) as far as possible, Suppose if it is necessary to
QA504 evaluate the following integral using end point approximation then Answer – 2 Marks

Differentiate the serendipity and langrangian elements


ANS:
Serendipity elements langrangian elements
QA505 In discretized element In discretized element, if nodes Answer – 2 Marks
if nodes lies on corner, then the are present in both centre of element
element are known as serendipity and corner are known as langrangian
elements. elements.
(PART B – 13 Marks - Either Or Type)

UNIT - I
Q. No Questions Scheme of Evaluation
Find the deflection at the center of a simply supported beam of span length “l” subjected to uniformly
distributed load throughout its length as shown in figure using Galerkin’s method.

ANS:

Trial Function – 3 Marks


Step by step derivation – 7
QB101 (a) Marks
Result – 3 Marks

(Or)
Solve the differential equation for a physical problem expressed as
d2y/dx2 + 100 = 0, 0≤x≤10  with boundary conditions as y(0)=0 and y(10)=0 using Galerkin’s method.
Assume trial function y=a1 x(10-x)
ANS:
Check whether trial function Satisfies boundary Condition
y=a1 x(10-x)

Trial Function – 3 Marks


Step by step derivation – 7
QB101 (b) Marks
Result – 3 Marks

QB102 (a) Consider a 1mm diameter, 50m long aluminum pin-fin as shown in figure used to enhance the heat Trial Function – 3 Marks
transfer from a surface wall maintained at 300oC. Calculate the temperature distribution in a pin-fin by Step by step derivation – 7
using Galerkin’s  method. Marks
Result – 3 Marks
Take, 𝒌 = 𝟐𝟎𝟎𝒘/𝒎 o𝐂 for aluminum h= 𝟐𝟎𝟎𝒘/𝒎𝟐 o𝐂, 𝑻∞ = 𝟑𝟎 o𝐂.
ANS:

𝜋 = 𝑠𝑡𝑟𝑎𝑖𝑛 𝑒𝑛𝑒𝑟𝑔𝑦 − 𝑤𝑜𝑟𝑘 𝑑𝑜𝑛𝑒


𝜋=𝑢–𝑣
(Or)
QB102 (b) A simply supported beam subjected to uniformly distributed load over entire span and it is subject to a Trial Function – 3 Marks
point load at the center of the span. Calculate the bending moment and deflection at midspan by using Step by step derivation – 7
Rayleigh – Ritz method Marks
Result – 3 Marks

ANS:
𝜋 = 𝑠𝑡𝑟𝑎𝑖𝑛 𝑒𝑛𝑒𝑟𝑔𝑦 − 𝑤𝑜𝑟𝑘 𝑑𝑜𝑛𝑒
QB103 (a) The following differential equation is available for a physical phenomenon. 𝑨𝑬 = 𝒅𝟐𝒖 / 𝒅𝒙𝟐 + 𝒂𝒙 = 𝟎, Trial Function – 3 Marks
Step by step derivation – 7
The boundary conditions are Marks
u(0) = 0, Result – 3 Marks
𝑨𝑬 = 𝒅𝒖 / 𝒅𝒙|𝒙=𝑳 = 𝟎
By using Galerkin’s technique, find the solution of the above differential equation.
ANS:
(Or)
A linear elastic spring is subjected to a force of 1000N as shown in figure calculate the displacement
and the potential energy of the spring.

Formulation – 3 Marks
Step by step derivation – 7
QB103 (b) ANS: Marks
Result – 3 Marks

UNIT - II
Q. No Questions Scheme of Evaluation
QB201 (a) For the beam and loading shown in fig. calculate the nodal displacements. Formulation – 3 Marks
Take [E] =210 Gpa =210×109 𝑵/𝒎 , [I] = 6×10-6 m4 Step by step derivation – 7
Marks
Result – 3 Marks
ANS:
(Or)
QB201 (b) Determine the axial vibration of a steel bar shown in fig. Take [E] =2.1×105𝑵/𝒎𝒎𝟐, [ρ] = 7800 Formulation – 3 Marks
𝒌𝒈/𝒎𝟑 Step by step derivation – 7
Marks
ANS:

Result – 3 Marks

For a tapered plate of uniform thickness t = 10mm as shown in fig. find the displacements at the nodes Formulation – 3 Marks
QB202 (a)
by forming in to two element model. The bar has mass density ρ = 7800𝑲𝒈/𝒎𝟑 Young’s modulus E = Step by step derivation – 7
2×105𝑴𝑵/𝒎𝟐. In addition to self weight the plate is subjected to a point load p = 10KN at its Centre.
Also determine the reaction force at the support.

ANS:

Marks
Result – 3 Marks

(Or)
Consider the simply supported beam shown in fig. let the length L=1m, E=2×1011𝑵/𝒎𝟐, area of cross
section A=30cm2, moment of inertia I=100mm4, density[ρ] = 7800𝒌𝒈/𝒎𝟑. Determine the natural
frequency using two types of mass matrix. Lumped mass matrix and consistent mass matrix.

ANS:

Formulation – 3 Marks
Step by step derivation – 7
QB202 (b) Marks
Result – 3 Marks

QB203 (a) A wall of 0.6m thickness having thermal conductivity of 1.2 W/mk. The wall is to be insulated with a Formulation – 3 Marks
material of thickness 0.06m having an average thermal conductivity of 0.3 W/mk. The inner surface Step by step derivation – 7
temperature in 1000OC and outside of the insulation is exposed to atmospheric air at 30oc with heat Marks
transfer coefficient of 35 W/m2k. Calculate the nodal temperature. Result – 3 Marks
ANS:

(Or)
Derivation of the displacement function u and shape function N for one dimensional linear bar
element.
ANS: Formulation – 3 Marks
Step by step derivation – 7
QB203 (b) Marks
Result – 3 Marks

UNIT - III
Q. No Questions Scheme of Evaluation
For the Plane Stress element shown in fig,

the nodal displacement are : u1= 2mm , v1= 1mm , u2= 0.5mm , v2= 0 mm, u3= 3mm , v3= 1 mm.
Determine the element stress σx, σy, τxy, σ1, σ2 and the Principal angles  .  E=210GPa, µ=0.25 ,
t=10mm.All co-ordinates are in millimeters.
ANS:

Formulation – 3 Marks
Step by step derivation – 7
QB301 (a) Marks
Result – 3 Marks

(Or)
QB301 (b) Calculate the element stiffness matrix and the temperature force vector for the plane stress element as Formulation – 3 Marks
shown in figure. The element experiences a 20°C increase in temperature, Assume coefficient of
thermal expansion is 6 x 10-6/°C Take Young’s modulus E = 2 X 105N/mm2,possion ratio
v=0.25,Thickness t= 5mm.

ANS:

Step by step derivation – 7


Marks
Result – 3 Marks

QB302 (a) Derive the Shape function for the Constant Strain Triangular element (CST). Step by step derivation – 13


ANS: Marks
(Or)
QB302 (b) compute the element matrix and vectors for the element shown in fig. Formulation – 3 Marks
Step by step derivation – 7
Marks
Result – 3 Marks
when the edges 2-3 and 3-1 experience convection heat loss.
ANS:

QB303 (a) Derive the Shape function for the six noded triangular elements. Step by step derivation – 13


Marks
ANS:

(Or)
For the triangular element shown in fig.

Formulation – 3 Marks
Step by step derivation – 7
QB303 (b) Obtain the strain-displacement matrix [B] and determine the strain ex  , ey   ,exy Marks
ANS: Result – 3 Marks
UNIT - IV
Q. No Questions Scheme of Evaluation
 For the axe symmetric element shown in fig .Determine the element stresses. Take E= 2.1x 105 N/
mm2 𝑣 = 0.25 The co-ordinates shown in fig are in mm. The nodal displacements are
 u1=0.05 mm, u2=0.02 mm, u3=0.0 mm, w𝟏 = 𝟎. 𝟎𝟑 𝒎𝒎, w𝟐 =𝟎. 𝟎𝟐 𝒎𝒎, w𝟑 = 𝟎 𝟎 𝒎𝒎.

Formulation – 3 Marks
Step by step derivation – 7
QB401 (a) ANS: Marks
Result – 3 Marks

(Or)
Calculate the element stiffness matrix and the thermal force vector for the axisymmetric triangular ele Formulation – 3 Marks
QB401 (b)
ment shown in figure. The element experiences a 150c increase in temperature. The co-ordinates are in Step by step derivation – 7
mm. Take α= 10 x 10-6/0c ; E= 2x 105 N/mm2 , 𝑣 = 0.25

ANS:

Marks
Result – 3 Marks
Determine the stiffness matrix [K] for the element having nodal coordinates (0,0) , (50,0) , (50,50)
take E = 200GPa , 𝑣 = 0.25.(all co-ordinates are in 'mm' ).
ANS:

Formulation – 3 Marks
Step by step derivation – 7
QB402 (a) Marks
Result – 3 Marks

(Or)
QB402 (b) Derive  the  expression  for  stress  –  strain  relationship  for  a 2D element? Step by step derivation – 13
ANS: Marks
Derive  the  expression  for  strain-displacement relationship for axisymmetric element.
ANS:

Step by step derivation – 13


QB403 (a) Marks

(Or)
QB403 (b) The nodal co-ordinates for an axisymmetric triangular element are given . Formulation – 3 Marks
r1 =10mm ,r2  = 30mm , r3  =30mm  Step by step derivation – 7
z1 =10mm,z2  =10mm , z3 =40mm  Marks
Evaluate [B] matrix for that element. Result – 3 Marks
ANS:
UNIT - V
Q. No Questions Scheme of Evaluation
QB501 (a) For the isoparametric quadrilateral element shown in Fig. Formulation – 3 Marks
Step by step derivation – 7
Marks
Result – 3 Marks

the Cartesian co-ordinate of point P are (6,4). The loads 10KN and 12KN are acting in x and y
direction on the point P. Evaluate the nodal equivalent forces.
ANS:
(Or)

Step by step derivation – 13


 Derive the shape function for the Eight Noded Rectangular Element
QB501 (b) Marks
ANS:
For the isoparametric four noded quadrilateral element shown in fig. Determine the Cartesian co-
ordinates of point P which has local co-ordinates ε= 0.5 , η =0.5

Formulation – 3 Marks
Step by step derivation – 7
QB502 (a) Marks
Result – 3 Marks
ANS:
(Or)
Evaluate the integral

using Gaussian integration with one, two , three integration points and compare with exact solution.
Formulation – 3 Marks
ANS: Step by step derivation – 7
QB502 (b) Marks
Result – 3 Marks

Derive the shape function for 4 noded rectangular parent element by using natural Step by step derivation – 13
QB503 (a) co- ordinate system and co-ordinate transformation. Marks
ANS:
(Or)
Integrate the function f(r) = 1+ r + r + r between the limit -1 and +1 using (i) Exact method (ii) gauss
2  3 

integration method and compare the two results.


ANS:

Formulation – 3 Marks
Step by step derivation – 7
QB503 (b) Marks
Result – 3 Marks
(PART C – 15 Marks - Either Or Type)

UNIT - I
Q. No Questions Scheme of Evaluation
Solve the differential equation for a physical problem expressed as
d2y/dx2 + 50 = 0, 0≤x≤10 with boundary conditions as
Formulation – 3 Marks
y (0) = 0 and y (10) = 0
Step by step derivation – 9
using the trial function y = a1x (10-x) find the value of the parameters a1 by the following methods
QC101 (a) Marks
listed below. (i) Point collocation method (ii) Sub domain collocation method (iii) Least squares
Result – 3 Marks
method and (iv) Galerkin method
ANS:
a = 25 (in all methods)
(Or)
Determine the expression for deflection and bending moment in a simply supported beam subjected to
uniformly distributed load over entire span. Find the deflection and moment at mid span and compare
with exact solution Rayleigh-Ritz method. Use

ANS:
Formulation – 3 Marks
Step by step derivation – 9
QC101 (b) Marks
Result – 3 Marks
UNIT - II
Q. No Questions Scheme of Evaluation
Derive the shape function, stiffness matrix and load vector for one dimensional bar element.
ANS:

Step by step derivation – 15


QC201 (a) Marks

(Or)
QC201 (b) A simple frame structure is shown in figure. Estimate the element stiffness matrix and assemble in the Formulation – 3 Marks
global format. Step by step derivation – 9
Marks
Result – 3 Marks

 
ANS:
UNIT - III
Q. No Questions Scheme of Evaluation
QC301 (a) A thin plate is subjected to surface traction as shown in figure. Calculate the global stiffness matrix. Formulation – 3 Marks
Step by step derivation – 9
Marks
Result – 3 Marks

Take Young’s modulus E = 2 X 105N/mm2, Poisson's ratio v=0.30, Thickness t=25mm.Assume


plane stress condition.
ANS:
(Or)
Derive the shape function of a quad lateral element as shown in figure by applying finite element
technique.

Step by step derivation – 15


QC301 (b) Marks
ANS:

UNIT - IV
Q. No Questions
QC401 (a) A long hollow cylinder of inside diameter 100 mm and outside diameter 140 mm is subjected to an Formulation – 3 Marks
internal pressure of 4 N/mm2 as shown in figure. Step by step derivation – 9
Marks
Result – 3 Marks
(i) By using two elements on the 15 mm length shown in figure.
(ii) Calculate the displacements at the inner radius Take E=2×105 N/mm2.  ν = 0.3.
ANS:
(Or)
Derive the shape function for axisymmetric triangular element .
ANS:

Step by step derivation – 15


QC401 (b) Marks

UNIT - V
Q. No Questions Scheme of Evaluation
QC501 (a) A four noded rectangular element is shown in Fig. Formulation – 3 Marks
Step by step derivation – 9
Marks
Result – 3 Marks

Determine the following
1.jacobian matrix
2. Strain – Displacement matrix
3. Element Stresses.
ANS:
(Or)
QC501 (b) For the element shown in fig. Determine the Jacobian matrix. Formulation – 3 Marks
Step by step derivation – 9
Marks
Result – 3 Marks

ANS:
Knowledge Level (Blooms Taxonomy)

Applying
K1 Remembering (Knowledge) K2 Understanding (Comprehension) K3
(Application of Knowledge)

K4 Analysing (Analysis) K5 Evaluating (Evaluation) K6 Creating (Synthesis)

Note: For each Question, mention as follows


(i) K1 or K2 etc. for Knowledge Level
(ii) CO1, CO2 etc. for Course Outcomes
(iii) Any number from 1 to 5 for Difficulty Level (With 1 as Most Easy & 5 as Most Difficult)

You might also like