0% found this document useful (0 votes)
18 views

Unit1 - 2 Marks

document 1
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
18 views

Unit1 - 2 Marks

document 1
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 54

Unit1 – 2 Marks

1. Define Shape Functions:

Shape functions are mathematical functions used in finite element analysis to interpolate
field values (like displacement) between the nodes of an element.

2. What do you mean by Higher Order Elements?

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.

3. Distinguish Between 1D Bar Element and 1D Beam Element:

• 1D Bar Element: Models axial deformation (stretching or compressing) along a


straight line.

• 1D Beam Element: Models bending, shear, and axial deformation.

4. What is the Galerkin Method of Approximation?

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.

5. Mention the Basic Steps of the Rayleigh-Ritz Method:

1. Assume an approximate solution.

2. Substitute it into the governing equation.

3. Minimize the energy functional.

4. Solve for the unknowns.

6. List Any Four Advantages of Finite Element Method:

1. Handles complex geometries.

2. Provides accurate solutions.

3. Allows local refinement.

4. Can solve a variety of engineering problems.

7. What is Meant by Finite Element?

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:

1. Preprocessing (modeling and meshing).

2. Solution (solving equations).

3. Postprocessing (interpreting results).

9. What is Meant by Degrees of Freedom?

Degrees of freedom refer to the independent variables (like displacement or rotation) that
can change at a node or element.

10. Name the Four Finite Element Analysis Software:

1. ANSYS

2. ABAQUS

3. COMSOL

4. Nastran

Unit 2 – 2 Marks

11. What do you mean by Constitutive Law?

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).

12. Differentiate CST and LST Elements:

• 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.

13. What are the Important Properties of CST Element?

• 2D triangular shape.

• Used for plane stress or plane strain problems.

• Provides constant strain distribution across the element.

14. What are CST & LST Elements?


• CST (Constant Strain Triangle): A type of triangular finite element with constant
strain.

• LST (Linear Strain Triangle): A type of triangular finite element where strain can vary
linearly across the element.

15. When Do We Resort to 1D Quadratic Spar Elements?

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.

16. What Are Called Higher Order Elements?

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.

17. What is a Truss?

A truss is a structural element consisting of straight members connected at joints,


designed to carry axial forces (tension or compression) only. It does not carry bending
moments.

18. State the Properties of a Stiffness Matrix:

• Symmetric (for linear problems).

• Positive semi-definite.

• Relates forces and displacements.

• Size depends on the number of degrees of freedom.

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).

20. Give the General Expression for Element Stiffness Matrix:

The general expression for an element stiffness matrix is:


This expression integrates the product of the shape functions, material properties, and the
geometry over the element.

Unit 3 – 2 Marks

21. What are the Advantages of Natural Coordinates?

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.

22. How Do You Define Two Dimensional Elements?

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?

Higher-order elements use higher-degree polynomials for interpolation, providing more


accurate solutions, especially for complex shapes or higher gradients in stress and
displacement.

25. Give Four Applications Where Axisymmetric Elements Can Be Used:

1. Pressure vessels.

2. Circular shafts.
3. Heat conduction in cylindrical objects.

4. Radial deformation of bearings.

26. Define the Super Parametric Element:

A super parametric element uses a higher-dimensional space for interpolation, allowing


more complex shapes and better accuracy compared to standard parametric elements.

27. What is Meant by Isoparametric Element?

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.

28. What is Axisymmetric Element?

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.

29. What is CST Element?

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.

30. What is Meant by Stress Analysis?

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

31. Write Short Notes on Axisymmetric Problems:

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.

32. Write the Shape Functions for a 1D, 2-Noded Element:

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.

34. What is Meant by Axisymmetric Field Problem?

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.

35. Distinguish Between Plane Stress and Plane Strain Problems:

• 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.

36. Sketch Two 3D Elements Exhibiting Linear Strain Behavior:

(Unfortunately, I can't sketch, but I can describe!)

1. Tetrahedron Element (4 nodes): A 3D element with linear shape functions, used for
general 3D problems.

2. Hexahedron Element (8 nodes): A 3D cubic element with linear strain behavior,


used for modeling cubic or rectangular structures.

37. Define Damping Ratio:

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).

38. What is Meant by Transverse Vibrations?

Transverse vibrations refer to oscillations that occur perpendicular to the axis of a


structure, like a beam vibrating up and down when subjected to forces.
39. What Are the Types of Eigenvalue Problems?

There are two main types of eigenvalue problems:

1. Structural Eigenvalue Problems: Find the natural frequencies of a structure


(vibration modes).

2. Heat Transfer Eigenvalue Problems: Find the eigenmodes of heat conduction


(temperature distribution).

40. Define Frequency of Vibration:

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

41. What do you mean by Isoparametric Formulation?

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.

42. What Are the Types of Non-Linearity?

The main types of non-linearity are:

1. Geometric Non-linearity: Non-linear behavior due to large deformations.

2. Material Non-linearity: Non-linear behavior due to non-linear stress-strain


relationships (e.g., plasticity).

3. Boundary Non-linearity: Non-linear behavior caused by changing boundary


conditions (e.g., contact problems).

43. Define Isoparametric Elements.

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.

For a 2D triangular element (CST element), the shape functions are:

• 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.

45. Define Path Line.

A path line is the trajectory followed by a specific fluid particle as it moves over time.

46. Distinguish Between Essential Boundary Conditions and Natural Boundary


Conditions:

• 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).

47. Define the Stream Function for a One-Dimensional Incompressible Flow:

The stream function is a mathematical function used to describe the flow of an


incompressible fluid. In 1D flow, the stream function typically simplifies to a constant since
the flow is uniform in one direction.

48. Define Heat Transfer.

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.

• Objective: Establish what needs to be solved, such as displacements, stresses, or


temperature distribution.

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.

3. Selection of Element Types

• 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).

• Purpose: Ensure accurate representation of the problem.

4. Selection of Shape Functions


• Description: Define interpolation functions (shape functions) to approximate the
unknown variable within each element.

• Purpose: Represent the variation of the field variable (e.g., displacement or


temperature) within the element.

5. Derivation of Element Equations

• Description: Formulate the governing equations for each element, often using
principles like equilibrium, conservation, or energy minimization.

• Purpose: Establish the local stiffness matrix and force vector.

6. Assembly of the Global System

• Description: Assemble the individual element equations into a global system by


enforcing continuity at shared nodes.

• Purpose: Create a global stiffness matrix and force vector that represent the entire
problem.

7. Application of Boundary Conditions

• Description: Incorporate known displacements, forces, or other constraints into


the global equations.

• Purpose: Reduce the system to a solvable form by addressing physical constraints.

8. Solution of the Global Equations

• Description: Solve the resulting system of linear or nonlinear algebraic equations


(e.g., using direct methods like Gaussian elimination or iterative methods).
• Purpose: Obtain the nodal values of the field variable (e.g., displacements,
temperatures).

9. Post-Processing

• Description: Analyze the computed results, including derived quantities (e.g.,


stresses, strains, heat flux) and visualizations (e.g., contour plots, deformation
plots).

• Purpose: Interpret and validate the solution for engineering insights.

10. Validation and Verification

• Description: Compare the results with theoretical solutions, experimental data, or


benchmarks to ensure accuracy.

• Purpose: Confirm the reliability and correctness of the model.


52.The following differential equation is available for a physical phenomenon
AE (d2y/d 𝒙 2) +qo = 0 with the boundary conditions

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)

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy