Unit1 - 2 Marks
Unit1 - 2 Marks
Shape functions are mathematical functions used in finite element analysis to interpolate
field values (like displacement) between the nodes of an element.
Higher-order elements use polynomial functions of degree higher than 1 (e.g., quadratic or
cubic) to model the solution more accurately within an element.
The Galerkin method is a technique where the error in the solution is weighted and
minimized using the shape functions, leading to a system of equations.
A finite element is a small part of a larger problem, used to approximate the solution to that
problem in the finite element method.
8. State the Three Phases of Finite Element Method:
Degrees of freedom refer to the independent variables (like displacement or rotation) that
can change at a node or element.
1. ANSYS
2. ABAQUS
3. COMSOL
4. Nastran
Unit 2 – 2 Marks
Constitutive law describes the relationship between stress and strain in a material,
defining how it deforms under different loads. It’s used to model material behavior (e.g.,
Hooke’s Law for linear elasticity).
• CST (Constant Strain Triangle) Element: A 2D triangular element with linear shape
functions, used for modeling problems with constant strain.
• LST (Linear Strain Triangle) Element: A linear triangular element where strain
varies across the element.
• 2D triangular shape.
• LST (Linear Strain Triangle): A type of triangular finite element where strain can vary
linearly across the element.
1D quadratic spar elements are used when modeling slender structures (like beams) that
experience bending, where higher accuracy in the displacement field is needed, and linear
elements do not suffice.
Higher-order elements are finite elements that use higher-degree polynomials (e.g.,
quadratic or cubic) for interpolation, providing more accurate solutions compared to linear
elements.
• Positive semi-definite.
19. How Do You Calculate the Size of the Global Stiffness Matrix?
The size of the global stiffness matrix is determined by the total number of degrees of
freedom in the system. For a system with nnn nodes and ddd degrees of freedom per node,
the global stiffness matrix will be of size (nd)×(nd)(nd) \times (nd)(nd)×(nd).
Unit 3 – 2 Marks
Natural coordinates simplify the calculation of element properties and make it easier to
define elements in arbitrary shapes. They avoid complex transformations and are
especially useful in finite element analysis.
Two-dimensional elements are finite elements used to model structures or problems that
lie in a plane, such as 2D stress, strain, and heat transfer problems. These elements have
two spatial dimensions (length and width) and usually have nodes at their corners or
edges.
23. Give One Example Each for Plane Stress and Plane Strain Problems:
• Plane Stress: A thin sheet subjected to in-plane forces, like a flat plate under
tension.
• Plane Strain: A long, thick wall subjected to compressive forces, where strain in the
thickness direction is zero.
24. What Are Higher Order Elements and Why Are They Preferred?
1. Pressure vessels.
2. Circular shafts.
3. Heat conduction in cylindrical objects.
An isoparametric element uses the same shape functions for both geometry and field
variables (like displacement), making it easier to model and solve complex problems.
An axisymmetric element is used for problems that are symmetrical about an axis, such as
circular or cylindrical shapes under axial loading or pressure, simplifying 3D problems into
2D.
The CST (Constant Strain Triangle) element is a 2D triangular finite element where the
strain is constant across the element, often used in simple stress analysis problems.
Stress analysis is the process of determining the internal forces (stress) in materials or
structures when subjected to loads, to ensure they can withstand those forces without
failure.
Unit 4 – 2 Marks
Axisymmetric problems involve structures or systems that have symmetry around an axis,
like cylinders or spheres. These problems are simplified from 3D to 2D by assuming that all
physical behavior (e.g., stress, displacement) depends only on the radial distance and not
the angular direction.
For a 1D, 2-noded linear element, the shape functions N1(x)N_1(x)N1(x) and N2(x)N_2(x)N2
(x) are:
• N1(x)=1−xN_1(x) = 1 - xN1(x)=1−x
• N2(x)=xN_2(x) = xN2(x)=x where xxx is the normalized coordinate along the element,
ranging from 0 to 1.
33. What are the Advantages of Natural Coordinates Over Global Coordinates?
Natural coordinates simplify the element formulation by defining positions relative to the
element itself (usually in terms of local coordinates like ξ, η), rather than global
coordinates. This makes it easier to integrate and calculate element properties for complex
shapes.
An axisymmetric field problem involves a system where the field (e.g., stress, temperature)
is symmetric around a central axis, so the problem can be reduced from 3D to 2D by
assuming all variables depend only on the radial distance and not on the angular or axial
directions.
• Plane Stress: Occurs in thin structures where stresses in the thickness direction
(out of the plane) are assumed to be zero.
• Plane Strain: Occurs in thick structures where strain in the thickness direction is
assumed to be zero.
1. Tetrahedron Element (4 nodes): A 3D element with linear shape functions, used for
general 3D problems.
The damping ratio is a measure of how quickly a vibrating system loses energy due to
damping. A ratio of 0 means no damping, while a ratio of 1 means critical damping (no
oscillation).
The frequency of vibration is the number of complete cycles a vibrating object goes through
per unit of time, typically measured in Hertz (Hz). It tells us how fast the object oscillates.
Unit 5 – 2 Marks
Isoparametric formulation is a method in finite element analysis where the same shape
functions are used to describe both the geometry of an element and the field variables (like
displacement, temperature) inside the element.
Isoparametric elements are finite elements where the same shape functions are used for
both the geometry of the element and the field variables (e.g., displacement or
temperature), making the element formulation simpler and more flexible.
44. Write Down the Shape Function for Two-Dimensional Heat Transfer.
• N1=1−x−yN_1 = 1 - x - yN1=1−x−y
• N2=xN_2 = xN2=x
• N3=yN_3 = yN3=y where xxx and yyy are the local coordinates of the element.
A path line is the trajectory followed by a specific fluid particle as it moves over time.
• Essential Boundary Conditions (Dirichlet): Specify the value of the field variable
(e.g., displacement, temperature) at the boundary (e.g., fixed displacement).
• Natural Boundary Conditions (Neumann): Specify the value of the derivative of the
field variable (e.g., force, flux) at the boundary (e.g., applied force or heat flux).
Heat transfer is the process of thermal energy moving from a hotter object to a cooler one.
It occurs through three mechanisms: conduction, convection, and radiation.
49. Write Down the Expression for Governing Equation in Fluid Mechanics (2-D):
where u and v are the velocity components in the x and y directions, p is pressure, ρ is
density, and μ is viscosity.
50. Write Down the Expression for Velocity Gradient in Fluid Mechanics.
Unit 1 - 16 Marks
51.List and briefly describe the general step of the finite element method. (16)
1. Problem Definition
• Description: Clearly define the physical problem and its parameters, such as
geometry, material properties, external loads, and boundary conditions.
2. Domain Discretization
• Description: Divide the domain into small, manageable subdomains called finite
elements (e.g., lines, triangles, quadrilaterals).
• Purpose: Approximate the complex domain with simpler elements for numerical
calculations.
• Description: Choose appropriate element shapes and types based on the problem’s
geometry and physics (e.g., 1D beams, 2D plane stress, or 3D solid elements).
• Description: Formulate the governing equations for each element, often using
principles like equilibrium, conservation, or energy minimization.
• Purpose: Create a global stiffness matrix and force vector that represent the entire
problem.
9. Post-Processing
Find the value of f(x) using the weighted residual method. (16)
41. The following differential equation is available for a physical phenomenon.
(d2y/d 𝒙 2) + 50 = 0 for 0 ≤ 𝒙 ≤ 10. The trial function is, y =a1 𝒙 (10−𝒙 ),
Boundary conditions are,
y (0) = 0
y (10) = 0
Find the value of the parameter a1 by the following methods:
a) Point collocation c) Least squares
b) Sub domain collocation d) Galerkin
54.Find the deflection at the centre of a simply supported beam of span length subjected to
uniformly distributed load throughout its length as shown in figure, (16)
a)
a)Point collocation method
b) Sub domain collocation
c) Least squares method
d) Galerkin’s method
55.Solve the below equations using Guass-Elimination method. (16)
Unit 2 - 16 Marks
41. Consider a bar as shown in figure, cross sectional area of the bar is 750 mm2 and
young’s modulus is 2×105 N/ mm2. If u1 = 0.5 mm and u2 = 0.625 mm, (16)
i. Displacement at point, P
ii.strain, e
iii.Stress, σ
iv.Element stiffness matrix,[K]
v.Strain energy, U
57.Consider a bar as shown in figure. An axial load of 200 kN is applied at point ‘P’. Take A1
=2400 mm2, E1 = 70, A2 = 600mm2, E2 = 200×109 N/ m2. (16)
58. A thin steel plate of uniform thickness 25mm is subjected to a point load of 420 N at mid
depth as shown in figure. The plate is also subjected to self-weight. If Young’s modulus, E =
2×105 N/ mm2 and unit weight density, ρ = 0.8 ×10-4 N/ mm3
59.The stepped bar shown in Figure is subjected to an increase in temperature,
ΔT = 80°C. Determine the displacements, element stresses and support reactions. (16)
Unit 3 - 16 Marks
61. Determine the shape functions N1, N2 and N3 at the interior point P for the triangular
element shown in the figure. (16)
62.For the isoparametric quadrilateral element shown in figure, the Cartesian co-
ordinates of point P are (6, 4). The loads 10kN and 12kN are acting in x and y
directions on that pointP, evaluate the nodal equivalent forces. (16)
63. For the isoparametric four noded quadrilateral elements shown in figure. Determine the
Cartesian co-ordinates of point P which has local coordinates ε=0.5and η=0.5. (16)
𝟏
64.Evaluate the integral I= ∫−𝟏(𝟐 + 𝐱 + 𝐱𝟐) dx and compare with exact solution. (16)
Unit 4 - 16 Marks
66. For the bar as shown in figure with length 2 L, modulus of elasticity E, mass density ρ,
and cross sectional area A. Determine the first two natural frequencies. (16)
67. Determine the natural frequencies of vibration for a beam fixed at both ends as shown in
figure. The beam has mass density ρ, modulus of elasticity E, cross sectional area A,
moment of inertia I, and length 2L. For simplicity of the long hand calculations, the beam
is discretized into two elements of length L. (16)
68. Determine the natural frequencies for the 3 degrees of freedom system shown in figure.
(16)
𝟒 −𝟐𝟎 −𝟏𝟎
69. Find the eigen values and eigen vectors of (−𝟐 𝟏𝟎 𝟒 )
𝟔 −𝟑𝟎 −𝟏𝟑
70. Determine the Eigen values and natural frequencies of a system whose stiffness and mass
matrices are given below. (16)
[𝑲] =
𝟐𝐀𝐄 𝟑 −𝟏 𝛒𝐀𝐋 𝟔 𝟏
[ ], m= [ ]
𝐋 −𝟏 𝟏 𝟏𝟐 𝟏 𝟐
Unit 5 - 16 Marks
71. An aluminium alloy fin of 7 mm thick and 50 mm Long protrudes from a wall, which is
maintained at 1200C. The ambient air temperature is 220C. The heat transfer co –efficient
and thermal conductivity of the fin material are 140 W/m2K and 55 W/mK respectively.
Determine the temperature distribution of fin. (16)
72. A steel rod of diameter d = 2cm, length L = 5cm and thermal conductivity k = 50W/m0C is exposed at one
end to a constant temperature of 320 0C. The other end is in ambient air of temperature 200C with a
convection coefficient of h= 100W/m2 0C. Determine the temperature at the midpoint of the rod. (16)
73.A pump pumping fluid at Q = 6500 m3/hr is located at coordinates (5, 2) in the elements
as shown in figure. Find the amount of Q allotted to each node. All nodal coordinates are in
m. assume unit thickness of t = 1 mm. (16)