100% found this document useful (3 votes)
10K views

Finite Element Analysis MCQ

1. The document discusses various concepts related to matrix algebra and the finite element method. It provides definitions and explanations for terms like matrix, transpose, symmetric matrix, Gaussian elimination, and frontal method. 2. Key concepts covered include that a matrix is an array of elements, the transpose of a product is the product of the transposes in reverse order, a symmetric matrix is positive definite if all eigenvalues are greater than zero, Gaussian elimination successively eliminates unknowns to solve simultaneous equations, and the frontal method is a variation of Gaussian elimination that uses the structure of finite element problems. 3. The document contains multiple choice questions related to these matrix algebra and finite element method topics, with explanations provided for each answer.

Uploaded by

Online Shopping
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as DOCX, PDF, TXT or read online on Scribd
100% found this document useful (3 votes)
10K views

Finite Element Analysis MCQ

1. The document discusses various concepts related to matrix algebra and the finite element method. It provides definitions and explanations for terms like matrix, transpose, symmetric matrix, Gaussian elimination, and frontal method. 2. Key concepts covered include that a matrix is an array of elements, the transpose of a product is the product of the transposes in reverse order, a symmetric matrix is positive definite if all eigenvalues are greater than zero, Gaussian elimination successively eliminates unknowns to solve simultaneous equations, and the frontal method is a variation of Gaussian elimination that uses the structure of finite element problems. 3. The document contains multiple choice questions related to these matrix algebra and finite element method topics, with explanations provided for each answer.

Uploaded by

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

Finite Element Method Questions and Answers – MatrixAlgebra

1. What is a matrix?
a) Group of elements
b) Array of elements
c) Group of columns and rows
d) Array of numbers
Answer: b
Explanation: A matrix is an array of elements. The matrix A is denoted as [A]. An element located in the ith row
and j th column is denoted as aij. A matrix is a collection of numbers arranged into a fixed number of rows and
columns.

2. (A B C)T = _______
a) (C B A)T
b) BT CT AT
c) CT BT AT
d) AT BT CT
Answer: c
Explanation: A matrix which is formed by turning all the rows of given matrix into columns and vice versa is
called a transpose of matrix. The transpose of a product is given as the product of the transposes in the reverse
order.
(A B C)T = CT BT AT.

3. A symmetric matrix is called ____________, if all its Eigen values are strictly positive i.e., greater than zero.
a) Negative definite
b) Positive definite
c) Co- definite
d) Alternative definite
Answer: b
Explanation: If all Eigen values of symmetric matrix are positive then the matrix is called as positive definite
matrix. A symmetric matrix A of dimension (n x n) is positive definite if, for any non zero vector x = [x 1 x2 x3……
xn]T. That is xT Ax > 0.

4. A A-1=A-1A is a condition for ________


a) Singular matrix
b) Nonsingular matrix
c) Matrix inversion
d) Ad joint of matrix
Answer: c
Explanation: If det A not equal to zero, then A has an inverse, denoted by A -1. The inverse satisfies the relation
A A-1 =A-1A= I

5. A positive definite symmetric matrix A can be decomposed into form A=LL T this decomposition is called
________
a) Cholesky
b) Rayleighs
c) Galerkins
d) Potential energy
Answer: a
Explanation: L is the lower triangular matrix, and its transpose LT is upper triangular matrix. This is called
Cholesky decomposition. It is a decomposition of a positive definite matrix into a product of lower triangular
matrix and its conjugate transpose.

6. Det(A-λI)=0 is a ________
a) Characteristic equation
b) Matrix equation
c) Inversion of matrix
d) Cholesky’s equation
Answer: a
Explanation: A non zero solution will occurs when (A-ɅI) is a singular matrix or det(A-ɅI)=0 it is a characteristic
equation. A characteristic equation is the equation which is solved to find the Eigen values, also called the
characteristic polynomials.
7. Gaussian elimination is a name given to a well known method of solving simultaneous equation by
successively eliminating _________
a) Variables
b) Equations
c) Unknown
d) Algorithms
Answer: c
Explanation: Gaussian elimination is an approach for solving equations type of Ax=B in matrix form. Gaussian
elimination is a name given to a well known method of solving simultaneous equation by successively
eliminating Unknowns.

8. Step number in Gaussian elimination is denoted as ___________


a) Superscript
b) Subscript
c) Unknown
d) Elimination
Answer: a
Explanation: Gaussian elimination is an algorithm for solving systems of linear equations. The idea at step 1 is to
use equation 1 (first row) in eliminating x1 from remaining equations. We know the step numbers as superscript
set in parentheses.

9. In Gaussian elimination, A is defined as symmetric matrix then its multiplier is defined as ____
a) C = akk/aik
b) C = aki/akk
c) C = aik/akk
d) C = akk/aki
Answer: b
Explanation: In a Gaussian elimination, If A is a symmetric matrix then its algorithm can be modified in two
methods, one method is its multiplier is defined as C = aki/akk. 2nd modification is related to DO LOOP.

10. A banded matrix is defined as ____________


a) Non zero elements are contained in band
b) Zero elements are contained in a band
c) Non zero elements are contained out of a band
d) Both Non zero elements and Zero elements
Answer: a
Explanation: A band matrix is a sparse matrix whose non zero entries are confined to a diagonal band. In a
banded matrix, all of the non zero elements are contained within a band; outside of the band all elements are
zero.

11. In a symmetric banded matrix __________


a) aij=aji
b) aji*aij
c) aij≠aji
d) aii=ajj

Answer: a
Explanation: For a symmetric banded matrix aij=aji. A symmetric banded matrix is a symmetric matrix whose
nonzero elements are arranged uniformly near the diagonal.

12. The line separating from the top zeros from the first non-zero element is called ____
a) Equation
b) Gaussian solution
c) Skyline solution
d) Both Gaussian and skyline solutions
Answer: c
Explanation: If there are zeros at the top of the column, only the elements starting from the first non zero value
need be stored. The line separating from the top zeroes from the first non- zero element is called Skyline
solution.
13. Frontal method is a _______ of Gaussian elimination method that uses the structure of finite element
problem.
a) Structure
b) Variation
c) Algorithm
d) Data
Answer: b
Explanation: Frontal method is a variation of Gaussian elimination method that uses the structure of finite
element problem. Elements can be stored in-core in a clique sequence as recently proposed by areas, this
subset is called front and it is essentially the transition region between the part of the system already finished.

14. Frontal method is implemented for ________


a) Hexahedral element
b) Polyhedral element
c) Octahedral element
d) Both Hexahedral and Polyhedral
Answer: a
Explanation: The frontal method is implemented for the hexahedral element. By this method we can recombine
tetrahedral element to hexahedral element. However, non conformal quadrilateral faces adjacent to triangular
faces.

15. Frontal method involves __________


a) Computer programming
b) Manual programming
c) C- programming
d) Computing
Answer: a
Explanation: The elimination process is handled by writing the eliminated equation to the computer hard disk.
Processing the front involves dense matrix operations, which use the CPU efficiently. In a typical
implementation, only the front is in memory while factors in decomposition are written into files.

“One Dimensional Problems – Finite Element Modelling”.


1. If the structure is divided into discrete areas or volumes then it is called an _______
a) Structure
b) Element
c) Matrix
d) Boundaries
Answer: b
Explanation: An element is a basic building block of finite element analysis. An element is a mathematical
relation that defines how the degrees of freedom of node relate to next. The structure is divided into discrete
areas or volumes known as elements.

2. In finite element modeling nodal points are connected by unique ________


a) Surface
b) Shape
c) Eigen values
d) Matrix
Answer: a
Explanation: A node is a co-ordinate location in a space where the degrees of freedom can be defined. A node
may be limited in calculated motions for a variety of reasons. Element boundaries are defined when nodal points
are connected by unique polynomial curve or surface.

3. In finite element modeling every element connects to _______


a) 4 nodes
b) 3 nodes
c) 2 nodes
d) Infinite no of nodes
Answer: c
Explanation: In finite element modeling, each element connects to 2 nodes. Better approximations are obtained
by increasing the number of elements. It is convenient to define a node at each location where the point load is
applied.
4. In one dimensional problem, each node has _________ degrees of freedom.
a) 2 degrees of freedom
b) 3 degrees of freedom
c) No degrees of freedom
d) 1 degree of freedom
Answer: d
Explanation: A degrees of freedom may be defined as, the number of parameters of system that may vary
independently. It is the number of parameters that determines the state of a physical system. In one dimensional
problem, every node is permitted to displace only in the direction. Thus each node has only one degree of
freedom.

5. Which relations are used in one dimensional finite element modeling?


a) Stress-strain relation
b) Strain-displacement relation
c) Total potential energy
d) Total potential energy; Stress-strain relation; Strain-displacement relation.
Answer: d
Explanation: The basic procedure for a one dimensional problem depends upon total potential energy, stress-
strain relation and strain-displacement relation are used in developing the finite element modeling.

6. One dimensional element is the linear segments which are used to model ________
a) Bars and trusses
b) Plates and beams
c) Structures
d) Solids
Answer: a
Explanation: In finite element method elements are grouped as one dimensional, two dimensional and three
dimensional elements. One dimensional element is the linesegment which is used to model bars and trusses.

7. Modeling is defined as ________________


a) Elemental area with uniform cross section
b) Elemental area with non uniform cross section
c) Structural area with uniform cross section
d) Non structural area with non uniform cross section
Answer: a
Explanation: Modeling is one of the basic steps in finite element method. Let us model a stepped shaft consists
of discrete no of elements each having a uniform cross sectional area. Average cross section area within each
region is evaluated and used to define elemental area with uniform cross sectional area.

A1=A1’+A2’/2.

8. Discretization includes __________ numbering.


a) Element and node
b) Only nodal
c) Only elemental
d) Either nodal or elemental
Answer: a
Explanation: The process of dividing a body into equivalent number of finite elements associated with nodes is
called discretization. Discretization includes both node and element numbering, in this model every element
connects two nodes.
9. The loading on an element includes _______
a) Body force
b) Traction force
c) Point load
d) Body force, Traction force & Point load
Answer: d
Explanation: The loading on an element includes body force; traction force & point load. Body force is distributed
force acting on every elemental volume. Traction force is a distributed load along the surface of a body.

10. Global nodes corresponds to _______


a) Entire body
b) On surface
c) On interface
d) On element
Answer: a
Explanation: Global coordinate system corresponds to the entire body. It is used to define nodes in the entire
body.

11. Local node number corresponds to ______________


a) Entire body
b) On element
c) On interface
d) On surface
Answer: b
Explanation: Local coordinate system corresponds to particular element in the body. The numbering is done to
that particular element neglecting the entire body.

One Dimensional Problems – Co-ordinates and Shape Functions

1. Natural or intrinsic coordinate system is used to define ___________


a) Co-ordinates
b) Shape functions
c) Displacement functions
d) Both shape functions and co-ordinate functions
Answer: b
Explanation: Natural coordinate system is another way of representing direction. It is based on the relative
motion of the object. We use this system of coordinates in defining shape functions, which are used in
interpolating the displacement field.

2. In q=[q1,q2]T is defined as __________


a) Element displacement vector
b) Element vector
c) Displacement vector
d) Shape function vector
Answer: a
Explanation: Once the shape functions are defined, the linear displacement field within in the element can be
written in terms of nodal displacements q1 and q2 and matrix notation as q=[q1,q2]. Here q is referred as element
displacement function.

3. Shape function is just a ___________


a) Displacement function
b) Equation
c) Interpolation function
d) Matrix function
Answer: c
Explanation: The shape function is the function which interpolates the solution between the discrete values
obtained at the mesh nodes. Low order polynomials are typically chosen as shape functions. Interpolation within
the shape functions is achieved through shape functions.
4. Isoparametric formula is ______________
a) x=N1x1+N2x2
b) x=N2x1+N1x2
c) x=N1x1-N2x2
d) x=N2x1-N1x2
Answer: a
Explanation: From nodal displacement equation we can write that isoparametric equation as
x=N1x1+N2x2
Here both displacement u and co-ordinate x are interpolated within the element using shape functions N 1 and N2.
This is called isoparametric formulation in literature.

5. B=1/(x2−x1)[-1 1] is an ___________
a) Strain matrix
b) Element-strain displacement matrix
c) Displacement matrix
d) Elemental matrix
Answer: b
Explanation: ε=Bq
Here B is element strain displacement matrix. Use of linear shape functions results in a constant B matrix.
Hence, in a constant strain within the element. The stress from Hooke’s law is
σ=EBq.

6. Deformation at the end of elements are called _____________


a) Load
b) Displacement functions
c) Co-ordinates
d) Nodes
Answer: d
Explanation: Nodes are the points where displacement, reaction force, deformation etc.., can be calculated.
Corner of each element is called a node. A node is a co-ordinate location in space where degrees of freedom
are defined.

7. Write the shape function of the given element.

 u= N1u1(e)+N2u2(e). Here N1 & N2 are


a) N1=1-x/le&N2=x/le
b) N1=x/le&N2=1-x/le
c) N1=0 & N2=x
d) N1=x & N2=0

Answer: a
Explanation:

1 2 --- local variables


I j --- global variables
u1(e) u2(e)
x1=0 x2=0
u1(e)=c1+c2(0)=c1
u2(e)= c1+c2(le)
By solving we get
N1=1-x/le& N2=x/le.
8. In shape functions, first derivatives must be _______ within an element.
a) Infinite
b) Finite
c) Natural
d) Integer
Answer: b
Explanation: In general shape functions need to satisfy that, first derivatives must be finite within element. Shape
functions are interpolation functions. First derivatives are finite within element because for easy calculations.

9. In shape functions, _________ must be continuous across the element boundary.


a) Derivatives
b) Nodes
c) Displacement
d) Shape function
Answer: c
Explanation: Shape functions are interpolation functions. In general shape functions need to satisfy that,
displacements must be continuous across the element boundary.

10. Stresses due to rigid body motion are _______________


a) Zero
b) Considered
c) Not considered
d) Infinite
Answer: c
Explanation: A rigid body is a solid body in which deformation is zero or so small it can be neglected. A rigid
body is usually considered as a continuous distribution of mass. By rigid body deformation is neglected so
stresses are not considered.

11. The expressions u=Nq; ε=Bq; σ=EBq relate ____________


a) Displacement, Strain and Stress
b) Strain and stress
c) Strain and displacement
d) Stress and displacement
Answer: a
Explanation: Stress is defined as force per unit area. Strain is defined as the amount of deformation in the
direction of applied force. Displacement is the difference between the final and initial position of a point. The
given expressions show the relationship between stress, strain and displacement of a body.

One Dimensional Problems – Potential Energy Approach


1. Continuum is discretized into_______ elements.
a) Infinite
b) Finite
c) Unique
d) Equal
Answer: b
Explanation: The continuum is a physical body structure, system or a solid being analyzed and finite elements
are smaller bodies of equivalent system when given body is sub divided into an equivalent system.

2. Ue=12∫ σT εA dx is a _____________
a) Potential equation
b) Element strain energy
c) Load
d) Element equation
Answer: b
Explanation: The given equation is Element strain energy equation. The strain energy is the elastic energy
stored in a deformed structure. It is computed by integrating the strain energy density over the entire volume of
the structure.
3. ∏ = 12 QTKQ-QT F In this equation F is defined as _________
a) Global displacement vector
b) Global load vector
c) Global stiffness matrix
d) Local displacement vector
Answer: b
Explanation: Global load vector is assembly of all local load vectors. This load vector is obtained by due to given
load. In the given equation F is defined as global load vector.

4. What are the basic unknowns on stiffness matrix method?


a) Nodal displacements
b) Vector displacements
c) Load displacements
d) Stress displacements
Answer: a
Explanation: Stiffness matrix represents systems of linear equations that must be solved in order to as certain an
approximate solution to the differential equation. In stiffness matrix nodal displacements are treated as basic
unknowns for the solution of indeterminate structures. The external loads and the internal member forces must
be in equilibrium at the nodal points.

5. Write the element stiffness for a truss element.


a) K=A/l
b) K=AE/l
c) K=E/l
d) K=AE
Answer: b
Explanation: Truss is a structure that consists of only two force members only. Where the members are
organized so that the assemblage as a whole behaves as a single object.

6. Formula for global stiffness matrix is ____________


a) No. of nodes*Degrees of freedom per node
b) No. of nodes
c) Degrees of freedom per node
d) No. of elements
Answer: a
Explanation: Generally global stiffness matrix is used to complex systems. Stiffness matrix method is used for
structures such as simply supported, fixed beams and portal frames. Size of stiffness matrix is defined as:
Size of global stiffness matrix=No. of nodes*Degrees of freedom per node.

One Dimensional Problems – Galerkin Approach


1. Galerkin technique is also called as _____________
a) Variational functional approach
b) Direct approach
c) Weighted residual technique
d) Variational technique
Answer: c
Explanation: The equivalent of applying the variation of parameters to a function space, by converting the
equation into weak formulation. Galerkin’s method provide powerful numerical solution to differential equations
and modal analysis. The Galerkin method of weighted residuals, the most common method of calculating the
global stiffness matrix in the finite element method.

2. In the equation, ∫LσTϵ(ϕ)Adx−∫LϕTfAdx−∫LϕTdx–∑iϕiPi=0 First term represents _______


a) External virtual work
b) Virtual work
c) Internal virtual work
d) Total virtual work
Answer: c
Explanation: In the given equation first term represents internal virtual work. Virtual work means the work done
by the virtual displacements. The principle of virtual work is equivalent to the conditions for static equilibrium of a
rigid body expressed in terms of total forces and torques. The virtual work done by internal forces is called
internal virtual work.
3. Considering element connectivity, for example for element ψ=[ψ 1, ψ2]n for element n, then the variational form
is ______________
a) ψT(KQ–F)=0
b) ψ(KQ-F)=0
c) ψ(KQ)=F
d) ψ(F)=0
Answer: a
Explanation: Element connectivity means Assemble the element equations. To find the global equation system
for the whole solution region we must assemble all the element equations. For formulation of a variational form
for a system of differential equations. First method treats each equation independently as a scalar equation,
while the other method views the total system as a vector equation with a vector function as a unknown.

4. Element connectivities are used for _____


a) Traction force
b) Assembling
c) Stiffness matrix
d) Virtual work
Answer: b
Explanation: Element connectivity means “Assemble the element equations. To find the global equation system
for the whole solution region we must assemble all the element equations. In other words we must combine local
element equations for all the elements used for discretization.

5. Virtual displacement field is _____________


a) K=E/Al
b) F=ma
c) f(x)=y
d) ф=ф(x)
Answer: d
Explanation: Virtual work is defined as work done by a real force acting through a virtual displacement. Virtual
displacement is an assumed infinitesimal change of system coordinates occurring while time is held constant.

6. Virtual strain is ____________


a) ε(ф)=dx/dϕ
b) ε(ф)=dϕ/dx
c) ε(ф)=dx/dε
d) ф(ε)=dε/dϕ
Answer: b
Explanation: Virtual work is defined as the work done by a real force acting through a virtual displacement. A
virtual displacement is any displacement is any displacement consistent with the constraints of the structure.

7. To solve a galerkin method of approach equation must be in ___________


a) Equation
b) Vector equation
c) Matrix equation
d) Differential equation
Answer: d
Explanation: Galerkin method of approach is also called as weighted residual technique. This method of
approach can be used for irregular geometry with a regular pattern of nodes. The solution function is substituted
in a differential equation, this differential equation will not be satisfied and will give a residue.

8. By the Galerkin approach equation can be written as __________


a) {P}-{K}{Δ}=0
b) {K}-{P}{Δ}=0
c) {Δ}-{p}{K}=0
d) Undefined
Answer: a
Explanation: Galerkin’s method of weighted residuals, the most common method of calculating the global
stiffness matrix in fem. This requires the boundary element for solving integral equations.
9. In basic equation Lu=f, L is a ____________
a) Matrix function
b) Differential operator
c) Degrees of freedom
d) No. of elements
Answer: b
Explanation: The method of weighted residual technique uses the weak form of physical problem or the direct
differential equation. The basic equation Lu=f in that L is an differential operator. It uses the principle of
orthogonality between Residual function and basis function.

One Dimensional Problems – Assembly of the Global Stiffness Matrix and Load Vector
1. How is Assembly of stiffness matrix symbolically denoted?
a) K={k}e
b) K←∑eKe
c) K←∑Ke
d) Undefined
Answer: b
Explanation: The stiffness matrix represents the system of linear equations that must be solved in order to
ascertain an approximate solution to differential equation.

2. What is the Strain energy equation?


a) Ue=1/2qTkeq
b) Ue=1/2qekeq
c) Ue=1/2qke
d) Ue=1/2qTke
Answer: a
Explanation: Strain energy is defined as the energy stored in the body due to deformation. The strain energy per
unit volume is known as strain energy density and the area under stress-strain curve towards the point of
deformation. When the applied force is released, the system returns to its original shape.

3. From where does the global load vector F is assembled?


a) Element force vectors only
b) Point loads only
c) Both element force vectors and point loads
d) Undefined
Answer: c
Explanation: Global load vector is assembling of all local load variables. This global load vector is get from
assembling of both element force vectors and point loads.

4. Principal of minimum potential energy follows directly from the principal of ________
a) Elastic energy
b) Virtual work energy
c) Kinetic energy
d) Potential energy
Answer: b
Explanation: The total potential energy of an elastic body is defined as sum of total strain energy and the work
potential energy. Therefore the principal of minimum potential energy follows directly the principal of virtual work
energy.

5. The points at where kinetic energy increases dramatically then those points are called _______
a) Stable equilibrium points
b) Unstable equilibrium points
c) Equilibrium points
d) Unique points
Answer: b
Explanation: If an external force acts to give the particles of the system some small initial velocity and kinetic
energy will developed in that body then the point where kinetic energy decreased that point is Stable equilibrium
point and the point where the kinetic energy dramatically increased then the point is called Unstable equilibrium
points.
6. We can obtain same assembly procedure by Stiffness matrix method and _______
a) Potential energy method
b) Rayleigh method
c) Galerkin approach
d) Vector method
Answer: c
Explanation: Galerkin method provides powerful numerical solution to differential equations and modal analysis.
Assembling procedure is same for both stiffness matrix method and galerkin approach method in Finite element
modeling.

7. By element stiffness matrix we can get relation of members in an object in _____


a) Different matrices
b) One matrix
c) Identity matrix
d) Singular matrix
Answer: b
Explanation: Element stiffness matrix method is that make use of the members of stiffness relations for
computing member forces and displacement in structures. So by this element stiffness matrix method we can
get relation of members in an object in one matrix.

8. What is the Global stiffness method called?


a) Multiple matrix
b) Direct stiffness matrix
c) Unique matrix
d) Vector matrix
Answer: b
Explanation: Global stiffness matrix method makes use of the members stiffness relations for computing
member forces and displacements in structures. Hence Global stiffness matrix or Direct stiffness matrix or
Element stiffness matrix can be called as one.

9. Which technique do traditional workloads use?


a) Scale out technique
b) Scale up technique
c) Building technique
d) Shrinking technique
Answer: b
Explanation: When the workload increases on the system, the machine scales up by adding more RAM, CPU
and storage spaces.

One Dimensional Problems – Properties of K


1. Dimension of global stiffness matrix is _______
a) N X N, where N is no of nodes
b) M X N, where M is no of rows and N is no of columns
c) Linear
d) Eliminated
Answer: a
Explanation: A global stiffness matrix is a method that makes use of members stiffness relation for computing
member forces and displacements in structures. The dimension of global stiffness matrix K is N X N where N is
no of nodes.

2. Each node has only _______


a) Two degrees of freedom
b) One degree of freedom
c) Six degrees of freedom
d) Three degrees of freedom
Answer: b
Explanation: Degrees of freedom of a node tells that the number of ways in which a system can allowed to
moves. In a stiffness matrix each node can have one degree of freedom.
3. Global stiffness K is a______ matrix.
a) Identity matrix
b) Upper triangular matrix
c) Lower triangular matrix
d) Banded matrix
Answer: d
Explanation: A banded matrix is a sparse matrix whose non zero entities are confined to a diagonal band,
comprising the main diagonal and zero or more diagonals on either side. A global stiffness matrix K is a banded
matrix. That is, all the elements outside the band are zero.

4. The dimension of Kbanded is _____ (Here NBW is half bandwidth)


a) [N X NBW ]
b) [NBW X N]
c) [N X N]
d) [NBW X NBW]
Answer: a
Explanation: K can be compactly represented in banded form. As Kbanded is of dimension [N X NBW] where NBW
is the half band width.

5. In many one-dimensional problems, the banded matrix has only two columns. Here NBW=____
a) 6
b) 3
c) 7
d) 2
Answer: d
Explanation: NBW means half bandwidth. Many of the One- dimensional problems banded matrix has only 2
columns then NBW=2. We know that
NBW=max(Difference between dof numbers connecting an element)+1

6. Stiffness matrix represents a system of ________


a) Programming equations
b) Iterative equations
c) Linear equations
d) Program CG SOLVING equations
Answer: c
Explanation: Stiffness is amount of force required to cause the unit displacement same concept is applied for
stiffness matrix. The stiffness matrix represents a system of linear equations that must be solved in order to
ascertain an approximate solution to differential equation.

7. Stiffness matrix is _____


a) Non symmetric and square
b) Symmetric and square
c) Non symmetric and rectangular
d) Symmetric and rectangular
Answer: b
Explanation: Stiffness matrix is a inherent property of the structure. The property of a stiffness matrix, as the
stiffness matrix is square and symmetric.

8. In stiffness matrix, all the _____ elements are positive.


a) Linear
b) Zigzag
c) Diagonal
d) Rectangular
Answer: c
Explanation: Stiffness matrix represents system of linear equations that must be solved in order to ascertain an
approximate solution to the differential equation. The stiffness matrix is an inherent property of a structure. In
stiffness matrix all the diagonal elements are positive.
9. The size of global stiffness matrix will be equal to the total ______ of the structure.
a) Nodes
b) Degrees of freedom
c) Elements
d) Structure
View Answer
Answer: b
Explanation: For a global stiffness matrix, a structural system is an assemblage of number of elements. These
elements are interconnected to form the whole structure. The size of global stiffness matrix will be equal to the
total degrees of freedom of the structure.

10. Element stiffness is obtained with respect to its ___


a) Degrees of freedom
b) Nodes
c) Axes
d) Elements
Answer: c
Explanation: A stiffness matrix represents system of linear equations that must be solved in order to ascertain an
approximate solution to the differential equation. Element stiffness is obtained with respect to its axes.

Finite Element Equations – Treatment of Boundary Conditions

1. Types of Boundary conditions are ______


a) Potential- Energy approach
b) Penalty approach
c) Elimination approach
d) Both penalty approach and elimination approach
Answer: d
Explanation: Boundary condition means a condition which a quantity that varies through out a given space or
enclosure must be fulfill at every point on the boundary of that space. In fem, Boundary conditions are basically
two types they are Penalty approach and elimination approach.

2. Potential energy, π = _________


a) 1/2QTKQ-QTF
b) QKQ-QF
c) 1/2KQ-QF
d) 1/2QF

Answer: a
Explanation: Minimum potential energy theorem states that “Of all possible displacements that satisfy the
boundary conditions of a structural system, those corresponding to equilibrium configurations make the total
potential energy assume a minimum value.” Potential energy π=1/2QTKQ-QTF

3. Equilibrium conditions are obtained by minimizing ______


a) Kinetic energy
b) Force
c) Potential energy
d) Load
Answer: c
Explanation: According to minimum potential energy theorem, that equilibrium configurations make the total
potential energy assumed to be a minimum value. Therefore, Equilibrium conditions are obtained by minimizing
Potential energy.

4. In elimination approach, which elements are eliminated from a matrix ____


a) Force
b) Load
c) Rows and columns
d) Undefined
View Answer
Answer: c
Explanation: By elimination approach method we can construct a global stiffness matrix by load and force acting
on the structure or an element. Then reduced stiffness matrix can be obtained by eliminating no of rows and
columns of a global stiffness matrix of an element.
5. In elimination approach method, extract the displacement vector q from the Q vector. By using ___
a) Potential energy
b) Load
c) Force
d) Element connectivity
Answer: d
Explanation: By elimination approach method we can construct a global stiffness matrix by load and force acting
on the structure or an element. Then we extract the displacement vector q from the Q vector. By using Element
connectivity, and determine the element stresses.

6. Penalty approach method is easy to implement in a ______


a) Stiffness matrix
b) Iterative equations
c) Computer program
d) Cg solving
Answer: c
Explanation: Penalty approach is the second approach for handling boundary conditions. This method is used to
derive boundary conditions. This approach is easy to implement in a computer program and retains it simplicity
even when considering general boundary conditions.

7. If Q1=a1 then a1is _________


a) Displacement
b) Symmetric
c) Non symmetric
d) Specified displacement
Answer: d
Explanation: In penalty approach method a1 is known as specified displacement of 1. This is used to model the
boundary conditions.

8. The first step of penalty approach is, adding a number C to the diagonal elements of the stiffness matrix. Here
C is a __________
a) Large number
b) Positive number
c) Real number
d) Zero
Answer: a
Explanation: Penalty approach is one of the method to derive boundary conditions of an element or a structure.
The first step is adding a large number C to the diagonal elements of the stiffness matrix. Here C is a large
number.

9. In penalty approach evaluate _______ at each support.


a) Load vector
b) Degrees of freedom
c) Force vector
d) Reaction force
Answer: d
Explanation: By penalty approach we can derive boundary conditions of an element or a structure. The first step
of this approach is to add a large number to the diagonal elements. Second step is to extract element
displacement vector. Third step is to evaluate reaction force at each point.

10. For modeling of inclined roller or rigid connections, the method used is ___
a) Elimination approach
b) Multiple constraints
c) Penalty approach
d) Minimum potential energy theorem
Answer: b
Explanation: Multiple constraints is one of the method for boundary conditions it is generally used in problems for
modeling inclined rollers or rigid connections.
One Dimensional Problems – Quadratic Shape Function
1. What is a shape function?
a) Interpolation function
b) Displacement function
c) Iterative function
d) Both interpolation and displacement function
Answer: d
Explanation: The shape function is a function which interpolates the solution between discrete values obtained at
the mesh nodes. Lower order polynomials are chosen as shape functions. Shape function is a displacement
function as well as interpolation function.

2. Quadratic shape functions give much more _______


a) Precision
b) Accuracy
c) Both Precision and accuracy
d) Identity
Answer: b
Explanation: The shape function is function which interpolates the solution between discrete values obtained at
the mesh nodes. The unknown displacement field was interpolated by linear shape functions within each
element. Use of quadratic interpolation leads to more accurate results.

3. Strain displacement relation ______


a) ε=du/dx
b) ε=du/dϵ
c) x=dϵ/du
d) Cannot be determined
Answer: a
Explanation: The relationship is that connects the displacement fields with the strain is called strain –
displacement relationship. If strain is ε then strain – displacement relation is
ε=du/dx

4. The _____ and ______ can vary linearly.


a) Force and load
b) Precision and accuracy
c) Strain and stress
d) Distance and displacement
Answer: c
Explanation: Strain is defined as a geometrical measure of deformation representing the relative displacement
between particles in a material body. Stress is a physical quantity that expresses the internal forces that
neighboring particles of a continuous material exert on each other. In quadratic shape functions strain andstress
can vary linearly.

5. By Hooke’s law, stress is ______


a) σ=Bq
b) σ=EB
c) B=σq
d) σ=EBq
Answer: d
Explanation: Hooke’s law states that the strain in a solid is proportional to the applied stress within the elastic
limit of that solid.

6. Nodal displacement as _____


a) u=Nq
b) N=uq
c) q=Nu
d) Program SOLVING
Answer: a
Explanation: Nodes will have nodal displacements or degrees of freedom which may include translations,
rotations and for special applications, higher order derivatives of displacements.
7. At the condition, at , N1=1 at ξ=-1 which yields c=−1/2. Then these shape functions are called ____
a) Computer functions
b) Programming functions
c) Galerkin function
d) Lagrange shape functions
Answer: d
Explanation: The lagrange shape function sum to unity everywhere. At the given condition the shape functions
are named as Lagrange shape functions.

Plane Trusses
1. Plane trusses are also known as _____
a) One–dimensional trusses
b) Two-dimensional trusses
c) Three-dimensional trusses
d) Poly dimensional trusses
Answer: b
Explanation: Truss elements are two- node members which allow arbitrary orientation in XYZ co-ordinate
system. Truss transmits axial force only. Planar truss is one where all members and nodes lie within Two
dimensional plane.

2. A truss structure consists only ___ force members.


a) Only one
b) Two
c) Three
d) Poly
Answer: b
Explanation: Truss elements are two node members which allow arbitrary orientation in XYZ co-ordinate system.
Truss transmits axial force only, in general, three degree of freedom element. A truss structure consists only 2
truss members.

3. Plane truss element can be shown in _____


a) Local coordinate system
b) Global coordinate system
c) Local and global coordinate systems
d) Dimensional structure
Answer: c
Explanation: Truss is one where all members and nodes lie within two dimensional plane. Truss is that elements
of a truss have various orientation. These different orientations can be shown in local and global coordinate
system.

4. The truss element is a _____ when we see it in a local co-ordinate system.


a) Three dimensional
b) One dimensional
c) Two dimensional
d) Thermal component
Answer: b
Explanation: Truss is one where all members and nodes lie within two dimensional plane. Truss is that elements
of a truss have various orientations. When we see a truss in local co-ordinate system, the element of a truss can
be seen as one dimensional element.

5. Strain energy (U) in global co-ordinates can be written as ____


a) q’ T k’q’
b) q’ T k’
c) k’ q’
d) 1/2 q’ T k’q’
Answer: d
Explanation: Strain energy is defined as the energy stored in the body due to deformation. Strain energy per unit
volume is known as strain energy density and the area under stress- strain curve towards the point of
deformation.
6. The stress σ in a truss element is given by ____
a) σ=E
b) σ=ε
c) σ=Eeε
d) σ=α
Answer: c
Explanation: Stress is a physical quantity that expresses the internal forces that neighboring the particles of a
continuous material exert on each other. Expression for element stresses can be obtained by noting that a truss
element in local co-ordinates is simple two- force member.

Assembly of Global Stiffness Matrix for the Banded & Skyline Solutions
1. What is a banded matrix?
a) Sparse matrix
b) Rectangular matrix
c) Unit matrix
d) Square matrix
Answer: a
Explanation: In matrix theory band matrix is a sparse matrix, whose non-zero entities are confined to a diagonal
band. Comprising the main diagonal and zero are more diagonals on either side.

2. Skyline matrix storage is in the form of ______


a) Banded matrix
b) Sparse matrix
c) Singular matrix
d) Identity matrix
Answer: b
Explanation: In scientific computing, skyline matrix storage or SKS or a variable banded matrix storage or
envelope storage scheme is form of a sparse matrix storage format matrix that reduces the storage requirement
of matrix more than banded storage.

3. Symmetry and sparsity of the global stiffness matrix can be approached by _____ methods.
a) One
b) Three
c) Two
d) Four
Answer: c
Explanation: In assembly of global stiffness matrix, the solution for finite element equations can take advantage
of symmetry and sparsity of global stiffness matrix. There are two methods to identify them. They are banded
approach and skyline approach methods.

4. Which of these was one of the methods for determining assembly of global stiffness matrix?
a) Galerkin approach
b) Skyline approach
c) Rayleigh method
d) Assembly method
Answer: b
Explanation: In assembly of global stiffness matrix, there are two methods to determine the global stiffness
matrices. They are banded approach and skyline approach. In which the assembly procedure of the matrix was
easy.

5. In banded matrix, elements are _____ placed in stiffness matrix.


a) Singular
b) Determinant values
c) Directly
d) Indirectly
Answer: c
Explanation: A band matrix is a sparse matrix whose non zero entities are confined to a diagonal band
comprising the main diagonal and zero or more diagonals on either side. In the banded approach, the elements
of each element stiffness matrix Ke are directly placed in banded matrix S.
6. In Skyline matrix, the elements in a stiffness matrix can be placed in _______
a) Direct values
b) Determinant values
c) Load values
d) Vector form
Answer: d
Explanation: In skyline matrix storage, or SKS or, variable band matrix storage or, envelope storage scheme is a
form of a sparse matrix that reduces the storage requirement of the matrix more than banded storage. In skyline
approach, the elements of Ke are placed in a vector form with certain identification pointers.

7. The first step of skyline assembly matrix involves evaluation of ____


a) Column height
b) Row height
c) Matrix height
d) Undefined
Answer: a
Explanation: Skyline assembly matrix scheme of form of a sparse matrix that reduces the storage requirement of
a matrix than banded approach. The first step of skyline assembly involves the evaluation of the skyline height or
the column height for each diagonal location.

8. The second step in skyline approach is assembling the element stiffness values into _____
a) Row vector
b) Identity vector
c) Column vector
d) Determinant vector
Answer: c
Explanation: Skyline assembly matrix scheme of form of sparse matrix that reduces the storage requirement of a
matrix than banded approach. The second step in skyline approach is assembling the element stiffness values
into column vector.

9. The details of a skyline assembly matrix are implemented in a program called ____
a) Boolean program
b) Cholesky program
c) Truss program
d) Trussky program
Answer: d
Explanation: As this assembly was done to trusses by default all the steps applied in skyline approach were
implemented in program TRUSSKY.

Two Dimensional Problems – Finite Element Modelling


1. In 2D elements. Discretization can be done. The points where triangular elements meet are called ____
a) Displacement
b) Nodes
c) Vector displacements
d) Co-ordinates
Answer: b
Explanation: The two dimensional region is divided into straight sided triangles, which shows as typical
triangulation. The points where the corners of the triangles meet are called nodes.

2. Each triangle formed by three nodes and three sides is called a ______
a) Node
b) Force matrix
c) Displacement vector
d) Element
Answer: d
Explanation: An element is a basic building block of finite element analysis. An element is a mathematical
relation that defines how the degrees of freedom of a node relate to next. In discretization of 2D element each
triangle is called element.
3. The finite element method is used to solve the problem ______
a) Uniformly
b) Vigorously
c) Approximately
d) Identically
Answer: c
Explanation: The finite element method is a numerical method for solving problems of engineering and
mathematical physics. Typical problems areas of interest include structure analysis, heat transfer, fluid flow,
mass transport and electromagnetic potential etc..,. The method yields approximate values of the unknowns at
discrete number of points.

4. In two dimensional modeling each node has ____ degrees of freedom.


a) One
b) Infinity
c) Finite
d) Two
Answer: d
Explanation: In two dimensional problem, each node is permitted to displace in the two directions x and y. Thus
each node has two degrees of freedom.

5. For a triangular element,element displacement vector can be denoted as ___


a) q=[q1,q2,q3]T
b) q=[q1,q2]T
c) q=[q1,q2,……q6]T
d) Load vector
Answer: c
Explanation: The displacement components of a local node is represented in x and y directions, respectively. For
that we denote element displacement vector as
q=[q1,q2,……q6]T.

6. In two dimensional analysis, stresses and strains are related as ___


a) σ=Dε
b) σ=ε
c) Load values
d) ε=Dσ
Answer: a
Explanation: When a material is loaded with force, it produces stress. Which then cause material to deform.
Strain is response of a system t an applied stress.

7. In two dimensional modeling, body force is denoted as ___


a) f=[fx,fy]T
b) σ=Dε
c) q‘=lq
d) f=[2|i-j|+1]
Answer: a
Explanation: A body force is a force that acts throughout the volume of the body. Body forces contrast with
contact forces or the classical definition of surface forces which are exerted to the surface of the object. Body
force is denoted as f=[fx,fy]T.

8. The information of array of size and number of elements and nodes per element can be seen in ___
a) Column height
b) Element connectivity table
c) Matrix form
d) Undefined
Answer: b
Explanation: An element connectivity table specifies global node number corresponding to the local node
element. Element connectivity is the nodal information for the individual element with details how to fit together
to form the complete original system.
9. In two dimensional modeling, traction force is denoted as ____
a) Row vector
b) T=[Tx,Ty]T
c) f=[fx,fy]T
d) σ=Dε
Answer: b
Explanation: Traction or tractive force is the force used to generate motion between body and a tangential
surface, through the use of dry friction, through the use of hear force. Tractive force is defined as
T=[Tx,Ty]T

10. In two dimensional modeling, elemental volume is given by ____


a) dV=tdA
b) dV=dA
c) f=[fx,fy]T
d) Trussky program
Answer: a
Explanation: In mathematics, a volume element provides a means for integrating a function with respect to
volume in various co-ordinate systems such as spherical co-ordinates and cylindrical co-ordinates. Then
elemental volume is given by
dV=tdA.

Two Dimensional Problems – Constant Strain Triangle


1. Finite element method uses the concept of _____
a) Nodes and elements
b) Nodal displacement
c) Shape functions
d) Assembling
Answer: c
Explanation: The finite element method is a numerical method for solving problems of engineering and
mathematical physics. Finite element method uses the concept of shape functions in systematically developing
the interpolations.

2. For constant strain elements the shape functions are ____


a) Spherical
b) Quadratical
c) Polynomial
d) Linear
Answer: d
Explanation: The constant strain triangle element is a type of element used in finite element analysis which is
used to provide an approximate solution in a 2D domain to the exact solution of a given differential equation. For
CST shape functions are linear over the elements.

3. Linear combination of these shape functions represents a ______


a) Square surface
b) Linear surface
c) Plane surface
d) Combinational surface
Answer: c
Explanation: A constant strain element is used to provide an approximate solution to the 2D domain to the exact
solution of the given differential equation. The shape function is a function which interpolates the solution
between the discrete values obtained at the mesh nodes.

4. In particular, N1+N2+N3 represent a plane at a height of one at nodes ______


a) One
b) Two
c) Three
d) One, two and three
Answer: d
Explanation: Any linear combination of these shape functions also represents a plane surface. In particular,
N1+N2+N3 represents a plane height of one at nodes one, two, and, three and thus it is parallel to the triangle
123.
5. If N3 is dependent shape function, It is represented as ____
a) N3=ξ
b) N3=1-ξ
c) N3=1-η
d) N3=1-ξ-η
Answer: d
Explanation: The shape function is a function which interpolates the solution between the discrete values
obtained at the mesh nodes. N1, N2, N3 are not linearly independent only one of two of these are independent.

6. In two dimensional problems x-, y- co-ordinates are mapped onto ____


a) x-, y- co-ordinates
b) x-, ξ – co-ordinates
c) η-, y- co-ordinates
d) ξ-η-Co-ordinates
Answer: d
Explanation: The similarity with one dimensional element should be noted ; in one dimensional problem the x-
co-ordinates were mapped onto ξ- co-ordinates and the shape functions were defined as functions of ξ. In the
two dimensional elements the x-, y-, co-ordinates are mapped onto ξ-,,η – co-ordinates.

7. The shape functions are physically represented by _____


a) Triangular co-ordinates
b) ξ-,η-Co-ordinates
c) Area co-ordinates
d) Surface co-ordinates
Answer: c
Explanation: The shape function is a function which interpolates the solution between discrete values obtained at
the mesh nodes. Therefore appropriate functions have to be used and as already mentioned; low order typical
polynomials are used in shape functions. The shape functions are physically represented by area co-ordinates.

8. A1 is the first area and N1 is its shape function then shape function N1= ___
a) A1/A
b) A-A1
c) A1+A
d) A1
Answer: a
Explanation: The shape functions are physically represented by area co-ordinates. A point in a triangle divides
into three areas. The shape functions are precisely represented as
N1=A1/A .

9. The equation u=Nq is a _____ representation.


a) Nodal
b) Isoparametric
c) Uniparametric
d) Co-ordinate
Answer: b
Explanation: The isoparametric representation of finite elements is defined as element geometry and
displacements are represented by same set of shape functions.

10. For plane stress or plane strain, the element stiffness matrix can be obtained by taking _____
a) Shape functions, N
b) Material property matrix, D
c) Iso parametric representation, u
d) Degrees of freedom, DoF
Answer: b
Explanation: The material property matrix is represented as ratio of stress to strain that is σ=Dε . Therefore by
this relation element stiffness matrix can be obtained by material property matrix.
11. In a constant strain triangle, element body force is given as ____
a) fe=[fx,fy,fx,fy,fx,fy]T
b) fe=teAe/3
c) fe=teAe/3[fx,fy,fx,fy,fx,fy]T
d) fe=teAe/3[fx,fy]T
Answer: c
Explanation: A body force is a force which acts through the volume of the body. Body forces contrast with the
contact forces or the classical definition of the surface forces which are exerted to the surface of the body

12. Traction force term represented as ___


a) ∫uT Tl
b) ∫uTT
c) ∫uT
d) uTTl
Answer: a
Explanation: Traction force or tractive force are used to generate a motion between a body and a tangential
surface, through the use of dry friction, through the use of shear force of the surface is also commonly used.

13. In the equation KQ=F, K is called as ____


a) Stiffness matrix
b) Modified stiffness matrix
c) Singular stiffness matrix
d) Uniform stiffness matrix
Answer: b
Explanation: The stiffness matrix represents system of linear equations that must be solved in order to ascertain
an approximate solution to differential equation. The stiffness and force modifications are made to account for
the boundary conditions.

14. Principal stresses and their directions are calculated by using ____
a) Galerkin approach
b) Rayleigh method
c) Potential energy method
d) Mohr’s circle method
Answer: d
Explanation: Mohr’s circle is two dimensional graphical representation of the transformation law. While
considering longitudinal stresses and vertical stresses in a horizontal beam during bending.

15. I the distribution of the change in temperature ΔT, the strain due to this change is ____
a) Constant strain
b) Stress
c) Initial strain
d) Uniform strain
Answer: c
Explanation: The amount of heat transferred is directly proportional to the temperature change. The distribution
of change in temperature, the strain due to this change is initial strain.

Two Dimensional Problem Modelling and Boundary Conditions


1. Finite element method is used for computing _____ and _____
a) Stress and strain
b) Nodes and displacement
c) Nodes and elements
d) Displacement and strain
Answer: d
Explanation: The finite element method is a numerical method for solving problems of engineering and
mathematical physics. To solve the problem it subdivides a larger problem into smaller, simpler parts that are
called finite elements.
2. In deformation of the body, the symmetry of ______ and symmetry of ____ can be used effectively.
a) Stress and strain
b) Nodes and displacement
c) Geometry and strain
d) Geometry and loading
Answer: d
Explanation: Deformation changes in an object’s shape or form due to the application of a force or forces.
Deformation proportional to the stress applied within the elastic limits of the material.

3. For a circular pipe under internal or external pressure, by symmetry all points move _____
a) Radially
b) Linearly
c) Circularly
d) Along the pipe
Answer: a
Explanation: The boundary conditions require that points along x and n are constrained normal to the two lines
respectively. If a circular pipe under internal or external pressure, by symmetry all the points move radially.

4. Boundary conditions can be easily considered by using _______


a) Rayleigh method
b) Penalty approach method
c) Galerkin approach
d) Potential energy approach
Answer: b
Explanation: In computation of Finite element analysis problem defined under initial or boundary conditions. For
implementation of boundary conditions we need a staggered grid.

5. When dividing an area into triangles, avoid large _____


a) Dimensions
b) Loading
c) Aspect ratios
d) Boundary conditions
Answer: c
Explanation: Aspect ratio is defined as ratio of maximum to minimum characteristics dimensions. For this reason
we can avoid large aspect ratios when dividing an area into triangles.

6. In dividing the elements a good practice may be to choose corner angles in the range of ____
a) 30-120°
b) 90-180°
c) 25-75°
d) 45-180°
Answer: a
Explanation: The best elements are those that approach an equilateral triangular configuration. Such
configurations are usually not possible. A good practice is to choose corner angle in the range of 30-120°.

7. Stresses can be change widely at ____


a) Large circular sections
b) Notches and fillets
c) Corners
d) Crystals
Answer: b
Explanation: In a structure geometrical notches, such as holes cannot be avoided. The notches are causing in a
homogeneous stress distribution, as notches fillets are also a cause for in homogenous stress distribution.

8. The Constant strain triangle can give____ stresses on elements.


a) Linear
b) Constant
c) Uniform
d) Parallel
Answer: b
Explanation: The constant strain triangle or cst is a type of element used in finite element analysis which is used
to provide an approximate solution in a 2D domain to the exact solution of a given differential equation. By this
we get constant stresses on elements.
9. The _____ can be obtained even with coarser meshes by plotting and extrapolating.
a) Minimum stresses
b) Minimum strain
c) Maximum stresses
d) Maximum strain
Answer: c
Explanation: Coarse mesh is more accurate in getting values. The smaller elements will better represent the
distribution. Better estimates of maximum stress may be obtained even with coarser meshes. Coarse meshes
are recommended for initial trails.

10. Coarser meshes are recommended for _____


a) Loading
b) Notches and fillets
c) Crystals
d) Initial trails
Answer: d
Explanation: The smaller elements will better represent the distribution. Coarse mesh is more accurate in getting
values. Better estimates of maximum stress may obtained even with the coarse meshes.

11. Increasing the number of nodes in coarse mesh regions where stress variations are high, should give better
results. This method is called _____
a) Divergence
b) Convergence
c) Convergent- divergent
d) Un defined
Answer: b
Explanation: At the initial trails, errors may be fixed, before running large number of elements. The convergence
is successively increasing the number of elements in finite element meshes.

Two Dimensional Isoparametric Elements – Four Node Quadrilateral

1. In two dimensional isoparametric elements, we can generate element stiffness matrix by using ____
a) Numerical integration
b) Differential equations
c) Partial derivatives
d) Undefined
Answer: a
Explanation: The term isoparametric is derived from the use of the same shape functions (or interpolation
functions) [N] to define the element’s geometric shape as are used to define the displacements within the
element.

2. The vector q=[q1,q2………q8]T of a four noded quadrilateral denotes ____


a) Load vector
b) Transition matrix
c) Element displacement vector
d) Constant matrix
Answer: c
Explanation: A displacement is a vector whose length is the shortest distance from the initial to the final position
of a point P. It quantifies both the distance and direction of an imaginary motion along a straight line from the
initial position to the final position of the point.

3. For a four noded quadrilateral, we define shape functions on _____


a) X direction
b) Y direction
c) Load vector
d) Master element
Answer: d
Explanation: Master Element (ME) is the main point of reference in our analysis. The ME represents the person
itself, and it gives us a primary layer of our personality. To determine the quality of ME, and overall chart, we
have to analyze what kind of connection and access ME has to other Elements. The shape function is the
function which interpolates the solution between the discrete values obtained at the mesh nodes.
4. The master element is defined in ______
a) Co-ordinates
b) Natural co-ordinates
c) Universal co-ordinates
d) Radius
Answer: b
Explanation: Master Element (ME) is the main point of reference in our analysis. The ME represents the person
itself, and it gives us a primary layer of our personality. To determine the quality of ME, and overall chart, we
have to analyze what kind of connection and access ME has to other Elements.

5. Shape function can be written as _____


a) Nt=(1-ξ)(1-η)
b) Nt=(1-ξ)
c) Nt=(1-η)
d) Nt=1/4(1-ξ)(1-η)
Answer: d
Explanation: The shape function is the function which interpolates the solution between the discrete values
obtained at the mesh nodes. Therefore, appropriate functions have to be used and, as already mentioned, low
order polynomials are typically chosen as shape functions.

6. For a four noded element while implementing a computer program, the compact representation of shape
function is ____
a) Nt=1/4(1-ξ)(1-η)
b) Nt=(1-ξ)(1-η)
c) Nt=1/4(1+ξξi)(1+ηηi)
d) Undefined
Answer: c
Explanation: Four Node Quad is a four-node plane-strain element using bilinear isoparametric formulation. This
element is implemented for simulating dynamic response of solid-fluid fully coupled material, based on Biot’s
theory of porous medium. Each element node has 3 degrees-of-freedom (DOF): DOF 1 and 2 for solid
displacement (u) and DOF 3 for fluid pressure (p).

7. The stiffness matrix from the quadrilateral element can be derived from _____
a) Uniform energy
b) Strain energy
c) Stress
d) Displacement
Answer: b
Explanation: In the finite element method for the numerical solution of elliptic partial differential equations, the
stiffness matrix represents the system of linear equations that must be solved in order to as certain an
approximate solution to the differential equation.

8. For four noded quadrilateral element, the global load vector can be determined by considering the body force
term in _____
a) Kinetic energy
b) Potential energy
c) Kinematic energy
d) Temperature
Answer: b
Explanation: A body force that is distributed force per unit volume, a vector, many people probably call up
Vector’s definition (from Despicable Me). He says: It’s a mathematical term. A quantity represented by an arrow
with both direction and magnitude. … Vector: a quantity with more than one element (more than one piece of
information).

9. Shape functions are linear functions along the _____


a) Surfaces
b) Edges
c) Elements
d) Planes
Answer: b
Explanation: The shape function is the function which interpolates the solution between the discrete values
obtained at the mesh nodes. Therefore, appropriate functions have to be used and, as already mentioned, low
order polynomials are typically chosen as shape functions.
Numerical Integration
1. Which method of approach is useful for evaluating four noded quadratic elements?
a) Numerical integration
b) Penality approach method
c) Gaussian quadrature approach
d) Rayleighs method
Answer: c
Explanation: Gaussian quadrature is to select the n Gauss points and n weights such that provides an exact
answer for polynomials f(ξ) of as large ∼ degree as possible. In other words, the Idea is that if the n-point
integration formula is exact for all polynomials up to as high a degree as possible, then the formula will work well
even if f is not a polynomial.

2. One point formula in quadratic approach is ____


a) w1f(ξ1)
b) σ=εD
c) Nt=(1-ξ)(1-η)
d) Constant matrix
Answer: a
Explanation: In elementary algebra, the quadratic formula is the solution of the quadratic equation. There are
other ways to solve the quadratic equation instead of using the quadratic formula, such as factoring, completing
the square, or graphing. This is seen to be the familiar midpoint rule.

3. Two point formula of a quadratic approach is _____


a) X direction
b) w1f(ξ1)+w2f(ξ2)
c) Nt=(1-ξ)(1-η)
d) σ=D

Answer: b
Explanation: In elementary algebra, the quadratic formula is the solution of the quadratic equation. There are
other ways to solve the quadratic equation instead of using the quadratic formula, such as factoring, completing
the square, or graphing. From this solution, we can conclude that n-point Gaussian quadrature will provide an
exact answer if f is a polynomial of order (2n – 1) or less.

4. The extension of Gaussian quadrature to two-dimensional integrals of the form of _____


a) I≈∑ni=1∑nj=1wiwjf(ξi,ηj)
b) Natural co-ordinates
c) w1f(ξ1)+w2f(ξ2)
d) w1f(ξ1)
Answer: a
Explanation: In numerical analysis, a quadrature rule is an approximation of the definite integral of a function,
usually stated as a weighted sum of function values at specified points within the domain of integration. An n-
point Gaussian quadrature rule, is a quadrature rule constructed to yield an exact result for polynomials ofdegree
2n − 1 or less by a suitable choice of the points xi and weights wi for i=1,…, n. The domain of integration for
such a rule is conventionally taken as [−1, 1].

5. Stiffness integration for quadratic element for 2*2 matrix is ____


a) Nt=(1-ξ)(1-η)
b) kij=∑4IP=1WIP∅IP
c) Nt=(1-η)
d) Nt=1/4(1-ξ)(1-η)
Answer: b
Explanation: Stiffness is the rigidity of an object, the extent to which it resists deformation in response to an
applied force. The complementary concept is flexibility or pliability: the more flexible an object is, the less stiff it
is. A stiff equation is a differential equation for which certain numerical methods for solving the equation are
numerically unstable, unless the step size is taken to be extremely small.
6. The stresses in the quadratic element are not ______
a) Linear
b) Uniform
c) Constant
d) Undefined
Answer: c
Explanation: The stress applied to a material is the force per unit area applied to the material. The maximum
stress a material can stand before it breaks is called the breaking stress or ultimate tensile stress. Tensile
means the material is under tension. The forces acting on it are trying to stretch the material.

7. The stresses are evaluated at the __________


a) Nodal points
b) Nodal displacements
c) Gauss points
d) Elements
Answer: c
Explanation: The stress applied to a material is the force per unit area applied to the material. The maximum
stress a material can stand before it breaks is called the breaking stress or ultimate tensile stress. The forces
acting on it are trying to stretch the material. In numerical analysis, a quadrature rule is an approximation of the
definite integral of a function, usually stated as a weighted sum of function values at specified points within the
domain of integration.

8. For quadrilateral with 2X2 integration gives _____ sets of stress values.
a) One
b) Two
c) Three
d) Four
Answer: d
Explanation: The stress applied to a material is the force per unit area applied to the material. The maximum
stress a material can stand before it breaks is called the breaking stress or ultimate tensile stress. Tensile
means the material is under tension. The forces acting on it are trying to stretch the material.

9. For degenerate four noded quadrilateral element the errors are _____
a) Constant
b) Uniform
c) Higher
d) Lesser
Answer: c
Explanation: A degenerated element is an element whose characteristic face shape is quadrilateral, but is
modeled with at least one triangular face. Degenerated elements are often used for modeling transition regions
between fine and coarse meshes, or for modeling irregular and warped surfaces.

10. Gauss points are also the points used for numerical evaluation of _____
a) Surfaces
b) ke
c) Elements
d) Planes
Answer: b
Explanation: Stiffness is the rigidity of an object, the extent to which it resists deformation in response to an
applied force. The complementary concept is flexibility or pliability: the more flexible an object is the less stiff it is.
A stiff equation is a differential equation for which certain numerical methods for solving the equation are
numerically unstable, unless the step size is taken to be extremely small.

 Four Node Quadrilateral for Axis Symmetric Problems


1. In the four-node quadrilateral element, the shape functions contained terms _________
a) ξ
b) σ
c) ∅
d) Undefined
Answer: a
Explanation: FourNodeQuad is a four-node plane-strain element using bilinear isoparametric formulation. This
element is implemented for simulating dynamic response of solid-fluid fully coupled material, based on Biot’s
theory of porous medium. Each element node has 3 degrees-of-freedom (DOF): DOF 1 and 2 for solid
displacement (u) and DOF 3 for fluid pressure (p).

2. A _________ element by using nine-node shape function.


a) Load vector
b) Sub parametric
c) Element displacement vector
d) Constant matrix
Answer: b
Explanation: The Nine-Node Biquadratic Quadrilateral This element is often abbreviated to Quad9 in the FEM
literature. This element has three types of shape functions, which are associated with corner nodes, midside
nodes and center node, respectively.

3. Eight-Node Quadrilateral. This element belongs to the ________ family of elements.


a) Serendipity
b) Constant matrix
c) Load vector
d) Master element
Answer: a
Explanation: The Eight-Node “Serendipity” Quadrilateral. This element is often abbreviated to Quad8 in the FEM
literature. It is an eight-node quadrilateral element that results when the center node 9 of the biquadratic
quadrilateral (Quad9) is eliminated by kinematic constraints.

4. N1, is of the form ____


a) Co-ordinates
b) N1=c(1-ξ)(1-η)(1+ξ+η)
c) N1=(1-ξ)(1-η)
d) N1=(1-ξ)

Answer: b
Explanation: The shape function is the function which interpolates the solution between the discrete values
obtained at the mesh nodes. Therefore, appropriate functions have to be used and, as already mentioned, low
order polynomials are typically chosen as shape functions. In this work linear shape functions are used.

5. Six node triangular elements is also known as _____


a) Triangle
b) Quadratic triangle
c) Interpolation
d) Shape function
Answer: b
Explanation:. By referring to the master element where ϛ=1-ξ-η. Because of terms ξ 2,η2 etc. in the shape
functions, this element is also called a quadratic triangle. The isoparametric representation is
u=Nq.

6. In six node triangular element, the gauss points of a triangular element can be defined by ____
a) Two point rule
b) Three point rule
c) One point rule
d) Undefined
Answer: c
Explanation: In numerical analysis, a quadrature rule is an approximation of the definite integral of a function,
usually stated as a weighted sum of function values at specified points within the domain of integration.

7. The mid node should not be outside of the triangular element this condition should ensures that det J does not
attain a value ____
a) Constant
b) Zero
c) Unity
d) Infinite
Answer: b
Explanation: The Mid-Node Admissible Spaces (MAS) [1,2] for two-dimensional quadratic triangular finite
elements are extended to three-dimensional quadratic tetrahedral finite elements (3DQTE). The MAS concept
for 3DQTE postulates a bounded region within which a mid-side node of a curved edge of the 3DQTE can be
placed to ensure maintaining a specified minimum and maximum Jacobian determinant value at any point of the
element.

8. The nodal temperature load can be evaluated by using _____


a) Uniform energy
b) Strain energy
c) Numerical integration
d) Displacement
Answer: c
Explanation: A temperature can be applied to nodes, surfaces, or parts in a model. A surface temperature
applies nodal temperatures to each node on the surface, and a part temperature applies nodal temperatures to
each node in the part. A temperature is used for a thermal stress analysis.

9. The gauss points for a triangular region differ from the _____ region.
a) Rectangular
b) Triangular
c) Square
d) Temperature
Answer: c
Explanation: In numerical analysis, a quadrature rule is an approximation of the definite integral of a function,
usually stated as a weighted sum of function values at specified points within the domain of integration.

10. In a nine node quadrilateral, the shape functions can be defined as _______
a) Shape functions
b) Generic shape functions
c) Elements
d) Planes
Answer: b
Explanation: The shape function is the function which interpolates the solution between the discrete values
obtained at the mesh nodes. Therefore, appropriate functions have to be used and, as already mentioned, low
order polynomials are typically chosen as shape functions. In this work linear shape functions are used.

Beams and Frames – Finite Element Formulation


1. During finite element formulation of beam each node has _______ degrees of freedom.
a) three
b) two
c) one
d) six
Answer: b
Explanation: During finite element formulation of beam, each node has two degrees of freedom. The two
degrees of freedom on each node represent the transverse displacement and the slope or rotation of the node.

2. Beams are horizontal members used for supporting transverse loading.


a) True
b) False
Answer: a
Explanation: Beams are horizontal members supporting transverse loads acting on it. Some examples of beams
include shafts, bridges, and members in buildings.

3. The total number of degrees of freedom in a beam with four nodes is ______
a) four
b) eight
c) sixteen
d) thirty two
Answer: b
Explanation: Number of degrees of freedom per node in a beam element=2
Number of nodes in beam element=4
Total number of degrees of freedom=2*4=8

4. The displacements in beam elements are interpolated using _______


a) shape elements
b) shape functions
c) shape parameters
d) shape factors
Answer: b
Explanation: Shape functions are used in beam elements to interpolate the displacements. The shape functions
along with nodal displacements can be used to interpolate displacements in beam elements.

5. The shape functions for interpolation on beam elements are defined on the range of ________
a) 0 to +1
b) -1 to 0
c) 0 to +2
d) -1 to +1
Answer: d
Explanation: The shape function for interpolation is defined in the range of -1 to +1. The value varies between -1
to +1 where value on one node is -1 and the value on other node is +1.

6. In beam elements the cross section of the element is assumed.


a) True
b) False
Answer: a
Explanation: Beam elements are a type of one dimensional element. The cross section of the geometry is
assumed where the beam element is used.

7. Which of the following statements is correct?


a) Stiffness coefficient value for numerical solution is less than the value of exact solution
b) Stiffness coefficient value for numerical solution is greater than the value of exact solution
c) Stiffness coefficient value for numerical solutions is equal to the value of exact solution
d) Stiffness coefficient value for numerical solutions is twice the value of exact solution
Answer: b
Explanation: The stiffness coefficient value for numerical solution is greater than the value of exact solutions.
This yields the displacement value in numerical solution lower as compared to the value of exact solution.

Beams and Frames – Load Vector


1. On a simply supported beam with uniformly distributed load (p) over length (l) the value of reaction force at
one support is _______
a) p*l
b) (p*l)/2
c) (p*l)2
d) (p*l)/3
Answer: b
Explanation: Overall force acting on the beam=p*l
The reaction force at one of the two supports=(p*l)/2.

2. In Galerkin method we convert a continuous operator problem into a discrete problem.


a) True
b) False
Answer: a
Explanation: In Galerkin method we convert a continuous operator problem into a discrete problem. In beams
the problem is formulated into finite elements using Galerkin Method.

3. Which of the following is not a one dimensional element?


a) bar
b) brick
c) beam
d) rod
Answer: b
Explanation: Brick is not a one dimensional element. One dimensional element is used when one dimension of
the model geometry is significantly greater than the other two dimensions.

4. Three geometrically identical beams made out of steel, aluminum, and titanium are axially loaded. Which of
the following statements is correct?
a) Stress in titanium is the least
b) Stress in cast iron is the highest
c) Stress in steel is the least
d) Stress in all three beams is the same
Answer: d
Explanation: The stress in all three beams will be induced equally. Stress in not dependent on the material, but
the geometry and cross section of the element.

5. The application of force at which of the following point on a beam will nullify the effect of torsion?
a) Centroid
b) Center of mass
c) Extreme fiber
d) Shear centre
Answer: d
Explanation: The application of force on shear centre nullifies the effect of torsion on a beam element. This is
useful when the cross section of beam is asymmetric and creates a twisting effect on application of force.

6. For a taper beam element two cross sections are necessary to define the geometry.
a) True
b) False
Answer: a
Explanation: A taper beam element requires two cross sections to define the geometry. Regular beam element
cannot take into account the variation in cross section required to define the geometry.

7. Which of the following statements is correct?


a) Beam elements are recommended for unsymmetrical cross sections
b) Bar elements are recommended for unsymmetrical cross sections
c) Beam and bar elements can both be used for unsymmetrical cross sections
d) Neither beam nor bar elements can be used for unsymmetrical cross sections
Answer: a
Explanation: Beam elements are recommended for unsymmetrical cross sections due to their ability to take into
account the shear centre. Thus shear centre can nullify effects of torsion acting on unsymmetrical cross section
which is limited in case of bar elements.

Beams and Frames – Boundary Conditions


1. Symmetry in application of boundary conditions should be avoided in which of the following type of analysis?
a) Linear static analysis
b) Modal analysis
c) Thermal analysis
d) Nonlinear static analysis
Answer: b
Explanation: Symmetric boundary conditions should not be used for modal analysis. Symmetric model would
miss some of the modes of modal analysis or out of phase modes.

2. Boundary conditions are applied to simulate the physical constraints on the finite element model.
a) True
b) False
Answer: a
Explanation: Boundary conditions simulate the physical constraints on the finite element model. Application of
boundary conditions is a crucial preprocessing step to yield accurate solution.

3. Which of the following is the correct equation for stiffness (K) of an element given value of force (F) and
displacement (Q)?
a) FQ=K
b) KQ=F
c) KF=Q
d) KFQ=1
Answer: b
Explanation: The correct equation is given by KQ=F. The value of force (F) is the product of stiffness (K) and
displacement (Q). The value of stiffness (K) of the element determines the displacement of the node.

4. Which of the following conditions must be fulfilled to apply symmetry in a finite element model?
a) Geometry of the model is symmetric
b) Boundary conditions to be applied are symmetric
c) Geometry model has large number of nodes
d) Geometry of the model is symmetric and boundary conditions to be applied are symmetric
Answer: d
Explanation: The geometry and boundary conditions both have to be symmetric to apply any kind of symmetry.
Half or quarter portions of a model can be used to reduce computational cost.

5. Which of the following boundary conditions cannot be directly applied on solid elements?
a) Force
b) Pressure
c) Support
d) Torque
Answer: d
Explanation: Torque cannot be directly applied on solid element in finite element model. Since solid elements
have three translational degrees of freedom and no rotational degrees of freedom torque cannot be directly
applied on solid elements.

6. Traction is force acting on an area in any direction other than normal.


a) True
b) False
Answer: a
Explanation: Traction is force acting on an area in any direction other than normal. The force acting on an area
in normal direction is called as pressure. Traction is boundary condition applied where force acting on a surface
is not normal to the surface such as friction and drag.

7. Which of the following statements is correct?


a) Reaction force at supports is equal to the sum of the product of stiffness and displacement
b) Reaction force at supports is equal to the product of sum of stiffness and displacement
c) Reaction force at supports is equal to the sum of stiffness’s
d) Reaction force at supports is equal to the sum of displacements
Answer: a
Explanation: Reaction force at supports is equal to the sum of the product of stiffness and displacement. The
stiffness and displacement matrices are multiplied for each element and then cumulated to find the reaction
force at supports.

8. Which of the following equations give the relation between material properties like modulus of elasticity (E),
modulus of rigidity (G), and Poisson’s ratio (u)?
a) E = 2*G*(1+u)
b) E = 3*G*(1+u)
c) E = 2*G*(1-u)
d) E = 3*G*(1-u)
Answer: a
Explanation: The relation between the material properties is given by
E = 2*G*(1+u)
Here E is the ratio of normal stress to normal strain. G is the ratio of shear stress to shear strain and u is theratio
of lateral strain to longitudinal strain.

 Library of Elements and Interpolation Functions – 1


1. Which option is not correct about the three-noded triangular plane stress (linear) element used in FEM?
a) It has six degrees of freedom
b) It belongs to both the isoparametric and superparametric element families
c) It can be improved by the addition of internal degrees of freedom
d) Delaunay triangulation can be used for its mesh generation
Answer: c
Explanation: The three-node triangular element with linear displacements for the plane stress problem is simply
called a linear triangle. It has six degrees of freedom and it belongs to both the isoparametric and
superparametric element families. A mesh of linear trianglecan be easily generated using Delaunay
triangulation, but the element cannot be improved by the addition of internal degrees of freedom; rather, it can
be improved by increasing the number of nodes.

2. In FEM, which option is used to develop the Higher-order triangular elements (i.e. triangular elements with
interpolation functions of higher degree) systematically?
a) Pascal’s triangle
b) Galerkin method
c) Jacobi method
d) Delaunaytriangulation
Answer: a
Explanation: The Higher-order triangular elements (also the Lagrange family of triangular elements) can be

systematically developed with the help of Pascal’s triangle. Finite element equations are obtained using the
Galerkin method. Jacobi is used for eigenvalue problems. The Delaunay method is used to generate mesh for
triangular elements.

3. In FEM, What is the number of displacement polynomials necessary for finding displacements in a linear
triangular element?
a) 1
b) 2
c) 3
d) 4
Answer: b
Explanation: The number of displacement polynomials for an element is equal to the degrees of freedom of each
node of the element. A linear triangular element has three nodes and two degrees of freedom at each node.
Thus, the total number of displacement polynomials necessary for finding displacements is two.

4. Concerning triangular elements in FEM, which option is not correct about the mathematical formula of
Pascal’s triangle?
a) It contains the terms in two coordinates only
b) The position of the terms can be viewed as the nodes of a triangular element
c) The position of the first and last terms of a row is at the vertices of a triangular element
d) A triangular element of order 2 corresponds to the second row

Answer: d
Explanation: A Pascal’s triangle contains the terms of polynomials of various degrees in two coordinates. We
can view the positions of the terms as nodes of a triangular element, with the constant term and the first and last
terms of a given row being the vertices of the triangle. A triangular element of order 2 (i.e., the degree of the
polynomial is 2) contains six nodes and corresponds to the third row of Pascal’s triangle.

5. Which option is not correct about the four-noded rectangular plane stress element used in FEM?
a) It has eight degrees of freedom
b) Shape functions N1, N2, N3 and N4 are bilinear functions of x and y
c) The displacement field is continuous across elements
d) Its Delaunay triangulation is unique
Answer: d
Explanation: The four-node quadrilateral element with linear displacements for a plane stress problem has two
degrees of freedom at each node. The total degrees of freedom of the element is eight. The displacement field is
continuous across elements connected at nodes and the shape functions N1, N2, N3 and N4 are bilinear
functions of x and y. Its Delaunay triangulationis not unique, but it has two solutions.

6. In the FEM element library, what is the other name of a higher-order element?
a) Complex element
b) Simplex element
c) Linear element
d) Nonlinear element
Answer: a
Explanation: Simplex and linear elements contain nodes only at endpoints but not at the interior. They have
linear polynomials as interpolation functions. Higher-order elements can be created easily from simplex
elements by adding additional intermediate nodes to each element. They are also called complex elements.

7. In the FEM element library, an eight noded quadrilateral element belongs to which family?
a) Serendipity
b) Linear
c) Simplex
d) Quadratic
Answer: a
Explanation: The Serendipity elements are the rectangular elements with intermediate nodes but no interior
nodes, i.e., all nodes lie on boundary. Since four nodes of an eight noded quadrilateral element are intermediate
nodes, it belongs to the Serendipity family. Simplex and linear elements contain nodes only at endpoints but not
at intermediate points. They have linear polynomials as interpolation functions. A quadratic element contains
interior nodes.

8. In FEM, which option is not correct about the Lagrange family of triangular elements?
a) The nodes are uniformly spaced
b) Pascal’s triangle can be viewed as a triangular element
c) Dependent variables and their derivatives are continuous at inter-element boundaries
d) 2nddegree polynomial corresponds to 6 noded triangle
Answer: c
Explanation: In Lagrange family elements the nodes are regularly placed everywhere on the grid i.e., they
areuniformly spaced. The location of the terms in Pascal’s triangle gives the location of nodes in elements. Thus,
Pascal’s triangle can be viewed as a triangular element. The derivatives of dependent variables are not
continuous at inter-element boundaries. 2nd-degree polynomial corresponds to 6 noded triangles.

9. What is the displacement function for one-dimensional, two noded linear elements in terms of its shape
functions N1 and N2?
a) N1u1+N2u2
b) N1u2+N2u1
c) N1u1-N2u2
d) N1u2-N2u1
Answer: a
Explanation: For a linear element, the displacement function is a linear polynomial of nodal displacements. A
one-dimensional, two noded linear elements have two nodes with corresponding displacements u 1, u2 and
corresponding shape functions N1, N2. The displacement function is given by N1u1+N2u2.

10. In the FEM element library, what is the correct name for a six noded triangular element?
a) Linear strain triangular element
b) Constant strain triangular element
c) Variable strain triangular element
d) Higher-order triangular element
Answer: a
Explanation: A Constant strain triangular (CST) element is the simplest triangular element with three end nodes.
A Linear strain triangular element (LST) is a six-noded triangular element with three intermediate nodes in
addition to three end nodes. For plane stress applications, LST gives an accurate result compare to the three-
noded CST element. The variable strain triangular element is a higher-order triangular element with more than
six nodes.

Library of Elements and Interpolation Functions – 2


1. In the FEM element library, what is the correct name for a three noded triangular element?
a) Linear strain triangular element
b) Constant strain triangular element
c) Variable strain triangular element
d) Higher-order triangular element
Answer: b
Explanation: A Constant Strain Triangular (CST) element is the simplest triangular element with only three nodes
that are located at its ends. A Linear Strain Triangular element (LST) is a six-noded triangular element with three
intermediate nodes in addition to three end nodes. For plane stress applications, LST gives an accurate result
compare to the three-noded CST element. The variable strain triangular element is a higher-order triangular
element with more than six nodes.

2. If the geometry and other parameters of an element are defined in terms of only one spatial coordinate, then
the element is a one-dimensional element?
a) True
b) False
Answer: a
Explanation: A one-dimensional element possesses one degree of freedom at each node. It is also known as a
bar element or line element. Geometry and other parameters of a bar element are defined in terms of one spatial
coordinate only. If a one-dimensional element has two nodes with corresponding displacements u 1, u2and
corresponding shape functions N1, N2, then the displacement function is given by N1u1+N2u2.

3. In FEM, what is the name of the element specified by a polynomial of order two or more?
a) Nonlinear element
b) Higher-order element
c) Linear element
d) Master element
Answer: b
Explanation: Simplex and linear elements contain nodes only at endpoints but not at the interior. They have
linear polynomials as interpolation functions. Higher-order elements can be created easily from simplex
elements by adding additional intermediate nodes to each element. They are also called complex elements.

4. In FEM, what is the name of the shape function of an Euler-Bernoulli beam element?
a) Hermite cubic interpolation function
b) Lagrange cubic interpolation function
c) Consistent element functions
d) Quadratic interpolation functions
Answer: a
Explanation: Interpolation function of a beam element is continuous with nonzero derivatives up to order two. It is
derived by interpolating the displacement polynomial as well as its derivative at the nodes. Such
interpolationfunctions are called as Hermite cubic interpolation (or cubic spline) function. The Lagrange cubic
interpolation Functions are derived by interpolating the displacement polynomial but not its derivatives.

5. In FEM, which option is used to develop the Higher-order rectangular elements (i.e., rectangular elements
with interpolation functions of higher degree) systematically?
a) A rectangular array of binomial coefficients
b) Galerkin method
c) Jacobi method
d) Delaunay triangulation
Answer: a
Explanation: Analogous to the Lagrange family of triangular elements, the Lagrange family of rectangular
elements can be developed from a rectangular array of binomial coefficients. Since a linear rectangular element
has four corners (hence, four nodes), the polynomial should have the first four terms 1, x, y, and xy(which form a
parallelogram in Pascal’s triangle and a rectangle in the rectangular array of binomial coefficients).

6. In FEM, what are the elements in which the same shape functions describe the geometry and field
displacement variables?
a) Iso-parametric
b) Axi-Symmetric
c) Super-parametric
d) Sub-parametric
Answer: a
Explanation: In sub-parametric formulations, the geometry is represented by elements of a lower order than
those used to approximate the dependent variable. An example of this category is provided by the beam
element. In iso-parametric formulations (which are the most common in practice), the same element is used to
approximate the geometry as well as the dependent unknowns. In super-parametric formulations, the geometry
is represented by elements of a higher order than those used to approximate the dependent variables.

7. In the Finite Element Method (FEM), if the geometry is represented by elements of a higher order than those
used to approximate the field displacement variables, then it is called super-parametric formulation.
a) True
b) False

Answer: a
Explanation: In super-parametric formulations, the geometry is represented by elements of a higher order than
those used to approximate the dependent variables. In sub-parametric formulations, the geometry is represented
by elements of a lower order than those used to approximate the dependent variable. The beam element
provides an example of this category. In iso-parametric formulations (which are the most common in practice),
the same element is used to approximate the geometry as well as the dependent unknowns.

8. Which option is not correct about the Lagrange rectangular element used in FEM?
a) Second-order Lagrange element has nine nodes
b) Zero-order Lagrange element has one node
c) First-order Lagrange element has four nodes
d) Third-order Lagrange element has fifteen nodes
Answer: d
Explanation: In general a pth-order Lagrange rectangular element has n nodes with n= (p+1) 2, where p=0,1,2 …
For p=0,
n=1.
For p=1,
n=22,
=4.
For p=2,
n=32
=9.
For p=3,
n=42
=16.

9. Which option is not correct about the Lagrange family of triangular elements used in FEM?
a) 2nd-degree polynomial corresponds to 6 noded triangle
b) 0th-degree polynomial corresponds to 1 noded triangle
c) 1st-degree polynomial corresponds to 3 noded triangle
d) 3rd-degree polynomial corresponds to 9 noded triangle
Answer: d
Explanation: A pth degree polynomial corresponds to n noded triangular element with n=0.5(p+2)(p+1), where
n=0, 1, 2 …
For p=0,
n=1.
For p=1,
n=0.5*3*2,
=3.
For p=2,
n=0.5*3*4
=6.
For p=3,
n=0.5*4*5
=10.

10. What is the number of nodes present on the boundary of the Lagrange quadratic rectangular element used
in FEM?
a) 1
b) 4
c) 8
d) 9
Answer: c
Explanation: The Lagrange quadratic rectangular element has nine regularly spaced nodes. Four nodes are
paced at the four corners, four at midpoints of the sides, and one at the center of the element. Thus, a total of 8
boundary nodes are present. Its associated polynomial has a total of nine terms, including the second degree
and third-degree terms.

11. Which nodes of the higher-order elements of the Lagrange family do not contribute to the inter-element
connectivity?
a) Interior nodes
b) All nodes
c) Corner nodes
d) Intermediate nodes
Answer: a
Explanation: Since the Interior nodes of the higher-order elements of the Lagrange family do not contribute to
the inter-element connectivity, they can be condensed out at the element level so that the size of the element
matrices is reduced. The elements formed after removing the Interior nodes are called serendipity elements.

12. What is the reason for an element in the Serendipity family to have a smaller size of stiffness matrix compare
to a similar element in the Lagrange family?
a) Absence of interior nodes
b) Modified element connectivity
c) Lesser interpolation functions
d) Irregular arrangements of nodes
Answer: a
Explanation: The internal nodes of the higher-order elements of the Lagrange family do not contribute to inter-

element connectivity, and hence they are condensed out at element level; as a result, the size of the element
matrices is reduced. However, the element connectivity remains unaffected. The elements formed after
removing the internal nodes are called serendipity elements.

You might also like