Download as docx, pdf, or txt
Download as docx, pdf, or txt
You are on page 1of 17

FRANCIS XAVIER ENGINEERING AND TECHNOLOGY

DEPARTMENT OF MECHANICAL ENGINEERING


ME 8692- FINITE ELEMENT ANALYSIS
UNIVERSITY QUESTIONS – PART A
S.No Question Univ
Qn
1. What are the methods generally associated with the finite element analysis? Apr-
(i) Force method – Internal forces are considered as the unknowns of the May
problem. 16
(ii) Displacement of stiffness method.- Displacements of the nodes are
considered as the unknowns of the problem.
2. If a displacement field in x direction is given by Apr-
u = 2x2+4y2+6xydetermine strain in x direction. May
u=2 x 2 +4 y 2+6 xy 16
∂u
Strain e=
∂x
e=4 x+ 6 y
3. List the various methods of boundary value problems. Nov-
(i) Weighted Residual Method Dec
(ii) Rayleigh Ritz Method 16
4. What is meant by post processing? Nov-
Analysis and evolution of the solution result is referred to as post processing. Dec
Post processer computer program helps the user to interpret the result by 16
displaying them in graphical form.
5. What do you mean by constitutive law? Apr-
For a finite element, stress-strain relations are expressed as follows: May
{ σ }=[ D ] {e } 17
{ σ }=¿stress
{e} = strain
[D] = stress-strain relationship matrix or constitutive matrix
This equation is known as constitutive law.
6. Why polynomial type interpolation functions are mostly used in FEM? Apr-
The polynomial type of interpolation functions are mostly used due to the May
following reasons: 17
i) it is easy to formulate and computerize the finite element equations.
ii) It is easy to perform differentiation or integration
iii) The accuracy of the results can be improved by increasing the order of the
polynomial.
7. List the various weighted residual methods. Nov-
 Point collocation method Dec
 Sub-domain collocation method 17
 Least squares method
 Galerkin‟s method.
8 Compare the Ritz technique with the nodal approximation technique.
Variational method Weighted Residual method Apr-
Approximate solution needs only Approximate solution should May
to satisfy essential boundary satisfy both essential and natural 18

1
conditions boundary conditions
Weight functions is Weight function is selected
selected according to independent of the approximate
approximate solution functions
9 Differentiate between primary and secondary variables with suitable examples. Apr-
For example: In structural problem, first we find out the value of displacements May
(u). That displacement is called as a primary variable. 18
Then we find the value stress and strain using the displacement. The stress and
strain are called as a secondary variable.
10 What are h and p versions of finite element method? Nov-
It is used to improve the accuracy of the finite element method. In h version, Dec
the order of polynomial approximation for all elements is kept constant and the 18
numbers of elements are increased. In p version, the numbers of elements are
maintained constant and the order of polynomial approximation of element is
increased.
11 Why is variational formulation referred to as weak formulation? Nov-
Thus the trail function assumed need only satisfy the “essential” boundary Dec
condition at x=0, u(0) =0. This form of the weighted residual statement is 18
called the weak form of the weighted residual statement. It is referred to as the
weak form because of the weaker continuity demand on the trail solution.
12 The general weighted residual technique is expressed as ∫ R ( x ) wi ( x ) dx=0 , Apr-
i=1,2,….,n identify the weighting function associated with each of the WRMs May
19

13 Distinguish between Essential and natural boundary conditions with suitable Apr-
examples. May
There are two types of boundary conditions. 19
They are:
1. Primary boundary condition (or) Essential boundary condition
The boundary condition, which in terms of field variable, is known as primary
boundary condition.
2. Secondary boundary condition or natural boundary conditions The boundary
conditions, which are in the differential form of field variables, are known as
secondary boundary condition. Example: A bar is subjected to axial load as
shown in fig.

2
In this problem, displacement u at node 1 = 0, that is primary boundary
condition. EA du/dx = P, that is secondary boundary condition.
14 How will you mathematically model a long thin bar of varying cross section NOV
fixed at the upper end and subjected to its own self weight and a point load at /DEC
the lower free end? 2019
d
¿
dx
g(x) is the body force
15 What are the limitations of using a finite difference method? A/M
This method is difficult to use when regions have curved or irregular 10
boundaries and it is difficult to write general computer programs
16 During discretization, mention the places where it is necessary to place a node? Expe
(i) Concentrated load acting point cted
(ii) Cross section changing point Ques
(iii) Different material inter junction point tion
(iv) Sudden change in load point
17 Name any four FEA software. Expe
1.ANSYS 2.NASTRAN 3.COSMOS 4.NISA .Que
sti
18 What should be considered during piecewise trial functions? A/M
1. It should satisfy given boundary conditions and governing equations. 11
2. It should be differentiable as many times as needed by the given governing
equations.
19 Mention the basic steps of Rayleigh Ritz method. A/M
Finding out the total potential energy 11
Apply the principle of minimum potential energy principle.
Calculating the Ritz Parameter.
20 Give two sketches of structures that have both discrete elements and M/J
continuum. 12
Discrete Elements: Truss and Frame

Continuum Elements: Thin plates, shells

21 State the principle of minimum potential energy. M/J


It states that, “Among all the displacement equations that satisfy internal 12
compatibility and the boundary conditions, those that also satisfy the equations
of equilibrium make the potential energy a minimum in a stable system.
22 Distinguish between error in solution and residual. A/M
Residual: After applying the boundary conditions in the assumed trial solution 15
and given governing equations, we left with term residual.
3
Error: Difference between the exact solution and fea solution.

23 State the principle of virtual work. Dec


A body is in equilibrium if the internal virtual work equals the external virtual 2006
work for every kinematically admissible displacement field.

UNIT 2
ONE DIMENSIONAL PROBLEM
PART A
List all the differences between two noded linear and three noded quadratic bar N/D
element. 19
Two noded linear bar element having nodes at its end point. So we cannot find
the behaviour of field variable (Temperature, displacement) in-between points.
1
Three noded quadratic bar element having nodes at its end points also in-
between to the end points. We can find the behaviour of field variable
(Temperature, displacement) in-between points. It gives more accurate value
compared to the two noded linear elements.
Give the primary and secondary variables associated with the one dimensional N/D
beam element and their values at the boundary for a fixed-fixed beam and a 19,
2 simply supported beam. N/D
Deflection and slope or rotation is the primary variable. 17
Moments and forces are the secondary variable.
3 What are the differences between a beam element and a bar element? A/M
Bar element: When it is subjected to external load only axial deformations 19
occur. (or) Bar element is used to know when a structure is subjected to axial
deformation.
Beam Element: It will be used when the structure is subjected to transverse
load.
4 Derive the shape functions for a 1D three noded element. Or Derive the shape A/M
functions for a 1 D quadratic bar element. 19
A/M
15

Polynomials are generally used in shape function, why? N/D


1. Differentiation and integration of polynomial are quite easy. 18
5 2. It is easy to formulate and computerize the finite element equations. N/D
3. The accuracy of the results can be improved by increasing the order of the 16
polynomial.
6 Differentiate between longitudinal vibration and transverse vibration N/D
Longitudinal Vibrations: When the particles of the shaft or disc moves parallel 18
to the axis of the shaft, then the vibrations are known as Longitudinal

4
vibrations.

Transverse Vibrations: When the particles of the shaft or disc move


approximately perpendicular to the axis of the shaft, then the vibrations are
known as transverse vibrations.

What are the properties of stiffness matrix? A/M


1. It is a symmetric matrix. 18,
2. The sum of elements in any column must be equal to zero. A/M
7
3. It is an unstable element. So, the determination is equal to zero. 15
4. The diagonal coefficients are always positive and relatively large when
compared to the off-diagonal values in the same row.
Write the conduction, convection and thermal load matrices for 1D heat A/M
transfer through a fin. 18

9 Write the natural frequency of bar of length ‘L’, Young’s modulus ‘E’ and N/D
cross section ‘A’ fixed at one end carrying lumped mass ‘M’ at the other end. 17

5
10 Write down the expression of longitudinal vibration of bar element. A/M
17

11 What are the difference between boundary value problem and initial value A/M
problem? 17
The solution of differential equation is obtained for physical problems which
satisfies some specified conditions known as boundary conditions.
The differential equation together with these boundary conditions, subjected to
a boundary value problem.
The differential equation together with these boundary conditions, subjected to
a boundary value problem

12 Write down the expression of governing equation for free axial vibration of M/J
rod and transverse vibration of beam. 16

6
13 What is the stationary property of total potential energy? M/J
16

What is discretization? N/D


14 The art of subdividing a structure into a convenient number of smaller 15
components is known as discretization.
15 Write down the expression of stiffness matrix for a truss element. N/D
l,m are the direction cosines, 15
A = Cross Sectional Area; E = Young’s Modulus;

State the significance of shape function M/J


16 With the use of shape function we can find the behaviour of field variable 13
(Temperature, Displacement) at the interior nodes of the element.
State the principles of virtual work. N/D
17 A body is in equilibrium if the internal virtual work equals the external virtual 06
work for every kinematically admissible displacement field.
State the principle of minimum potential energy. N/D
The principle of minimum potential energy states: Among all the displacement 07
18 equations that satisfy internal compatibility and the boundary conditions, those
that also satisfy the equations of equilibrium make the potential energy a
minimum in a stable system.
19 Write down the expression of shape function N and displacement u for one Jan 06
dimensional bar element.
For one dimensional bar element,

20 Write the stiffness matrix for a one dimensional 2 noded linear element Nov-
Stiffness matrix [K]= ∫ [𝐵] 𝑇 𝑣 [𝐷][𝐵]𝑑𝑣 Dec
7
17

UNIT 3
TWO DIMENSIONAL SCALAR VARIABLE PROBLEMS
S.No Question Univ
Qn
1 Write down the shape functions associated with the three noded linear A/M
triangular elements and plot the variation of the same. 15
p 1+q 1 x +r 1 y
N 1=
2A
p 2+ q 2 x +r 2 y
N 2=
2A
p 3+q 3 x+ r 3 y
N 3=
2A

2 Give at least one example each for plane stress and plane strain analysis. A/M
Plane Stress: Plate with a hole, Plate with a fillet 15
Plane Strain: Dam subjected to horizontal loading, pipe subjected to vertical
loading
3 Define pathline and streamline M/J
A path line is defined as locus of points through which a fluid particle of fixed 16
identity passes as it moves in space.
A streamline is an imaginary line that connects a series of points in space at a
given instant in such a manner that all particles falling on the line at that instant
have velocities whose vectors are tangent to the line.
4 Write a displacement function equation for CST element. M/J
16

5 What is CST element? N/D


A three noded triangular element is known as constant strain triangular 15
element. It has six unknown displacement degrees of freedom (u1, v1, u2, v2, u3,
v3). The element is called as CST because it has a constant strain throughout it.

8
6 Define plane strain analysis. N/D
Plane strain is defined to be a state of strain in which the strain normal to the 15
xy plane and the shear strains are assumed to be zero.
7 State the assumptions in the theory of pure torsion. N/D
The material of the shaft is homogeneous, perfectly elastic and obey’s hooke’s 16
law.
Twist is uniform along the length of the shaft.
The stress does not exceed the limit of proportionality.
The shaft circular in section remains circular after loading.
Strain and deformations are small.
8 What is an LST element? N/D
A six noded triangular element is known as Linear Strain Triangular element. It 16
has twelve unknown displacement degrees of freedom.

9 What is QST element? A/M


Ten noded triangular elements are known as quadratic strain triangle. It is also 17
called cubic displacement triangle.

10 Write down the stress-strain relationship matrix for plane strain condition. A/M
17

E- Young’s Modulus ν=Poisson’s ratio

11 Write the natural frequency of bar length ‘L’, Young’s modulus ‘E’ and cross N/D
section ‘A’ fixed at one end and carrying lumped mass ‘M’ at the other end. 17

9
12 Write the governing equation for the torsion of non circular sections and give N/D
the associated boundary conditions. 17

13 Write down the shape functions for a 4 noded quadrilateral element. A/M
18

14 Distinguish between scalar and vector variable problems in 2D. A/M


2D Scalar: In this problem, the variable having only magnitude. It is having 18
single dof. Ex Thermal, Fluid mechanics, Torsion problem
2D Vector: In this problem, the variable having both magnitude and direction.
It is having 2 dof. Ex Asisymmetric, Plate and Shell elements
15 Classify elements, based on their dimensions. N/D
Elements are classified into three types based on their dimensions 18
1D element, 2 D element, 3D element.
16 What is steady state heat transfer and write its governing equation. N/D
Under Steady state conditions the temperature within the system does not 18
change with time.

17 Distinguish between CST and LST element. A/M


A three noded triangular element is known as constant strain triangular 19
element. It has six unknown displacement degrees of freedom (u1, v1, u2, v2, u3, N/D
10
v3). The element is called as CST because it has a constant strain throughout it. 18

A six noded triangular element is known as Linear Strain Triangular element. It


has twelve unknown displacement degrees of freedom.

18 Write the stiffness matrix used for the torsion problem of a square shaft A/M
assuming three noded triangular elements of area A. 19

19 A four noded quadrilateral element gives a better approximation than a three N/D
noded triangular element, Explain why. 19
A four noded quadrilateral element guarantees the continuity of displacements
across inter-element boundary edges than the 3 node triangular elements
20 Write down the shape functions for a linear strain triangular element used for a N/D
scalar variable problem. 19

21 Write the strain displacement matrix for a 3noded triangular element A/M
18

N/D
11
16

22 Write down the shape function for a 4 noded bi linear rectangular element. N/D
17

23

UNIT 4
TWO DIMENSIONAL VECTOR VARIABLE PROBLEMS
S.No Question Univ
Qn
1 Write the constitutive matrix for axisymmetric analysis. N/D
19

2 Give one practical example each for plane stress analysis and plane strain N/D
analysis indicating the primary variables. 19

Primary variables will be displacement for structural problems and for heat
transfer problems temperature will be the primary variable.
Plane stress: Thin plate, Beams, Web frames of tonkers.
12
Plane strain: Tunnel, Dam, Long cylinder tube with pressure.
3 What is meant by constitutive matrix? Write the same for plane stress analysis. A/M
Stress strain relationship matrix is called as constitutive matrix. 19

M/J
16

4 Brief the type of element that is best suited for analyzing a thin dome shaped A/M
structure subjected to out of plane load. 19
Axisymmetric elements with plane stresses conditions used to analyze a thin
dome shaped structure subjected to out of plane load
5 Give four applications where axisymmetric elements can be used. N/D
Pressure Vessels, cylinders loaded by uniform internal or external pressures, 18
flywheels, turbine discs, circular footings resting on a soil mass.
6 Distinguish between plate and shell elements. A/M
A shell element is a curved surface, which by virtue of their shape can 18
withstand both membrane and bending forces. A shell structure can take higher
loads, membrane stresses and predominant, which is primarily caused due to
in-place forces.
A plate is a planar structure with a very small thickness in comparison
to the planar dimensions. The forces applied on a plate are perpendicular to the
plane of the plate.
7 What are the ways by which a 3D problem can be reduced to a 2D problem? N/D
By using axisymmetric concept, the three dimensional problems like 17
stress analysis of piston, storage tanks, pressure vessels etc. Can be reduced to A/M
two dimensional problems. Sometimes, the plane stress and plane strain 17
concepts also help us to analyze the 3D problems as 2D problems

8 What are the types of shell element? M/J


 Flat shell element 16
 Solid shell element
 Curved shell element
 Degenerated shell element
9 Sketch a finite element model for a long cylinder subjected to an internal N/D
pressure using axisymmetric elements. 13

13
10 Distinguish between plane stress and plane strain conditions. OR What is N/D
meant by plane stress/plane strain analysis? 16
For the plane stress problem, the solid for analysis will be thin
(thickness is negligibly small) and hence the stress developed in the plane N/D
perpendicular to thickness will be zero. Mathematically σz, τyz, τzx are zero. A 13
good example for plane stress problem is the ring press-fitted on a shaft.
For a plane stress problem, the analysing solid may have very long
length and hence the deformation produced along the direction parallel to the
length will be assumed zero. Hence the strain in that direction will be zero.
Mathematically ez, νyz, νzx are zero.

11 What is meant by axisymmetric field problem? Give an example. N/D


 The problem domain must be symmetric about the axis of revolution. 09
 All boundary conditions must be symmetric about the axis of
revolution.
 All loading conditions must be symmetric about the axis of revolution.

12 List the required conditions for a problem assumed to be axisymmetric. M.J


The required conditions to be satisfied are such that the material 13
content. Loading conditions, boundary conditions and material properties like
strength, nature etc. Should be symmetric with respect to axis of revolution.
13 What are the assumptions used in thin plate and thick plate elements? A/M
Thin plate element 17
1. The line normal to the neutral axis before bending remains straight after
loading.
2. The transverse shearing strains are assumed to be zero. i.e shear strain ν xz
and νyz will be zero.

Thick plate element:


1. The deflections of the plate are small.
2. Stresses normal to the mid-surface are negligible.
3. Normal to the plate mid-surface before deformation remains straight but is
not necessarily normal to it after deformation.

UNIT 5
ISOPARAMETRIC FORMULATION
14
S.No Question Univ
Qn
1. Sketch and write the advantages of serendipity elements. A/M
In FEA, Serendipity are rectangular elements with no internal nodes. Since, the 2019,
internal node is removed, this elimination results in reduction in the size of the N/D
element matrices.The following are examples of first, second and third order 2018
lagrangian elements.
The following are examples of first, second and third order Serendipity
elements.

2. What is the significance of jacobian transformation? A/M


In a FE software, the Jacobian is a measure of the deviation of a given element 2019
from an ideally shaped element. The Jacobian value ranges from - 1.0 to 1.0,
where 1.0 represents a perfectly shaped element. The ideal shape for an
element depends on the element type. The check is performed by mapping an
ideal element in parametric coordinates onto the actual element defined in
global coordinates.
3. What is the salient feature of an isoparametric element? Give an example A/M
It is difficult to represent the curved boundaries by straight edges finite 2019,
elements. A large number of finite elements may be used to obtain reasonable N/D
resemblance between original body and the assemblage. In order to overcome 2018
this drawback, isoparametric elements are used i.e., for problems involving
curved boundaries, a family of elements known as "isoparametric elements"
are used.
4. Define Jacobian matrix. A/M
2019

5. Define dynamic analysis A/M


The solution of the problem varies with time is known as dynamic analysis 2017,
Example: vibration analysis problem
N/D 2017, N/D 2015, M/J 2014
6. What are essential and natural boundary conditions? Give some examples. A/M
• Primary boundary condition or EBC, Boundary condition which in 2017,
terms of field variable is known as Primary boundary condition N/D
• Secondary boundary natural boundary conditions which are in the 2015
differential form of field variable is known as secondary boundary condition
• Examples for the essential boundary condition are displacement, slope.
• Examples for the natural boundary conditions are bending moment,
15
shear force
7. Write down the stiffness matrix equation for four noded isoparametric element. A/M
2017

8. List any four finite element analysis software packages. N/D


•ANSYS 2017,
•NASTRAN N/D
•FEMAP 2014
•COMSOL
9. What are the advantages of natural co-ordinate systems? N/D
Natural coordinate system is basically a local coordinate system which allows 2017,
the specification of a point within the element by a set of dimensionless N/D
numbers whose magnitude never exceeds unity. This coordinate system is 2014
found to be very effective in formulating the element properties in finite
element formulation. This system is defined in such that the magnitude at
nodal points will have unity or zero or a convenient set of fractions. It also
facilitates the integration to calculate element stiffness.
10. What is the purpose of Isoparametric elements? N/D
It is difficult to represent the curved boundaries by straight edges finite 2016
elements. A large number of finite elements may be used to obtain reasonable
resemblance between original body and the assemblage.
11. What are the advantages of gauss quadrature numerical integration for N/D
isoparametric elements? 2016
The Gaussian quadratures provide the flexibility of choosing not only the
weighting coefficients (weight factors) but also the locations (abscissas) where
the functions are evaluated. As a result, Gaussian quadratures yield twice as
many places of accuracy as that of the Newton-Cotes formulas with the same
number of function evaluations.
12. Write the shape functions for a 1D quadratic isoparametric element. N/D
2014

13. What are the types of non-linearity? Dec


a.Non-lineraity in material behaviour from point to point 2007
b..Non-linearity in loading-deformation relation.

16
c.Geometric nonlinearity
d.Change in boundary condition for different loading
14. Define superparametric element. Dec
If the number of nodes used for defining the geometry is more than number of 2006
nodes used for defining the displacements, then, it is known as super
parametric elements.
15. What is meant by subparametric element? Dec
If the number of nodes used for defining the geometry is less than number of 2006
nodes used for defining displacements, then, it is known as isoparamteric
element.

17

You might also like