Vous êtes sur la page 1sur 22

FEA Questions & Answers

1. What Is The Finite Element Method (fem)?

The FEM is a novel numerical method used to solve ordinary and partial differential
equations. The method is based on the integration of the terms in the equation to
be solved, in lieu of point discretization schemes like the finite difference method.
The FEM utilizes the method of weighted residuals and integration by parts
(Green-Gauss Theorem) to reduce second order derivatives to first order terms.
The FEM has been used to solve a wide range of problems, and permits physical
domains to be modeled directly using unstructured meshes typically based upon
triangles or quadrilaterals in 2-D and tetrahedrons or hexahedrons in 3-D. The
solution domain is discretized into individual elements – these elements are
operated upon individually and then solved globally using matrix solution
techniques.

2. What Is The History Of The Fem?

Early work on numerical solution of boundary-value problems can be traced to the


use of finite difference schemes; South well used such methods in his book
published in the mid 1940’s. The beginnings of the finite element method actually
stem from these early numerical methods and the frustration associated with
attempting to use finite difference methods on more difficult, geometrically irregular
problems. Beginning in the mid 1950s,efforts to solve continuum problems in
elasticity using small, discrete "elements" to describe the overall behavior of simple
elastic bars began to appear, and such techniques were initially applied to the
aircraft industry. Actual coining of the term "finite element"appeared in a paper by
Clough in 1960. The early use of finite elements lay in the application to structural-
related problems. However, others soon recognized the versatility of the method
and its underlying rich mathematical basis for application in non-structural areas.
Since these early works, rapid growth in usage of the method has continued since
the mid 1970s. Numerous articles and texts have been published, and new
applications appear routinely in the literature.

3. What Is The Method Of Weighted Residuals, I.e., Galerkin’s Method?

The underlying mathematical basis of the finite element method first lies with the
classical Rayleigh-Ritz and variational calculus procedures. These theories
provided the reasons why the finite element method worked well for the class of
problems in which variational statements could be obtained (e.g., linear diffusion
type problems). However,as interest expanded in applying the finite element
method to more types of problems, the use of classical theory to describe such
problems became limited and could not be applied, e.g., fluid-related problems.
Extension of the mathematical basis to non-linear and non-structural problems was
achieved through the method of weighted residuals (MWR), originally conceived
by Galerkin in the early 20th century. The MWR was found to provide the ideal
theoretical basis for a much wider basis of problems as opposed to the Rayleigh-
Ritz method. Basically, the method requires the governing differential equation to
be multiplied by a set of predetermined weights and the resulting product
integrated over space; this integral is required to vanish. Technically, Galerkin's
method is a subset of the general MWR procedure, since various types of weights
can be utilized; in the case of Galerkin's method, the weights are chosen to be the
same as the functions used to define the unknown variables. Most practitioners of
the finite element method now employ Galerkin's method to establish the
approximations to the governing equations.

4. Why Should One Use Finite Elements?

The versatility of the FEM, along with its rich mathematical formulation and
robustness makes it an ideal numerical method for a wide range of problems. The
ability to model complex geometries using unstructured meshes and employing
elements that can be individually tagged makes the method unique. The ease of
implementing boundary conditions as well as being able to use a wide family of
element types is a definite advantage of the scheme over other methods. In
addition, the FEM can be shown to stem from properly-posed functional
minimization principles.

5. Can The Fem Handle A Wide Range Of Problems, I.e., Solve General Pdes?

While the FEM was initially developed to solve diffusion type problems, i.e., stress-
strain equations or heat conduction, advances over the past several decades have
enabled the FEM to solve advection-dominated problems, including
incompressible as well as compressible fluid flow. Modifications to the basic
procedure (utilizing forms of upwinding for advection, i.e., Petrov-Galerkin and
adaptive meshes) allow general advection-diffusion transport equations to be
accurately solved for a wide range of problems.

6. What Is The Advantage Of The Fem Over Finite Difference (fdm) And Finite
Volume (fvm) Methods?
The major advantages of the FEM over FDM and FVM are its built-in abilities to
handle unstructured meshes, a rich family of element choices, and natural handling
of boundary conditions (especially flux relations). The FDM is generally restricted
to simple geometries in which an orthogonal grid can be constructed; for irregular
geometries, a global transformation of the governing equations (e.g., boundary
fitted coordinates) must be made to create an orthogonal computational domain.
Likewise, implementation of boundary conditions in FDM can be cumbersome. The
FVM is an integral approach (typically with limits -0.5 to 0.5) similar to the FEM,
with volumes being used instead of elements. The divergence theorem is used to
establish the final equation set. Solutions are obtained at volume faces, vertices,
or volume centers – some methods employ staggered grids. While FVM can
handle irregular domains using unstructured grids (stemming from the FEM), the
required averaging over the volume limits the method to second order spatial
accuracy.

7. Is There Any Connection Between The Fem And The Boundary Element Method
(bem)?

In the BEM, one reduces the order of the problem by one, i.e., a two-dimensional
domain is reduced to a line integral – a three-dimensional domain becomes a two-
dimensional surface. The BEM only requires the discretization of the boundaries
of the problem domain – no internal meshing is required, as in the FDM, FVM, and
FEM schemes. The BEM requires two applications of the Green-Gauss Theorem
(versus one in the FEM and employing Galerkin’s Method). The method is ideal
for handling irregular shapes and setting boundaries that may extend to (near)
infinity. One can place interior nodes within the BEM to obtain internal values
easily. The BEM works quite effectively for linear differential equations – principally
elliptic equations. However, if one desires to solve nonlinear advection-diffusion
transport equations, the method becomes very cumbersome and computationally
demanding – BEM matrices are dense, and do not readily permit efficient, sparse
matrix solvers to be used as in the FEM.

8. What Is Adaptivity, I.e., H-, P-, R-, And Hp-adaptation?

Adaptivity is an active research area involving either remeshing or increased


interpolation order during the solution process. The method is particularly effective
in fluid flow, heat transfer, and structural analysis. The use of mesh refinement has
been especially effective in aerodynamic simulations for accurately capturing
shock locations in compressible flow. Generally, there are two types of adaptation:
h-adaptation (mesh refinement), where the element size varies while the orders of
the shape functions are kept constant; p-adaptation, where the element size is
constant while the orders of the shape functions are increased (linear, quadratic,
cubic, etc.). Adaptive remeshing (known as r-adaptation) employs a spring analogy
to redistribute the nodes in an existing mesh -no new nodes are added; the
accuracy of the solution is limited by the initial number of nodes and elements. In
mesh refinement (h-adaptation), individual elements are subdivided without
altering their original position. The use of hp-adaptation includes both h- and p-
adaptation strategies and produces exponential convergence rates. Both mesh
refinement and adaptive remeshing are now routinely used in many commercial
codes. A spectral element is a special class of FEM that uses a series of orthogonal
basis functions whereby the unknown terms are solved at selected spectral nodes;
the method is stable and highly accurate, but can become time consuming.

9. How Difficult Is It To Write A Fem Program?

Writing a FEM code is not terribly difficult, especially if one develops the code
utilizing a general set of subroutines, e.g., input data, integration, assembly,
boundary conditions,output, etc. About 90% of a FEM program is generic, which is
fairly common among most FEM codes – they tend to use similar matrix solvers,
quadrature rules, and matrix assembly procedures; I/O is usually the major
difference among commercial FEM codes – some are easy, and some are not so
easy to learn and use. A source listing of the FORTRAN codes can be found in the
FORTRAN file folder; flow charts can be obtained from the authors. Likewise,
MATLAB and MathCad files are also available. One of the best commercial
packages now on the market is COMSOL, which also allows users to write their
own solver packages and PDEs.

10. Are There Any Recommended Commercial Fem Packages That Are Versatile In
Handling A Wide Range Of Problems?

Any of the well known and widely versatile FEM codes now on the market
are good – it just depends on how comfortable the user is with the I/O part
of the program. COMSOL,as mentioned before, is quite easy and very
versatile – handling a wide range of problem classes including fluid flow
(with turbulence), heat transfer, structural analysis,electrodynamics, and
general PDEs including species transport, chemical reactions, and
groundwater/porous media flows.

11. How Long Does It Take For Me To Be Able To Use A Fem Program?

Some programs allow you to solve problems fairly quickly. It is always highly
recommended that work out the example problems generally provided by
most commercial software. COMSOL, ANSYS, ALGOR, and NASTRAN all
run on PCs.

12. Why Would I Want To Use A Fem Program?

The versatility, ease of data input, and solution accuracy make the FEM one
of the best numerical methods for solving engineering problems. FEM
programs are the backbone of structural analyses, and are becoming more
widely accepted for problems in which geometries are complex.

13. Is This A Method That Will Soon Become Obsolete?

The recent introduction of BEM and meshless methods would appear to


indicate the eventual obsolescence of the FEM. However, these newer
methods are still years away from being developed to the point of
widespread applicability found in FEM. The FEM will be around for many
years to come. Recent advances with the inclusion of spectral schemes and
adaptivity make it especially attractive now.

14. How Expensive Is A Fem Code?

FEM codes range from those that can be found for free on the web to others
costing many thousands of dollars. Those that run on PCs are generally
inexpensive, yet provide powerful tools for solving a number of large scale
problems.

15. What Kind Of Hardware Do I Need To Run A Fem Code?

A PC with a sufficiently fast processor, at least 256MB RAM, and at least


20GB of hard disk will permit many problems to be solved that once could
only be run on mainframe computers. A suggested PC level for major FEM
calculations is one with 1 GB RAM, 60 GB hard disk, and running with
Pentium 4/3.2 GHz or better processors would provide more that adequate
capabilities. The state-of-the-art in PC hardware is improving constantly; in
a few years, even these suggested requirements will seem obsolete

16. What is meant by the Finite element method?

Finite element method (FEM)is a numerical technique for solving boundary


value problems in which a large domain is divided into smaller pieces or
elements. The solution is determined by assuming certain polynomials. The
small pieces are called finite elements and the polynomials are called shape
functions.

17. List out the advantages of FEM.

Since the properties of each element are evaluated separately different


material properties can be incorporated for each element.
There is no restriction in the shape of the medium.
Any type of boundary condition can be adopted.

18. List out the disadvantages of FEM.

The computational cost is high.


The solution is approximate and several checks are required.

19. Mention the various coordinates in FEM.

Local or element coordinates


Natural coordinates
Simple natural coordinates
Area coordinator Triangular coordinates
Generalised coordinates

20. What are the basic steps in FEM?

Selection of suitable displacement function


Finding the element properties
Assembling the element properties
Applying the boundary conditions
Solving the system of equations
Computing additional results
Discretization of the structure
21. What is meant by discretization?

Discretization is the process of subdividing the given body into a number of


elements which results in a system of equivalent finite elements.

22. What are the factors governing the selection of finite elements?

The geometry of the body


The number of independent space coordinates
The nature of stress variation expected

23. Define displacement function

Displacement function is defined as simple functions which are assumed


to approximate the displacements for each element. They may be assumed
in the form of polynomials, or trigonometric functions.

24. Briefly explain a few terminology used in FEM.

The various terms used in FEM are explained below.


Finite element-Small elements used for subdividing the given domain to be
analysed are called finite elements. The elements may be 1D, 2D or 3D
elements depending on the type of structure.

Nodes and nodal points- The intersection of the different sides of elements
are called nodes. Nodes are of two types - external nodes and internal
nodes.
O External nodes - The nodal point connecting adjacent elements.
O Internal nodes- The extra nodes used to increase the accuracy of the
solution.
Nodal lines - The interface between elements are called nodal
Continuum- The domain in which matter exists at every point is called a
continuum. It can be assumed as having an infinite number of connected
particles.
Primary unknowns- The main unknowns involved in the formulation of the
element properties are known as primary unknowns.
Secondary unknowns- These unknowns are derived from primary
unknowns are known as secondary unknowns. In displacement
formulations, displacements are treated as primary unknowns and stress,
strain, moments and shear force are treated as secondary unknowns.

25. What are different types of elements used in FEM?

The various elements used in FEM are classified as:


One dimensional elements(1D elements)
Two dimensional elements(2D elements)
Three dimensional elements(3D elements)

26. What are1-D elements? Give examples

Elements having a minimum of two nodes are called 1D elements. Beams


are usually approximated with 1D elements. These may be straight or
curved. There can be additional nodes within the element

27. Whatare2-D elements? Give examples.

A plane wall, plate, diaphragm, slab, shell etc. can be approximated as an


assemblage of 2-D elements. Most commonly used elements are triangular,
rectangular and quadrilateral elements.

28. What are 3-D elements? Give examples.

3-D elements are used for modeling solid bodies and the various 3-
Delements are tetrahedron, hexahedron, and curved rectangular solid.

29. What are axisymmetric elements?

Axisymmetric elements are obtained by rotatinga1-D line about an axis.

30. Define Shape function

Shape function is also called an approximate function or an interpolation


function whose value is equal to unity at the node considered and zeros at
all other nodes. Shape function is represented by Ni where i =nodeno
31. What are the properties of shape functions?

The properties of shape functions are:


Theno of shape functions will be equal to the no of nodes present in the
element.
Shape function will have a unit value at the node considered and zero value
at other nodes.
The sum of all the shape functions is equal to 1. i. e. SNi =1

32. Define aspect ratio.

Element aspect ratio is defined as the ratio of the largest dimension of the
element to its smallest dimension.

33. What are possible locations for nodes?

The possible locations for nodes are:


Point of application of concentrated load.
Location where there is a change in intensity of loads
Locations where there are discontinuities in the geometry of the structure
Interfaces between materials of different properties.

34. What are the characteristics of displacement functions?

Displacement functions should have the following characteristics:


The displacement field should be continuous.
The displacement function should be compatible between adjacent
elements
The displacement field must represent constant strain states of elements
The displacement function must represent rigid body displacements of an
element.

35. What is meant by plane strain condition?

Plane strain is a state of strain in which normal strain and shear strain
directed perpendicular to the plane of body is assumed to be zero.

36. What is meant by finite element analysis?


Finite element method is a numerical method for solving problems of
engineering mathematical physics.
In the finite element method, instead of solving the problem for
the entire body in one operation, we formulate the equations for each finite
element and combine them to obtain the solution of the whole body.

37. What is meant by finite element?

A small unit having definite shape of geometry and nodes is called finite
element.

38. State the methods of engineering analysis.

There are three methods of engineering analysis. They are:


Experimental methods.
Analytical methods.
Numerical methods or approximate methods.

39. Give examples for the finite element.

One dimensional elements: (a) Truss element


Bar, Beam element
Two dimensional elements (a) Triangular element
Rectangular elements
Three dimensional elements (a) Tetrahedral elements.
Hexahedral elements.

40. What is meant by node or Joint?

Each kind of finite element has a specific structural shape and is


interconnected with the adjacent elements by nodal points or nodes. At the
nodes, degrees of freedom are located. The forces will act only at the nodes
and not at any other place in the element.

41. What do you mean by discretization?

Discretization is the basis of finite element method. The art of subdividing a


structure into a convenient number of smaller components is known as
discretization.
42. What are the types of boundary conditions?

There are two types of boundary conditions, they are


Primary boundary condition. Secondary boundary condition.

43. What are the three phases of the finite element method?

The three phases are


Preprocessing
Analysis
Post Processing

44. What is structural and non-structural problem?

Structural problem: In structural problems, displacement at each nodal point


is obtained. By using these displacement solutions, stress and strain in each
element can be calculated.
Non Structural problem: In non structural problem,temperatures or fluid
pressure at each nodal point is obtained. By using these values, Properties
such as heat flow, fluid flow, etc for each element can be calculated.

45. What are the methods generally associated with the finite element analysis?

The following two methods are generally associated with the finite element
analysis. They are
Force method.
Displacement or stiffness method

46. Explain force method and stiffness method?

In force method, internal forces are considered as the unknowns of the


problem. In displacement or stiffness method, displacement of the node is
considered as the problem. Among them two approaches,the displacement
method is desirable.

47. What is the polynomial type of interpolation functions that are mostly used in FEM?

The polynomial type of interpolation functions are mostly used due to the
following reasons:
It is easy to formulate and computerize the finite element equations.
It is easy to perform differentiation or integration.
The accuracy of the results can be improved by increasing the order of the
polynomial .

48. Name the variational methods.

Ritz method.
Rayleigh – Ritz method
Name the weighted residual methods.
Point collocation method.
subdomain collocation method.
Least square method
galerkin’s method

49. What is meant by post processing?

Analysis and evaluation of the solution results is referred to as post


processing. Post processor computer programs help the user to interpret
the results by displaying them in graphical form.

50. What is the Rayleigh ritz method?

Rayleigh ritz method is an integral approach method which is useful for


solving complex structural problems, encountered in finite element analysis.
This method is possible only if a suitable functional is available.

51. What does assemblage mean?

The art of subdividing a structure into a convenient number of smaller


components is known as discretization. These smaller components are then
put together. The process of uniting the various elements together is called
assemblage.

52. What is meant by DOF?


When the force or reaction acts at nodal point, node is subjected to
deformation. The deformation includes displacement, rotations, and/or
strains. These are collectively known as degrees of freedom (DOF).

53. What is aspect ratio?

Aspect ratio is defined as the ratio of the largest dimension of the element
to the smallest dimension. In many cases, as the aspect ratio increases, the
inaccuracy of the solution increases. The conclusion of many researches is
that the aspect ratio should be close to unity as possible.

54. What is the truss element?

The truss elements are part of a truss structure linked together by point
joints, which transmit only axial force to the element.

55. List two advantages of post processing?

Required results can be obtained in graphical form.


Contour diagrams can be used to understand the solution easily and
quickly.

56. If a displacement field in x direction is given by u=2x2+4y2+6xy.Determine the


strain in x direction.

U=2x2+4y2+6xy
Strain,e= δu/δx= 4x +6y

57. What are h and p versions of finite element method?

H version and p versions are used to improve the accuracy of the finite
element method.
In h version, the order of polynomial approximation for all elements is kept
constant and the number of elements is increased.
In p version, the number of elements is maintained constant and the order
of polynomial approximation of element is increased.

58. During discretization, mention the places where it is necessary to place a node
The following places are necessary to place a node during the discretization
process.
Concentrated load-acting point.
Cross section changing point
Different material interjection point
Sudden change in load point.

59. What is the difference between static and dynamic analysis?

Static analysis: The solution of the problem does not vary with time is known
as static analysis.
Example: Stress analysis on a beam.
Dynamic analysis: The solution of the problem varies with time is known as
dynamic analysis.
Example: vibration analysis problems.

60. Name the four FEA softwares?

ANSYS
NASTRAN
COSMOS
NISA

61. Differentiate between global and local axes.

Local axes are established in an element. Since it is in the element level,


they change with the change in orientation of the element. The direction
differs from element to element.
Global axes are defined for the entire system. They are the same in
direction for all the elements even though the elements are differently
oriented.

62. Distinguish between potential energy function and potential energy functional.

If a system has a finite number of degrees of freedom (q1 q2 and q3)


then the potential energy is expressed as, π = f (q1 q2 and q3)
It is known as a function.
If a system has infinite degrees of freedom, then the potential energy is
expressed as,
π = ∫ f( x, y, dy/dx, d2y/dx2,….)dx
It is known as functional.

63. What are the types of loading acting on the structure?

There are three types of loading acting on the body. They are:
Body force (f)
Traction force (T)
Point load (P)

64. Define body force (f).

A body force is a distributed force acting on every elemental volume of the


body.
Unit: Force per unit volume. Example: Self-weight due to gravity

65. Define traction force (T)

Traction force is defined as a distributed force acting on the surface of the


body
Unit: force per unit area.
Examples: Frictional resistance, viscous drag, surface shear etc.

66. What is point load (P)

Point load is force acting at a particular point, which causes displacement.

67. What are the basic steps involved in the finite element modeling.

Finite element modeling consists of the following:


Discretization of structure
Numbering of nodes.

68. What is discretization?

The art of subdividing a structure into a convenient number of smaller components


is known as discretization
69. What is the classification of co-ordinates?

The coordinates are generally classified as follows:


Global co-ordinates
Local co-ordinates
Natural co-ordinates

70. What are Global co-ordinates?

a. The points in the entire structure are defined using co-ordinate system is
known as global co-ordinate system.

71. What are natural co-ordinates?

A natural co-ordinate system is used to define any point inside the element
by a set of dimensionless numbers, whose magnitude never exceeds
unity.This system is very useful in assembling of stiffness matrices.

72. shape function.

In finite element method,field variables within an element are generally


expressed by the following approximate relation
N3 are the
Φ(x,y) = N1(x,y) φ1 + N2(x,y) φ2 +N3(x,y) φ3
Where φ1, φ2 and φ3 are the values of the field variables at the nodes and
N1 ,N2 and
interpolation functions.N1 ,N2 and N3 also called shape function because
they are used to express the
geometry or shape of the element.

73. What are the characteristics of shape function?

The characteristics of shape function are as follows:


The shape function has unit value at one nodal point and zero value at other
nodal points.
The sum of shape function is equal to one.
74. Why are they generally used as shape function?

Polynomials are generally used as shape function due to the following


reasons.
Differentiation and integration of polynomial are quite easy.
The accuracy of the results can be improved by increasing the order of the
polynomial.
It is easy to formulate and computerize the finite element equations.

75. How do you calculate the size of the global stiffness matrix?

Global stiffness matrix size = Number of nodes X degree of freedom per


node
Give the general expression for element stiffness matrix.
Stiffness matrix [k] = ∫ [B] T [D] [B] dv
Strain displacement matrix [row matrix]
[D] – Stress, Strain relationship matrix [Row matrix]

76. State the properties of a stiffness matrix.

The properties of a stiffness matrix [k] are


It is a symmetric matrix.
The sum of elements in any column must be equal to zero.
It is an unstable element.
So, the determinant is equal to zero.

77. Write down the general finite element equation.

General finite element equation is,


{F} = [K] {u}
{F} - Force vector [column matrix] [k] - Stiffness matrix [ row matrix]
{u} - Degrees of freedom [column matrix]

78. What is truss?

A truss is defined as a structure, made up of several bars, riveted or welded


together.

79. State the assumptions are made while finding the forces in a truss
.
The following assumptions are made while finding the forces in a truss.
All the members are pin jointed.
The truss is loaded only at the joints.
The self-weight of the members is neglected unless stated.

80. Write down the expression of shape function N and displacement u for one-
dimensional bar element.

For one dimensional bar element


Displacement function, u= N1 u1 + N2 U2
Where, shape function N1 = l-x / l
shape function N2= x/l
81. Define total potential energy.

The total potential energy π of an elastic body, is defined as the sum of total
strain energy U and potential energy of the external forces,(W).
Total potential energy, π = Strain energy (U) + Potential energy of the
external forces (W).

82. State the principle of minimum potential energy.

The principle of minimum potential energy states: Among all the


displacement equations that satisfy internal compatibility and the boundary
conditions, those that also satisfy the equations of equilibrium make the
potential energy a minimum in a stable system.

83. What is the stationary property of total potential energy?

If a body is in equilibrium, its total potential energy π is stationary.


For stable equilibrium, δ2π >0 , otherwise π is minimum for stable
equilibrium. For neutral equilibrium, δ2π = 0. In this case π is unchanging.
For unstable equilibrium, δ2π < 0 , otherwise π is maximum.

84. State the principle of virtual work?

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

85. Distinguish between essential boundary conditions and natural boundary


conditions.
There are two types of boundary conditions. They are:
Primary boundary condition (or) Essential boundary condition
The boundary condition, which in terms of field variable, is known as primary
boundary condition.
Secondary boundary condition or natural boundary conditions:
The boundary conditions, which are in the differential form of field variables,
are known as secondary boundary conditions.
Example: A bar is subjected to axial load as shown in fig.
U= 0
EA du/dx = p
86. What are differences between boundary value problem and initial value problem?

The solution of differential equations is obtained for physical problems,


which satisfies some specified conditions known as boundary conditions.
The differential equation together with these boundary conditions, subjected
to a boundary value problem.
The differential equation together with initial conditions subjected to an initial
value problem.
Examples: Boundary value problem. d2y/dx2 - a(x) dy/dx – b(x)y –c(x) = 0
with boundary conditions, y(m) = α and y(n) = β
initial value problem, ax2 + bx + c =0
Boundary conditions: x(0) = 0
X(0) = 7

87. How do you define two-dimensional elements?

Two dimensional elements are defined by three or nodes in a two


dimensional plane(ie x,y plane). The basic element useful for two
dimensional analysis is the triangular element.

88. What is the LST element?

Six noded triangular elements are known as linear strain triangle (LST),
which is shown in fig. It has twelve unknown displacement degrees of
freedom. The displacement functions for the element are quadratic instead
of linear as in the CST.

89. What is the QST element?


Ten noded triangular elements is known as quadratic strain triangle (QST),
which is shown if, fig. it is also called cubic displacement triangle.

90. Write down the stiffness matrix equation for two-dimensional CST element.

Stiffness matrix, [k] = [B]T [D] [B] A t


[B] = Strain displacement matrix
[D] = Stress strain matrix
A = Area of the element
T = Thickness of the element

91. Write down the expression for the shape function for a constant strain triangular
element.

For CST element,


Shape function, N1 = P1 + q1x + r1y
2A
N2 = p2+q2x+r2y
2A
Where P1= x2y3 – x3 y2
P2= x3y1 – x1 y3
P3= x1y2 – x2 y1
q1= y2 – y3
q2= y3 – y1
q3= y1 – y2
N3 = p3+q3x+r3y
2A
r1= x3 – x2 r2= x1 – x3 r3= x2 – x1

92. What is axisymmetric element?

Many three dimensional problems in engineering exhibit symmetry about


an axis of rotation. Such types of problems are solved by a special two-
dimensional element called the axisymmetric element.

93. What are the conditions for a problem to axisymmetric?

The problem domain must be symmetric about the axis of revolution.


All boundary conditions must be symmetric about the axis of revolution.
All loading conditions must be symmetric about the axis of revolution.
94. Give the stiffness matrix equation for an axisymmetric triangular element.

Stiffness matrix, [k] = 2π r A [B] T [D] [B] Where, coordinate r = r1 + r2 + r3


/3
A – area of the triangular element.

95. What are the ways in which a three dimensional problem can be reduced to a two
dimensional approach.

Plane stress: One dimension is too small when compared to the other two
dimensions.
Example: gear – thickness is small
Plane strain: one dimension is too large when compared to the other two
dimensions example : Long pipe [length is long compared to diameter]
Axisymmetric : geometry is symmetric about the axis.
Example: cooling tower

96. Describe the four types of weighted residual method.

97. Derive the stiffness matrix [K] for the truss element

98. Derive the shape function for one-dimensional bar element.

99. Using finite elements, find the stress distribution in a uniformly tapering bar of
circular cross sectional area 3cm2 and 2 cm2 at their ends, length 100mm,
subjected to an axial tensile load of 50 N at smaller end and fixed at larger end.
Take the value of Young's modulus as 2 x
105N/mm2.

100. (i) Explain the Galerkin’s method.


(ii) Explain the Gaussian elimination.

101. Derive the constitutive matrix for 2D element.

102. Derive the expression for the stiffness matrix for an axisymmetric shell
element.
103. Explain the terms plane stress and plane strain conditions. Give the
constitutive laws for these cases.

104. Derive the element stiffness matrix for a linear isoparametric quadrilateral
element.

105. Evaluate the integral by using Gaussian quadrature ∫ x2dx.

106. What is meant by sub parametric element?

If the number of nodes used for defining the geometry is less than the
number of nodes used for defining the displacements known as
isoparametric elements.

107. What is meant by iso parametric element?

If the number of nodes used for defining the geometry is the same as the
number of nodes used for defining the displacements is known as
isoparametric element.

108. Is beam element an isoparametric element?

Beam element is not an isoparametric element since the geometry and


displacements are defined by different order interpolation functions.

Vous aimerez peut-être aussi