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

Djs Fea Lab Manual

Uploaded by

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

Djs Fea Lab Manual

Uploaded by

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

Finite Element Analysis Lab

FEA
LAB
MANUAL

. Page 1
Finite Element Analysis Lab

Course Education Objectives:


1. To familiarize FEA concept for practical implementation
2. To Acquaints with FEA application Software.

List of Experiments:
Students should use the commercial software or programmes form the text-books or self-developed programs, to
verify the results obtained by manual calculations. The input data and output results of the problem solved using
the computer programs should be included in the Journal. The proposed list is given below:
1. Any two problems using 1D element: Analysis of axially loaded stepped/Tapered bar and beam.
2. Any two problems using truss element: Analysis of plane trusses.
3. Any two problems using 2D element: Analysis of plate with hole/notch.
4. Any one problem on steady state heat conduction.
5. Any one problem using axisymmetric element: Analysis of pressure vessel.
6. Any one problem of free vibration analysis for dynamic system.
While performing the analysis the students should understand the concepts of selection of element type, meshing and
convergence of solution.

Course Outcomes:
1. Apply basic aspects of FEA to solve engineering problems.
2. Select appropriate element, suitable meshing, appropriate solver and perform Convergence test for given
problem.
3. Interpret and validate FEA result.

. Page 2
1.1 Introduction

The finite element method has been a powerful tool for the numerical solution of a wide
range of engineering problems. Application range from deformation and stress analysis of
automotive, aircraft, building, defense, missile, and bridge structures to the field analysis of
dynamics, stability, fracture mechanics, heat flux, fluid flow, magnetic flux, seepage and other
flow problems.
With the advances in computer technology and CAD systems Complex problems can be
modeled with relative ease. Several alternate configurations can be tried out on a computer before
the first prototype is built.
The basics in engineering field is must to idealize the given structure for the required
behavior. The proven knowledge in the typical problem area, modeling techniques, data transfer
and integration, computational aspects of the finite element method is essential.
Most often it is not possible to ascertain the behavior of complex continuous system
without some sort of approximation. For simple members like uniform beams, plates etc. Classical
solutions can be sought by forming differential and/or integral equations through structures like
machine tool frames, Pressure vessels, automobile bodies, ships, aircraft structures, domes etc,
need some approximate treatment to arrive at their behavior, in static deformation, dynamic
properties or heat conducting property.
Indeed these are continuous systems with their mass and elasticity being continuously
distributed.
The classical differential equation solution approach leads to intractability. To overcome
this engineers and mathematicians have form time to time proposed complex structure is defined
using a finite number of well-defined components. Such systems are then regarded as discrete
systems. The discretization method could be finite difference approximation, various residual
procedures etc.
Finite element method comes under this category of discretization methods. R.W. Clough
appears to be the first to use this term of finite element since 1960s there has been much progress
in the method. The method requires a large number of computations requiring a fast computer. In
fact digital computer advances have been responsible for the expanding usage of the finite element
method.
The finite element method was initially developed to solve structural problems. Its use of
late, has been rapidly extended to various fields. which still by no means can be claimed as
complete since fields of usage are being continuously diversified.

Page 3
1.2 Methods of Engineering Analysis
The general methods for solving the practical problems can be classified as shown in
figure:
Methods of analysis

Analytical Methods Numerical Methods

Exact Methods (E.g. Approximate Methods (E.g.


separation of variables and Rayleigh Ritz methods and
Laplace transformation Galerkin’s methods)
methods, Integration of
differential equations)

Numerical solution of Finite Element Method Boundary Element


governing differential Method
equation

Numerical Finite Differences


Integration

Fig.1.1. Block diagram of engineering analysis

 Exact method Provides exact solution to the problems, but the limitation of this method is
that all practical problems cannot be solved and even if they can be solved, they may have
very complex solution.

 Approximate analytical methods are alternative to the exact methods, in which certain
functions are assumed to satisfy the geometric boundary conditions, but not necessary the
governing equilibrium equations. These assumed functions, which are simpler, are then
solved by any conventional method available. The solutions obtained from these methods

Page 6
have limited range of values of variables for which the approximate solution is nearer
to the exact solution.
 Numerical method has been developed to solve almost all types of practical problems.
The two common numerical methods used to solve the governing equations of practical
problems are numerical integration and finite element technique.
 Numerical integration methods such as Runge-Kutta, Miline’s method etc. adopt
averaging of slopes of given function at the given initial values. These methods yield
better solutions over the entire field width but sometimes laborious.
 Finite difference method the differential equations are approximated by finite
difference equation. Thus the given governing equation is converted to a set of
algebraic equations. These simultaneous equations can be solved by any simple
method such as Gauss Elimination, gauss-Seidal iteration method, Crout’s method
etc. the method of finite difference yield fairly good results and are relatively easy
to program. Hence, they are popular in solving heat transfer and fluid flow
problems. However, it is not suitable for problems with irregular geometry and not
suitable for problems of rapidly changing variables such as stress concentration
problems.

 Finite Element Method (F.E.M) has emerged out to be powerful method for all kinds
of practical problems. In this method the solution region is considered to be built up of many
small-interconnected sub regions, called finite elements. These elements are applied with
an interpolation model, which is simplified version of substitute to the governing equation
of the material continuum property. The stiffness matrices obtained for these elements are
assembled together and the boundary conditions of the actual problems are satisfied to
obtain the solution all over the body or region FEM is well suited for computer
programming.

 Boundary element method (B.E.M) like finite method is being used in all engineering
fields. In this approach, the governing differential equations are transformed into integral
identities applicable over the surface or boundary. These integral identities are integrated
over the boundary, which is divided into small boundary segments. As in finite element
method provided that the boundary conditions are satisfied, set of linear algebraic equations
emerges, for which a unique solution is obtained.

1.3 Introduction to FEM


In the field of engineering, it is necessary to obtain the unknown field parameters like
displacement or forces, which can describe the behavior of structures. These unknowns can
be obtained by using exact analytical solutions or energy methods, which are formulated
with governing equilibrium equations of analytical solutions on the basis
of solid mechanics. However in practice the real structure viz., aircraft/automobiles, civil,
naval architecture, offshore and nuclear engineering are large in size with irregular shapes,
Page 7
intermediate in nature, possessing geometrical material non-linearity and having
complicated loading or boundary conditions. In these cases, to reduce the continuous
system to a discrete one by conventional method, a lot of effort and assumption must be
made, which are cumbersome and error prone. The advent of high-speed electronic
computer has given tremendous opportunity to the numerical method approach. The most
commonly used numerical technique in solving engineering problems is FEM, because

Algebraic work corresponding to the solid mechanics is programmed in systematic matrix


calculations and formulated into mathematical model. User need not work with
1. Complicated algebra but only to deal with the discredited geometry of the physical
structural.
2. Ability to consider alternate loading and bending condition for the same geometry.
3. Accuracy of data mainly depends on the number of approximations. Since in FEM we can
make lesser number of assumptions, degree of accuracy will be high with a minimum
percentage or error from the exact value.
4. Faster and automatic calculations, which are repetitive in nature, simultaneous display of
modification and part processing results.
5. Accurate prediction with adequate details for identifying critical areas of interest like
highly stressed regions.

1.4 Finite Element Method


The given system or structure is divided into small elements of units interconnected at
grid points. Each element is solved variable, inherently making use of classical procedures and
analytical. This process of breaking down of continuum of finite discrete elements and solving for
the variable (velocity, displacement, stress and loads etc) is called finite element analysis.
The two methods used for the analysis of a problem in FEM are:
(a) Force method: Here the forces are unknown (minimum complimentary energy method)
(b) Displacement Method: Here the displacements are unknown (minimum potential energy
method)
The analysis by FEM involves the following steps.
1. Pre-processing: It is the act of preparation of data such as nodal locations, element
connectivity co-ordinates imposing boundary conditions applications of load and providing
material information to element etc. one can decide in this stage regarding the number of nodes,
elements, types with their order and the pattern of FE mesh.
2. Processing: This stage involves stiffness generation, stain energy calculation and
solutions of equations resulting in the evolution of nodal variables, induced elemental forces,
strains and stresses.
3. Post-Processing: The geometric deformation and distribution of forces, stresses and
strains in the structure, here the aspect of plotting a displaced plotting nodal date in the form of
contour plots, such as isotherms and isobars, and conversion of element oriented data into best
fitting nodal values is discussed. Preprocessing and post processing are integral parts of finite

Page 8
element analysis. The general purpose mesh generation scheme can model a variety of complex
regions. The node numbering gives spars matrices and in many cases should given minimum
bandwidth proper block representation. Mesh plotting shows the element layout.

1.5 What is FEA?

Finite Element Analysis is a way to simulate loading conditions on a design and determine
the design’s response to those conditions.
 The design is modeled using discrete building blocks called elements
 Each element has exact equations that describe how it responds to a
certain load.
 The “sum” of the response of all elements in the model gives the total
response of the design.
 The elements have a finite number of unknowns, hence the name finite
elements.
 The finite element model, which has a finite number of unknowns, can only approximate
the response of the physical system, which has infinite unknowns so the question arises:
How good is the approximation?
Unfortunately, there is no easy answer to this question. It depends entirely on what you are
simulating and the tools you use for the simulation. We will, however, attempt to give you
guidelines throughout this training course.

Physical System F.E. Model

Page 9
1.6 Degrees of Freedom

Degrees of freedom (DOFs) characterize the response of a field.

1.7 BASIC CONCEPTS OF FINITE ELEMENT METHOD


 Full field is divided into finite number of elements.
 Knowing the behavior of one/many elements one can predict the assemblage.
 It is to predict the behavior of individual elements under load.
 Minimum potential energy principle is used to evaluate element stiffness.
 Independent of the problem to be solved, stiffness of the element can be obtained.

1.8 TERMINOLOGY IN THE FINITE ELEMENT METHOD


The commonly used terminologies in FE analysis are as follows.
1. Discritization
The physical structure has to be represented by a mathematical model in such way that it
simplify the construction and easy to analyze. In modeling the given global domain is divided into
sub-domains called elements.
This process of modeling is termed as discrimination, which includes proper selection of
type and density of the elements, the location of the nodal points for applying loads/boundary
conditions, to extract the results from the areas of interest.
2. Grids

The point in space used for defining the geometry and connecting the elements. These points

Page
10
are useful to specify the displacement, force and boundary conditions of the structure

3. Displacement
Displacement defines the deformation or the movement caused by an external force. There
are six displacements for an element in space. These are three translations vectors u; v and w and
are three rotational vectors with respect to x, y and z. co-ordinate system. These nodal variables
are referred to as degrees of freedom.

4. Co-ordinate System
A co-ordinate system is the reference, which can specify the position of a point or an
element in a space. The co-ordinate systems used are.
 Global co-ordinate system (Cartesian i.e. x. y. z.)
 Local co-ordinate system.
 Polar co-ordinate system(r. 0)
 Cylindrical co-ordinate system(r. 0. z)
 Spherical co-ordinate system(r. 0)
 Can be Cartesian also (x. y. z)
5. Boundary Conditions/Constraints
 Resistance (reaction) offered at grid points due to the motion of the structure being
constrained by the applied forces.
These reactions can be obtained with respect to the specified co-ordinate
System.
 To prevent the rigid body motion there by reducing the continuous structure to discrete
system(avoiding the phenomena of mechanism)
 These constraints can be zero (u. v. w. x. y. z = 0) or non-Zero and specified enforced
displacement at grid points.

1.9 STEPS INVOLVED IN FEM

The basic steps involved in finite element method are as follows.


1. Modeling
The basic idea of finite element modeling is to discretize the region and expresses the
Displacement in terms of values at discrete points.
2. Discritization
Discritization means division of a given structure into finite number elements of better
approximations. This forms the first step in the analysis of complicated structural system.
3. Formulation of elemental equation and convergence test
The properties of the elements are formulated and combined to obtain the solution for the
entire body or structure. For e.g. in the displacement formulation widely adopted in
FE analysis, simple functions known as shape functions are chosen to approximate the
variation of the displacement at the nodes of the element.
Page
11
Convergence test is done to know that how much the approximate solution converges to
the exact value and the errors are calculated.
4. Determination of
a. Elemental stiffness matrix [Ke]
b. Elemental nodal displacement vector [Qe]
c. Elemental load vector [Fe]
5. Equilibrium equations are imposed so that each of the elements is in a state of
Equilibrium
[Ke] [Qe] = [Fe]
6. Assembly of
a. Stiffness matrix of all the elements [K]
b. Nodal displacements of all the elements [Q]
c. Nodal forces of all elements [f]
d. Overall stiffness matrix is formed by global addition of element stiffness matrices.

7. Assembled Equilibrium Equation


The equation of equilibrium for the entire structure of body is then obtained by combining
the equilibrium equation of each element such that the continuity of displacement is ensured
at each node where the elements are connected.
[K] [Q] = [F]
8. Application of boundary conditions to the overall equilibrium equation.

The necessary conditions are imposed and the equations of equilibrium are solved for the
nodal displacements. There are two approaches of applying the boundary conditions.
a. Elimination technique
In this technique after imposing the boundary conditions, whichever displacement
is Zero, the corresponding row and column of the overall equilibrium is eliminated.
b. Penalty approach
A second approach for handling boundary condition is the penalty approach. This
approach easily implemented in a computer program and retains its simplicity even when
considering general boundary conditions where a large value of C is added to the highest
diagonal elements. On applying the boundary conditions, the overall equilibrium equation
gets modified.
c. Solution of the modified overall equilibrium equation by gauss elimination method
The value of nodal displacements will be obtained in this step. Thus knowing of all
the nodal displacements, stain of each element will be computed. From these values
elemental stresses are obtained.
Computation of Stains:

For each element stain calculated is given by the overall equation


[] = {b} {q}

Page
12
Where [] = Strain Matrix
{b} = Strain Displacement Matrix where b is unique for
each element
{q} = Elemental Nodal Displacement Vector.
Computation of Stress:
Knowing the strain, the stress is calculated as follows
i.e., [] = {D} {}
Where [] = Stress Matrix
{D} = Constitutive Matrix for plane stress
{} = Strain Matrix
These are the main steps carried out in structural problems where the analysis is simple. It
becomes complicated thereafter for each and every problem, which includes dynamic analysis
where the forces and all the conditions vary with time. In thermal, it is transient analysis and in
fluid flow situations, it is turbulent flow analysis.
The finite element method was initially developed on a physical basis for the analysis of problems
in structural mechanics; however, it was soon recognized that the method can be applied equally
well to the solution of many other classes or problems

1.10 Merits of FEM

The merits of finite element method are:


 The systematic generality of finite procedure makes it a powerful and versatile tool for a
wide range of problems. Thus flexible, general-purpose computer programs can be
developed and can be applied to various problems with little or no modification.

 FEM can be easily interpreted in physical terms and it has a strong mathematical base.
Hence, finite element method can be easily applied to any problem with a proper
knowledge of the physical system under consideration and can be solved to a greater
accuracy by the application of proper mathematical tool.
 Non-homogeneous continuum can also be dealt with by merely assigning different
properties to different elements. It is even possible to vary the properties within an element
according to the polynomial applied.
 Finite element method accommodates complex geometry with ease and is capable of
handling non-linear and time dependent system also.
 In finite element method, since boundary conditions are introduced in the assembled
equations, it requires only to specify the geometric boundary conditions without regarding
its effects on interior elements. Since the boundary conditions do not enter into the
individual finite element equations, the field variable models need not be changed, when
the boundary conditions change.

Finite element method considers the multidimensional continuity of the body. Hence it does not
Page
13
require separate interpolation process to extend the approximate solution to every point within the
continuum. Also it does not require the trial solutions that must all apply to the entire
multidimensional continuum.

1.11 Limitations of FEM

 FEM has been developed as a very high solution technique. However, the solution obtained
from FEM can be realistic if and only if the material properties are known precisely.
 The major drawback of FEM is sensitivity of the solution on the geometry of the element
such as type, shape and orientation of elements used.
 The compute programs yield a large amount of data as results it is very difficult to separate
out the required results from the pile of numbers.

1.12 Errors Inherent in FEM Formulation

1. Geometry is simplified.

2. Field quantity is assumed to be a polynomial over an element. (Which is not true)

3. The computer carries only a finite number of digits.

4. The computer carries only a finite number of digits.


e.g :  1.41421356   3.14159265

Mistakes by Users

1. Elements are of the wrong type: e.g.) Shell elements are used where solid elements are
needed

Page
14
2. Distorted elements

3. Supports are insufficient to prevent all rigid-body motions

4. Inconsistant units (e.g. E=200 GPa, Force = 100 lbs)

Element Properties: The discretization of the structure or body into Finite Elements
Forms the basic first step in the analysis of a complicated structural system.

Rules for Discretization Of The Structure Into Elements: Sub-division of a body or


Structure into Finite Elements should satisfy the following requirements.
1. Two distinct elements can have common points only on their common boundaries if such
boundaries exist. No overlapping is allowed. Common boundaries can be points, lines or
surfaces.
2. The assembled element should leave no holes within the two elements and approximate the
geometry of the real body or structure as closely as possible to do. When the boundary of a
structure or body cannot be exactly represented by the elements selected, an error cannot be
avoided. Such error is called Geometric Discretization Error and it can be decreased by
reducing the size of the elements or by using elements allowing boundaries to become curved.

Mesh Generators:
The finite element models for practical analysis can contain tens of thousands or even
hundreds of thousands degrees of freedom. It is not possible to create such meshes manually. Mesh
generator is a software tool, which divides the solution domain into many Sub domains – finite
elements. Mesh generators can be of different types.
For two-dimensional problems, we want to mention two types: block mesh generators and
triangulates.
Block Mesh Generators:
Require some initial form of gross partitioning. The solution domain is partitioned in some
relatively small number of blocks. Each block should have some standard form The mesh inside
block is usually generated by mapping technique.
Triangulators:
Typically generate irregular mesh inside arbitrary domains. Voronoi polygons and
Delaunay triangulation are widely used to generate mesh. Later triangular mesh can be transformed
to the mesh consisting of quadrilateral elements. Delaney triangulation can be generalized for three
dimensional domains.

Page
15
Finite Element Model of Gear tooth

Page
16
Three-dimensional stress on an element

Page
17
2.1 Introduction to ANSYS

 ANSYS is a complete FEA software package used by engineers worldwide in virtually


all fields of engineering:
o Structural
o Thermal
o Fluid, including CFD (Computational Fluid Dynamics)
o Electrical / Electrostatics
o Electromagnetics
 A partial list of industries in which ANSYS is used:
o Aerospace
o Automotive
o Biomedical
o Bridges & Buildings
 ANSYS/Multiphysics is the flagship ANSYS product which includes all capabilities in
all engineering disciplines.

ANSYS/ ANSYS/ ANSYS/


Professional Mechanical ANSYS/ Emag
Multiphysics

ANSYS/ ANSYS/
Structural ProFEA
ANSYS/
ED
ANSYS/
FLOTRAN

DesignSpace
ANSYS/
ANSYS/ ANSYS/
LS-DYNA University
PrepPost

 There are three main component products derived from ANSYS/Multiphysics:


o ANSYS/Mechanical - structural & thermal capabilities
o ANSYS/Emag - electromagnetics
o ANSYS/FLOTRAN - CFD capabilities

Page 18
 Other product lines:
o ANSYS/LS-DYNA - for highly nonlinear structural problems
o DesignSpace - an easy-to-use design and analysis tool meant for quick
analysis within the CAD environment
o ANSYS/ProFEA - for ANSYS analysis & design optimization within
Pro/ENGINEER

 Structural analysis: is used to determine deformations, strains, stresses, and reaction


forces.
o Static analysis
 Used for static loading conditions.
 Nonlinear behavior such as large deflections, large strain, contact, plasticity,
hyper elasticity, and creep can be simulated
o Dynamic analysis
 Includes mass and damping effects.
 Modal analysis calculates natural frequencies and mode shapes.

 Harmonic analysis determines a structure’s response to sinusoidal loads of known


amplitude and frequency.
 Transient Dynamic analysis determines a structure’s response to time-varying
loads and can include nonlinear behavior.
o Other structural capabilities
 Spectrum analysis
 Random vibrations
 Eigen value buckling
 Substructuring, submodeling
o Explicit Dynamics with ANSYS/LS-DYNA
 Intended for very large deformation simulations where inertia forces are
dominant.
 Used to simulate impact, crushing, rapid forming, etc.

 Thermal analysis: is used to determine the temperature distribution in an object. Other


quantities of interest include amount of heat lost or gained, thermal gradients, and thermal
flux. All three primary heat transfer modes can be simulated: conduction, convection,
radiation.
o Steady-State
 Time-dependent effects are ignored.
o Transient
 To determine temperatures, etc. as a function of time.
 Allows phase change (melting or freezing) to be simulated.
o Electromagnetic analysis is used to calculate magnetic fields in electromagnetic devices.
o Static and low-frequency electromagnetics
Page 19
 To simulate devices operating with DC power sources, low-frequency AC, or low-
frequency transient signals.
 Computational Fluid Dynamics (CFD)
o To determine the flow distributions and temperatures in a fluid.
o ANSYS/FLOTRAN can simulate laminar and turbulent flow, compressible
and incompressible flow, and multiple species.
o Applications: aerospace, electronic packaging, automotive design
o Typical quantities of interest are velocities, pressures, temperatures, and film
coefficients.
 Magnetic:
Magnetic analysis is done using Ansys / Electromagnetic program. It can calculate
the magnetic field in device such as power generators, electric motor etc. Interest in
magnetic analysis is finding magnetic flux, magnetic density, power loss and magnetic
forces.
 Acoustic / Vibrations:
Ansys is the capable of modeling and analyzing vibration system. Acoustic is the
study of the generation, absorption and reflection of pressure waves in a fluid application.
o Few examples of acoustic applications are
o Design of concert house, where an even distribution of sound pressure is
possible.
o Noise cancellation in automobile.
o Underground water acoustics.
 Coupled Fields:
A coupled field analysis is an analysis that takes into account the interation between
two (or) more fields of engineering analysis. Pressure vessels, Induction heating and Micro
electro mechanical systems are few examples.

2.2 The GUI Layout

Page 20
Icon Toolbar Menu Utility Menu
Input Line Raise/Hidden Icon

Abbreviation Toolbar Menu

Graphics Area
Main Menu

Output
Window

User Prompt Info


Current Settings

Utility Menu:-Contains functions which are available throughout the ANSYS session, such as
file controls, selecting, graphics controls, parameters, and exiting.
Toolbar Menu
Contains push buttons for executing commonly used ANSYS commands and
functions. Customized buttons can be created.
Graphics Area
Displays graphics created in ANSYS or imported into ANSYS.

Input Line
Displays program prompt messages and a text field for typing commands. All
previously typed commands appear for easy reference and access.
Main Menu
Contains the primary ANSYS functions, organized by processors (preprocessor,
solution, general postprocessor, etc.)
Output
Displays text output from the program. It is usually positioned behind the other
windows and can be raised to the front when necessary.
Resume:
This is opening a previously saved database. It is important to know that if you
Simply resume a database; it doesn’t change the job name. For example: You start ANSYS

Page 21
with a job name of “file”. Then you resume my model.db, do some work, and then save.
That save is done to file.db! Avoid this issue by always resuming using the icon on the
toolbar. If you open mymodel.db using this method, it resumes the model and automatically
changes the job name to my model.
Plotting:
Contrary to the name, this has nothing to do with sending an image to a plotter or
printer. Plotting in ANSYS refers to drawing something in the graphics window. Generally
you plot one type of entity (lines, elements, etc.) to the screen at a time. If you want to plot
more than one kind of entity use, “Plot → Multiplot”, which by default will plot everything
in your model at once.
Plot Controls:
This refers to how you want your “plot” to look on the screen (shaded, wire frame,
entity numbers on or off, etc). Other plot control functions include sending an image to a
graphics file or printer.
Creating Geometry:
Geometry in ANSYS is created from
“Main Menu → Preprocessor → Modeling → Create” and has the following
terminology,
KEYPOINTS: These are points, locations in 3D space.
LINES: This includes straight lines, curves, circles, spline curves, etc. Lines are typically
defined using existing keypoints.
AREAS: This is a surface. When you create an area, its associated lines and keypoints
are automatically created to border it.
VOLUMES: This is a solid. When you create a volume, its associated areas, lines and
keypoints are automatically created.
SOLID MODEL: In most packages this would refer to the volumes only, but in ANSYS
this refers to your geometry. Any geometry. A line is considered a “solid model”.
You can’t delete a child entity without deleting its parent, in other words you can’t delete
a line if it’s part of an area, can’t delete a key point if it’s the end point of a line, etc.

 Boolean Operations:
Top Down style modeling can be a very convenient way to work. Instead of first
creating keypoints, then lines from those keypoints, then areas from the lines and so on
(bottom up modeling), start with volumes of basic shapes and use Boolean operations to
add them, subtract them, divide them etc. Even if you are creating a shell model, for
example a box, you could create the box as a volume (a single command) and then delete
the volume keeping the existing areas, lines and keypoints.
These kinds of operations are found under
“Main Menu → Preprocessor → Modeling → Operate →Booleans” with some common
ones being:
Add: Take two entities that overlap (or are at least touching) and make them one.

Page 22
Subtract: Subtract one entity from another. To make a hole in a plate, create the plate
(area of volume) then create a circular area or cylinder and subtract it from the plate.
Glue: Take two entities that are touching and make them contiguous or congruent so that
when meshed they will share common nodes. For example, using default mesh parameters,

Meshing without gluing areas. Meshing after gluing areas


Note: In case of Meshing after gluing areas. The coincident nodes on the common line
between the two areas will be automatically merged. You don’t have to manually
equivalence them like in some other codes.

Page 23
 The Working Plane:

All geometry is created with respect to the working plane,


which by default is aligned with the global Cartesian coordinate
system. The “Working Plane” is actually the XY plane of the working
coordinate system. The working coordinate system ID is coordinate
system 4 in ANSYS. Global Cartesian is ID 0, Global Cylindrical is
ID 1, and Global Spherical is ID 2.

 Working Plane Hints:

Turn on the working plane so you can see it with, “Utility


Menu → Work Plane → Display Working Plane”.
Change the way the working plane looks or adjust the snap
settings under “Utility Menu → Work Plane → WP Settings…”
Move the working plane around using
“Utility Menu → Work Plane → Offset WP to…”
Align the working plane with various parts of the model using
“Utility Menu → Work Plane → Align WP with…”
If you select more than one node or key point to offset the working
plane to, it will go to the average location of the selecte entities. VERY
handy! Use the working plane to slice and dice your model. For
example to cut an area in pieces use “Main Menu → Modeling
→ Operate → Booleans → Divide → Area by WrkPlane”. Do this for
lines and volumes as well.
 Select Logic:
Selecting is an important and fundamental concept in ANSYS.
Selected entities are your active entities. All operations (including
Solving) are performed on the selected set. In many operations you
select items “on the fly”; ANSYS prompts for what volumes to mesh
for example, you pick them with the mouse, and ANSYS does the
meshing.
However there are many times when you need to select things in more
sophisticated ways. Also, in an ANSYS input file or batch file you can’t
select things with the mouse!
Examples where this would be useful:

. Page 23
• You have many different areas at Z = 0 you want to constrain. You could select them all
one by one when applying the constraint, or select “By Location” beforehand, then say
“Pick All” in the picking dialog.
• You have a structure with many fastener holes that you want to constrain. Again, you could
select them all one by one when applying the constraint, or select lines “By
Length/Radius”, type in the radius of the holes to select all of them in one shot, then “Pick
All” in the picking dialog when applying the constraint.
After working with the selected set,
“Utility Menu → Select → Everything” to make the whole model active again.
 Select Entities Dialog Box Terminology:
From Full: Select from the entire set of entities in the model.
Reselect: Select a subset from the currently selected entities.
Also Select: Select in addition to (from the whole model) the set you have currently
selected.
Unselect: Remove items from the selection set.
Select All: This is not the same as “Utility Menu → Select → Everything”. This selects
all of whatever entity you have specified at the top of the dialog.
Invert: Reverses the selected and unselected entities (just the entities specified at the top
of the dialog).
OK: This does the select operation (or brings up a picker dialog so that you can pick with
the mouse) and then dismisses the dialog.
Apply: This does the operation but keeps the dialog box. Typically use this so the dialog
stays active.
Replot: Replots whatever is active in the graphics window.
Plot: Plots only the entity specified at the top of the dialog.

 Organizing Your Model Using Components:


If you select a group of entities and think that you might want to use that selection
set again, create a component out of it. Components are groups of entities but hold only
one kind of entity at a time. Components can themselves be grouped into Assemblies, so
this is how you group different types of entities together. Use “Utility Menu → Select →
Comp/Assembly → Create Component…” to create a component. The new Component
Manager in Release 8.0 makes it very easy to manage and manipulate groups and
select/plot what you want to see to the screen. This is found under “Utility Menu → Select
→ Component Manager”

 Creating a Material:

Page 24
of Mechanical Engineering, MSEC, Bangalore.
Create the material properties for your model in
“Main Menu → Preprocessor → Material Props → Material Models”. This gives you this
dialog box where all materials can be created, Double click on items in the right hand pane
of this window to get to the type of material model you want to create. All properties can
be temperature dependant. Click OK to create the material and it will appear in the left
hand pane. Create as many different materials as you need for your analysis.
 Selecting an Element Type:
ANSYS has a large library of element types. Why so many? Elements are organized
into groups of similar characteristics. These group names make up the first part of the
element name (BEAM, SOLID, SHELL, etc). The second part of the element name is a
number that is more or less (but not exactly) chronological. As elements have been created
over the past 30 years the element numbers have simply been incremented. The earliest
and simplest elements have the lowest numbers (LINK1, BEAM3, etc), the more recently
developed ones have higher numbers. The “18x” series of elements (SHELL181,
SOLID187, etc) are the newest and most modern in the ANSYS element library.
Tell ANSYS what elements you are going to use in your model using “Main Menu →
Element Type → Add/Edit/Delete”

Later, when meshing or creating elements manually you will need to tell ANSYS what
type of elements you want to create.
 Creating Properties
A solid element (brick or tet) knows its thickness, length, volume, etc by virtue of
its geometry, since it is defined in 3D space. Shell, beam and link (truss) elements do not
know this information since they are a geometric idealization or engineering abstraction.
Properties in

Dept. of Mechanical MSEC,


Engineering, Bangalore. Page 25
ANSYS are called Real Constants. Define real constants using “Main Menu → Real
Constants → Add/Edit/Delete”.

 Creating the Finite Elements Model - Meshing:


If you are just starting out in FEA, it is important to realize that your geometry
(called the solid model in ANSYS) is not your finite element model.
In the finite element method we take an arbitrarily complex domain, impossible to
describe fully with a classical equation, and break it down into small pieces that we can
describe with an equation.
These small pieces are called finite elements. We essentially sum up the response
of all these little pieces into the response of our entire structure The solver works with the
elements.
The geometry we create is simply a vehicle used to tell ANSYS where we want our
nodes and elements to go. While you can create nodes and elements one by one in a manual
fashion (called direct generation in ANSYS) most people mesh geometry because it is
much another very good reason we mesh geometry is that we assign materials and
properties to that geometry.
Then any element created on or in that geometric entity gets those attributes. If we don’t
like the mesh we can clear it and re-mesh, without having to re-assign the attributes.

 Steps for Creating the Finite Elements:


 Assign Attributes to Geometry (materials, real constants, etc).
 Specify Mesh Controls on the Geometry (element sizes you wa
 Mesh.
Most of the meshing operations can be done within the Mesh Tool, so that will be examined
in some detail now. Start it from “Main Menu → Preprocessor → Meshing → Mesh Tool”.

Smart Size is used to automatically

Page 26
pick the element edge length depending on the sizes of
features in the geometry. It makes a
finer mesh around Smaller Features
in order to Capture them
adequately.
For example in the mesh below
no sizes were specified at all
except a Smart Size level of 4.

A mapped mesh generates a very


regular grid of elements. This can
only be used on rectangular shaped
areas or volumes.
A free mesh will mesh any entity
regardless of shape.


 Applying Loads andBoundary Conditions:
Loads and boundary conditions can be applied in both the Preprocessor
(“Main Menu → Preprocessor → Loads → Define Loads → Apply”), and the Solution
processor (“Main Menu → Solution → Define Loads → Apply”).
1. Select the kind of constraint you want to apply.
2. Select the geometric entity where you want it applied.
3. Enter the value and direction for it.
There is no “modify” command for loads and B.C.’s. If you make a mistake simply apply
it again with a new value (the old one will be replaced if it’s on the same entity), or delete
it and reapply it.
Loads: Forces, pressures, moments, heat flows, heat fluxes, etc.
Constraints: Fixities, enforced displacements, symmetry and anti-symmetry conditions,
temperatures, convections, etc.
Although you can apply loads and boundary conditions to nodes or elements, it’s generally
better to apply all B.C.’s to your geometry. When the solve command is issued,

Page 27
they will be automatically transferred to the underlying nodes and elements. If B.C.’s are
put on the geometry, you can re-mesh that geometry without having to reapply them
 Solving:
Solution is the term given to the actual simultaneous equation solving of the
mathematical model. The details of how this is done internally is beyond the scope of this
guideline but is addressed in a separate “ANSYS Tips” white paper. For the moment, it is
sufficient to say that the basic equation of the finite element method that we are solving is,
[K]{u}={F}
where [K] is the assembled stiffness matrix of the structure,
{u} is the vector of displacements at each node, and
{F} is the applied load vector. This is analogous to a simple spring and is the essence
of small deflection theory.
To submit your model to ANSYS for solving, go to “Main Menu → Solution → Solve
→ Current LS”. LS stands for load step. A load step is a loading “condition”.
This is a single set of defined loads and boundary conditions (And their associated solution
results. More on this in the next section). Within an interactive session the first solve you
do is load step 1, the next solution is load step 2, etc.
If you leave the solution processor after solving to do post-processing for example, the load
step counter gets set back to one. You can also define and solve multiple load steps all at
once.
There are several solvers in ANSYS that differ in the way that the system of equations is
solved for the unknown displacements. The two main solvers are the sparse solver and the
PCG solver. If the choice of solvers is left to “program chosen” then generally ANSYS will
use the sparse solver. The PCG (preconditioned conjugate gradient) solver works well for
models using all solid elements. From a practical perspective one thing to consider is that
the sparse solver doesn’t require a lot of RAM but swaps out to the disk a lot. Disk I/O is
very slow. If you have a solid model and lots of RAM the PCG solver could be significantly
faster since the solution runs mostly in core memory

 Post processing:
The General Postprocessor is used to look at the results over the whole model at
one point in time.
This is the final objective of everything we have discussed so far; finding the
stresses, deflections, temperature distributions, pressures, etc. These results can then be
compared to some criteria to make an objective evaluation of the performance of your
design.
The solution results will be stored in the results file as result “sets”. For a linear
static analysis like we are talking about, the correlation between Load Step numbers and
Results Set numbers will be one to one as shown below.

Page 28
Only one set of results can be stored in the database at a time, so when you want to
look at a particular set, you have to read it in from the results file. Reading it in clears the
previous results set from active memory.

To read in a results set from the results file (not needed if you have run only a single
load step) use “Main Menu → General Postproc → Read Results → First Set, or By Pick”.
Most results are displayed as a contour plot as shown below. To generate a plot of stresses
use “Main Menu → General Postproc → Plot Results → Contour Plot → Nodal Solution”,
then pick the stresses you want to see

Dept. of Mechanical Engineering, MSEC, Bangalore. Page 29


There are many, many other ways to look at your results data including:
• Listing them to a file.
• Querying with the mouse to find a result at a particular node.
• Graphing results along a path.
• Combining different load cases.
• Summing forces at a point.
• Extracting data and storing it an APDL array that you can do further operations with.
Animate any result on the deformed shape with “Utility Menu → Plot Ctrls → Animate”.
This is very helpful for understanding if your model is behaving in a reasonable way

2.3 Performing a Typical ANSYS Analysis


The ANSYS program has many finite element analysis capabilities, ranging from a simple,
linear, static analysis to a complex, nonlinear, transient dynamic analysis. The analysis guide
manuals in the ANSYS documentation set describe specific procedures for performing analysis
for different engineering disciplines.

A typical ANSYS analysis has three distinct steps:

 Build the model.


 Apply loads and obtain the solution.
 Review the results.

 Building a Model
Building a finite element model requires more of an ANSYS user's time than any other
part of the analysis. First, you specify a jobname and analysis title. Then, you use the
PREP7 preprocessor to define the element types, element real constants, material
properties, and the
model geometry.
 Specifying a Jobname and Analysis Title
This task is not required for an analysis, but is recommended.
 Defining the Jobname
The jobname is a name that identifies the ANSYS job. When you define a jobname for
an analysis, the jobname becomes the first part of the name of all files the analysis creates.
(The extension or suffix for these files' names is a file identifier such as .DB.) By using a
jobname for each analysis, you insure that no files are overwritten. If you do not specify a
jobname, all files receive the name FILE or file, depending on the operating system.
Command(s): /FILNAME
GUI: Utility Menu>File>Change Jobname
 Defining Element Types
The ANSYS element library contains more than 100 different element types. Each
element type has a unique number and a prefix that identifies the element category:
BEAM4, PLANE77,SOLID96, etc. The following element categories are available:
The element type determines, among other things:

The degree-of-freedom set (which in turn implies the discipline-structural, thermal,


magnetic, electric, quadrilateral, brick, etc.) Whether the element lies in two-dimensional
or three-dimensional space.
For example, BEAM4, has six structural degrees of freedom (UX, UY, UZ, ROTX, ROTY,
ROTZ), is a line element, and can be modeled in 3-D space. PLANE77 has a thermal degree
of freedom (TEMP), is an eight-node quadrilateral element, and can be modeled only in 2-
D space.
 Defining Element Real Constants
Element real constants are properties that depend on the element type, such as
cross-sectional properties of a beam element. For example, real constants for BEAM3, the
2-D beam element, are area (AREA), moment of inertia (IZZ), height (HEIGHT), shear
deflection constant (SHEARZ), initial strain (ISTRN), and added mass per unit length
(ADDMAS). Not all element types require real constants, and different elements of the
same type may have different real constant values.
As with element types, each set of real constants has a reference number, and the
table of reference number versus real constant set is called the real constant table.
While defining the elements, you point to the appropriate real constant reference
number using the REAL command
(Main Menu> Preprocessor>Create>Elements>Elem Attributes).
 Defining Material Properties
Most element types require material properties. Depending on the application,
material
properties may be:
 Linear or nonlinear
 Isotropic, orthotropic, or anisotropic
 Constant temperature or temperature-dependent.
As with element types and real constants, each set of material properties has a material
reference Number.
The table of material reference numbers versus material property sets is called the Material
table. Within one analysis, you may have multiple material property sets (to correspond
with multiple materials used in the model). ANSYS identifies each set with a unique
reference Number.
Main Menu> Preprocessor> Material Props> Material Models.
 Creating the Model Geometry
Once you have defined material properties, the next step in an analysis is generating a
finite element model-nodes and elements-that adequately describes the model geometry.
There are two methods to create the finite element model: solid modeling and direct generation.
With solid modeling, you describe the geometric shape of your model, then instruct the ANSYS
program to automatically mesh the geometry with nodes and elements. You can control the
size and shape of the elements that the program creates. With direct generation, you "manually"
define the location of each node and the connectivity of each element. Several convenience
Operations, such as copying patterns of existing nodes and elements, symmetry reflection, etc.
are available.
 Apply Loads and Obtain the Solution
In this step, you use the SOLUTION processor to define the analysis type and analysis
options, apply loads, specify load step options, and initiate the finite element solution. You
also can apply loads using the PREP7 preprocessor.
 Applying Loads
The word loads as used in this manual includes boundary conditions (constraints,
supports, or boundary field specifications) as well as other externally and internally applied
loads. Loads in the ANSYS program are divided into six categories:
 DOF Constraints
 Forces
 Surface Loads
 Body Loads
 Inertia Loads
 Coupled-field Loads
You can apply most of these loads either on the solid model (keypoints, lines, and areas)
or the finite element model (nodes and elements). Two important load-related terms you
need to know are load step and substep.
A load step is simply a configuration of loads for which you obtain a solution. In a
structural analysis, for example, you may apply wind loads in one load step and gravity in
a second load step. Load steps are also useful in dividing a transient load history curve into
several segments.
Substeps are incremental steps taken within a load step. You use them mainly for accuracy
and
convergence purposes in transient and nonlinear analyses. Substeps are also known as
time stepssteps taken over a period of time.
 Initiating the Solution
To initiate solution calculations, use either of the following:
Command(s): SOLVE
GUI: Main Menu>Solution>Current LS
When you issue this command, the ANSYS program takes model and loading
information from the database and calculates the results. Results are written to the results
file (Jobname.RST, Jobname.RTH, Jobname.RMG, or Jobname.RFL) and also to the
database. The only difference is that only one set of results can reside in the database at
one time, while you can write all sets of results (for all substeps) to the results file.
 Review the Results
Once the solution has been calculated, you can use the ANSYS postprocessors to
review the results.

2.4. General Steps


Step 1: Ansys Utility Menu
File – clear and start new – do not read file – ok
File – change job name – enter new job name – xxxx – ok
File – change title – enter new title – yyy – ok
Step 2: Ansys Main Menu – Preferences
Select – STRUCTURAL - ok
Step 3: Preprocessor
Element type – select type of element from the table and the required options
Real constants – give the details such as thickness, areas, moment of inertia, etc.
Required depending on the nature of the problem.
Material Properties – give the details such as Young’s modulus, Poisson’s ratio
etc. Depending on the nature of the problem.
Step 4: Modeling – create the required geometry such as nodes elements, area,
volume by using the appropriate options.
Step 5: Generate – Elements/ nodes using Mesh Tool if necessary (in 2D and 3D
p ds such as DOF constraints, Force/Momentum,
r Pressure etc.
o Step 7: Solution – Solve the problem
b Step 8: General Post Processor – plot / list the required results.
l Step 9: Plot ctrls – animate – deformed shape –
e def+undeformed-ok Step 10: to save the solution, ansys tool
m
bar- save, model
s
)
S
t
e
p
6
:
A
p
p
l
y
b
o
u
n
d
a
r
y
c
o
n
d
i
t
i
o
n
s
/
l
o
a
EXPERIMENT TYPE 1:
AIM:- Stress analysis of Bars of constant cross section area

A.1 .Consider the bar shown in figure below. Determine the Nodal Displacement,
Stress in each element, Reaction forces.

Procedure:

Step 1: Ansys Utility Menu


File – clear and start new – do not read file – ok – yes.
Step 2: Ansys Main Menu – Preferences
select – STRUCTURAL - ok
Step 3: Preprocessor
Element type – Add/Edit/Delete – Add – Link – 2D spar 1 – ok – close.
Real constants – Add – ok – real constant set no – 1 – c/s area – 22/7*50**2/4 –
ok.
Material Properties – material models – Structural – Linear – Elastic – Isotropic
– EX – 2.1e5 –PRXY – 0.27 – ok – close.
Step 4: Preprocessor
Modeling – Create – Nodes – In Active CS – Apply (first node is created) – x,y,z
location in CS – 300 (x value w.r.t first node) – ok (second node is created).
Create – Elements – Auto numbered – Thru Nodes – pick 1 & 2 – ok (elements
are created through nodes).
Step 5: Preprocessor
Loads – Define loads – apply – Structural – Displacement – on Nodes- pick node
1 – apply –DOFs to be constrained – All DOF – ok. Loads – Define loads – apply
– Structural – Force/Moment – on Nodes- pick node 2 – apply – direction of
For/Mom – FX – Force/Moment value – 1500 (+ve value) – ok.
Step 6: Solution
Solve – current LS – ok (Solution is done is displayed) – close.

, Page 35
Step 7: General Post Processor
Element table – Define table – Add –‘ Results data item’ – By Sequence num –
LS – LS1 – ok.
Step 8: General Post Processor
Plot Results – Deformed Shape – def+undeformed – ok.
Plot results – contour plot – Line Element Results – Elem table item at node I –
LS1 – Elem table item at node J – LS1 – ok (Line Stress diagram will be displayed).
List Results – reaction solution – items to be listed – All items – ok (reaction forces
will be displayed with the node numbers).
List Results – Nodal loads – items to be listed – All items – ok (Nodal loads will
be displayed with the node numbers).
Step 9: PlotCtrls – Animate – Deformed shape – def+undeformed-ok

Comparison between theoretical and Ansys values:

Ansys Theoretical
Particulars
Node 1 Node 2 Node 1 Node2

Deformation

Stress

Reaction

, Page 36
A.2.A steel rod subjected to compression is modeled by two bar elements, as shown in
Figure. Determine the nodal displacements and the axial stress in each Element.
E=207 GPa, A = 500 mm2

Procedure:

1. Utility Menu > File > Change Job name > Enter ‘Bar Analysis’
2. Utility Menu > File > Change Title > Enter Bar Analysis.
3. Preprocessor> Element type>Add/Edit/Delete>Add> Link1
4. Preprocessor> Real constant> Add/Edit/Delete>Add>Ok> Area>500
5. Preprocessor>Material Property> Young’s Modulus > Enter Ex = 2e5.
6. Preprocessor > Modeling > Create>node > In active CS > Create three nodes
at Location (0, 0, 0) (500, 0, 0) and (1000, 0, 0).
7. Preprocessor > Modeling > Create > Element > Auto numbered >
Thru node > (Pick nodes (1, 2), (2, 3) and create element).
8. Preprocessor > Load > Define load > Apply > Structural > Displacement>
Select Node number 1 and apply ‘ALL DOF’.
9. Preprocessor > Load > Define load > Apply> Structural > Force / moment on nodes >
Select node number 3 and Enter value Fx = -12000 N.
10. Solution > Solve > Current LS
11. General postprocessor > Plot Results > Deform shape
12. Postprocessor> Contour plot> Nodal solution> Displacement vector sum.
13. Postprocessor>Element Table>Define Table>Add>By sequence num>LS 1
14. Postprocessor>Element Table>List Elem table>LS 1>ok

, Page 37
Comparison between theoretical and Ansys values

Ansys Theoretical
Particulars
Node 1 Node 2 Node 3 Node 1 Node 2 Node 3
Deformation
Stress
Reaction

, Page 38
A.3. Load of P = 60 x 10 3 N is applied as shown. Determine the following, a) Nodal
Displacement, b) Stress in each member, c) Reaction Forces.
Given Data: E=20 x103N/m2. 0.3 (Poison's Ratio)

Procedure:

1. File - Clear & Start New - Do not read File - Ok.


File - Change Job Name - Enter New Job Name - AXIAL 4 - Ok.
File - Change Title -Enter New Title - AXTAL 4 - Ok.
2. Ansys Main Menu(AMM) - preferences - Select Structural-Ok.
3. AMM - Preprocessor-Element Type-Add /Edit/Delete-Add - Link-2D spar 1 -Ok-
Close.
4. AMM - Preprocessor- Real Constants -Add -Ok - Real Constant No,1 -C/S Area =
250 – Apply-Ok - close.
5. AMM - Preprocessor - Material Properties - Material Models - Structural - Linear –
Elastic - Isotropic - Ex - 20e3, PRXY - 0.3 - 0k
6. AMM - Preprocessor-Modeling –Create- Node- in active CS- Node Number -1 XYZ
– 0, 0,0 Apply- Node Number - 2, XYZ- 1 50, 0, 0 - Node number 3, XYZ_ 300, 0,
0 _ Ok.
7. AMM- Preprocessor-Modeling-Create-Elements-Auto Numbered-Throu nodes – pick
Menu - Pick 1&2 Node - Apply, Pick 2 & 3 Node -Apply - Ok.
8. AMM – Preprocessor- Loads - Define Loads-Apply-Structural- Displacement-On
Nodes- pick 1st Node Apply - All DOF - Apply, pick 3rd Node - Apply - UX –
Give Displacement Valu l, 2 - Apply – Ok
9. AMM - Preprocessor- Loads - Define Loads-Apply-Structural- Force/ Moments- on
Nodes- Pick 21- Node - Apply - Select FX = 60e3 - Apply - Ok
10. AMM - solution - solve - current LS - ok - close - close (solution is done).
11. AMM-General P,P-Element Table-Define Table-Add-(Set Label)-Stress-(Set item,
Comp)- By Sequence Number- LS, LS1, - Ok.
12. AMM - GPP – Element table - List Element Table - select Stress - ok.
13. AMM - GPP - List Result – Nodal Solution - DOF solution - select All DOF - ok
14. AMM - GPP - List Results - Reaction solutions - select all items - ok.
, Page 40
15. AMM - GPP - Plot Results - Deformed shape - select Deformed + UN deformed –
ok.
16. AMM - GPP - Plot Results - Contour Plots - Line Element Results - Select Lab I =
Stress, Lab J = Stress - Ok.
17. Plot controls - Numbering - switch on Node Numbers & Elements Numbers - ok.
18. Plot Controls - Symbols - All BC's
19. Plot Controls - Animate - Deformed Shape - Ok
20. Plot - Multi plots.
21. File - Save as - Select the Directory - AXIAL 6 - Ok

Comparison between theoretical and Ansys values

Ansys Theoretical
Particulars
Node 1 Node 2 Node 3 Node 1 Node 2 Node 3

Deformation

Stress

Reaction

, Page 41
A.4.For the tapered bar shown in the figure determine the displacement, stress and
reaction in the bar. Given A1 = 1000 mm2 and A2 = 500 mm2, E = 2x105 N/mm2

The Tapered bar is modified into 2 elements as shown below with modified area of cross section
(1000+500)/2 = 750 mm2
Areas of modified two elements:
A1 = (1000+750)/2 = 875 mm2
A2 = (750+500)/2 = 625 mm2

Procedure:
1. Utility Menu > File > Change Jobname
2. Utility Menu > File > Change Title
3. Preprocessor> Element type>Add/Edit/Delete>Add> Link1.
4. Preprocessor> Real constant> Add/Edit/Delete>Add>Ok> Area>
(Create 2 set of Real Constant) > A1= 875 mm2and A2 = 625 mm2.
5. Preprocessor>Material Property> Young’s Modulus > Enter Ex= 2x105
6. Preprocessor > modeling > Create > Node > In active CS> Create 3 Nodes > (0,
0, 0), (-187.5, 0, 0) and (-375, 0, 0).
7. Preprocessor>Modeling >Create>Element> Element Attributes
(You can set Real Constant number set to 1).
8. Preprocessor>Modeling >Create>Element >Auto numbered >Thru Node>
(Pick nodes and create element between nodes 1 and 2)
9. Repeat the procedures given in 7 and 8 set real constant number to 2 and create
Element between nodes 2 and 3.
10. Preprocessor>Load>Define load> Apply> Structural> Displacement> on nodes
and select node 1 and Apply ‘ALL DOF’ in the wizard.
11. Preprocessor>Load>Define load> Apply> Structural>Force / moments > on
Nodes > Select node number ‘3’ and Apply a force Fy = - 4000.
12. Solution> Solve> Current LS.
13. General postprocessor > Plot Result > Deform shape
14. Postprocessor > Contour plot > Nodal solution > Displacement vector sum.
Comparison between Ansys and Theoretical Results

Ansys Theoretical
Particulars
Node 1 Node 2 Node 3 Node 1 Node 2 Node 3

Deformation

Stress

Reaction
EXPERMENT TYPE: II

AII.Consider the four bar truss shown in figure. For the given data, find
Stress in each element, Reaction forces, Nodal displacement. E = 210 GPa, A
= 0.1 m2.

Procedure:

Step 1: Ansys Utility Menu


File – clear and start new – do not read file – ok – yes.
Step 2: Ansys Main Menu – Preferences
Select – STRUCTURAL - ok
Step 3: Preprocessor
Element type – Add/Edit/Delete – Add – Link – 2D spar 1 – ok – close.
Real constants – Add – ok – real constant set no – 1 – c/s area – 0.1 – ok – close.
Material Properties – material models – Structural – Linear – Elastic – Isotropic – EX –
210e9 – ok – close.
Step 4: Preprocessor
Modeling – Create – Nodes – In Active CS – Apply (first node is created) – x,y,z
location in CS – 4 (x value w.r.t first node) – apply (second node is
created) – x,y,z location in CS – 4, 3 (x, y value w.r.t first node) – apply
(third node is
Created) – 0, 3 (x, y value w.r.t first node) – ok (forth node is created).
Create – Elements – Elem Attributes – Material number – 1 – Real
constant set number – 1 – ok Auto numbered – Thru Nodes – pick 1 & 2 –
apply – pick 2 & 3 – apply – pick 3 & 1 – apply – pick 3 & 4 – ok
(elements are created through nodes).
Step 5: Preprocessor

Page 59
Loads – Define loads – apply – Structural – Displacement – on Nodes – pick node
1 & 4 – apply – DOFs to be constrained – All DOF – ok – on Nodes – pick node 2
– apply – DOFs to be Constrained – UY – ok. Loads – Define loads – apply –
Structural – Force/Moment – on Nodes- pick node 2 – apply – direction of For/Mom
– FX – Force/Moment value – 2000 (+ve value) – ok – Structural Force/Moment –
on Nodes- pick node 3 – apply – direction of For/Mom – FY – Force/Moment value
– -2500 (-ve value) – ok.
Step 6: Solution
Solve – current LS – ok (Solution is done is displayed) – close.
Step 7: General Post Processor
Element table – Define table – Add – ‘Results data item’ – By Sequence num –
LS – LS1 – ok.
Step 8: General Post Processor
Plot Results – Deformed Shape – def+undeformed – ok.
Plot results – contour plot – Line Element Results – Elem table item at node I –
LS1 – Elem table item at node J – LS1 – ok (Line Stress diagram will be displayed).
Plot results – contour plot – Nodal solution – DOF solution – displacement vector
sum – ok. List Results – reaction solution – items to be listed
– All items – ok (reaction forces will be displayed with the node numbers).
List Results – Nodal loads – items to be listed – All items – ok (Nodal loads will
be displayed with the node numbers).
Step 91. PlotCtrls – Animate – Deformed shape – def+undeformed-ok

Comparison between Ansys and Theoretical Results

1. Nodal solution and Displacements

Node No Ux ( Theory ) Ux ( ANSYS ) Uy (Theory) Uy ( ANSYS)

Page 60
1. Elemental Solution and Displacement

Element No Stress (Theory) Stress (ANSYS)

1. Reaction Solution

Node No Fx (Theory) Fx (ANSYS) Fy (Theory) Fy (ANSYS)

Page 61
AII.2Analyze the 2D truss as shown below. All the members have cross-sectional
Area of 5000 mm2 and are made of steel with Young’s modulus 210000 MPa. The
Settlement at support B is 10 mm. The roller at C is on a floor 45° from horizontal
direction.
(a) If the applied force P is 200 kN, determine the member forces and
Stresses.
(b) Determine the maximum value of P in which the maximum member
Force does not exceed 600 kN.

Procedure:

Step 1: Start up & Initial Set up


Start ANSYS
Set Working Directory
Specify Initial job name: 2DTruss
Set Preferences: Structural
Set the unit system to SI by typing in “/units, SI” in the command line.
Check the output window for the units in SI system.
Step 2: Element Type and Real Constants
Specify element type: Main Menu > Preprocessor> Element Type > Add/Edit/Delete >
Add Pick Link in the left field and 2D Spar 1 in the right field. Click OK. Click Close.
Main Menu > Preprocessor > Real Constants > Add/ Edit/ Delete, and click ADD
Enter the cross-sectional area as 5000E-6 m2 Click OK. Click Close.

Step 3: Material Properties


Main Menu > Preprocessor > Material Props > Material Models > Structural > Linear
>Elastic > Isotropic Enter the Elastic modulus as 210Ee9 (Pa).
Save your work File > Save as Jobname.db
, Page 62
Step 4: Modeling
Create Keypoints
Main Menu > Preprocessor > Modeling > Create > Keypoints > In Active CS
Enter the keypoint number and coordinates of each keypoint. Click Apply after
each input. Click OK when finish. Note that: If the keypoint number is not blank,
the program will automatically use the smallest available number (that has not yet
been specified)
Create Lines from Keypoints
Main Menu > Preprocessor > Modeling > Create > Lines > Lines >Straight Line
Select the two keypoints to be joined by the line. Continue the same to construct
lines.
Step 5: Meshing
Main Menu > Preprocessor > Meshing > Mesh Tool There will be a Mesh Tool window
pop up.
In the third section Size Controls >Lines Click Set. Select Pick All. Another window
pops up. Enter the number of element divisions (NDIV) as 1. Click OK.
In the Mesh Tool pop up (fourth section), Mesh: Lines. Click Mesh. Select Pick All
Then close the Mesh Tool window.
To see node and element numbering, use: Plot Ctrls >Numbering>Node Numbers and
Plot Ctrls >Numbering >Element/Attr Numbering
Choose Plot > Elements to see the elements and the nodes
Step 6: Specify Boundary Conditions & Loading
Main Menu > Preprocessor > Loads > Define Loads > Apply > Structural > Displacement
> On Nodes Now select point A. Select “ALL DOF” in the box showing DOF to be
constrained. Set Value as 0 Click Apply
Select point B. Constrain “UY” and set displacement value to -10e-3 m. Click OK.
Since the roller at point C is 45° from global x axis. We cannot apply the support directly.
We need to create a local coordinate system at point C in the orientation of the support.
Work Plane > Local Coordinate Systems > Create Local CS > By 3 Nodes Read the
instruction at the bottom of ANSYS window.
It says Pick or enter 3 nodes: origin, X axis and XY plane. Choose the nodes in that order
by clicking node 3, 5and 2, respectively (See figure below). Note that node 5 defines the
direction of the x-axis and node 2 defines the xy plane. The direction of y-axis is
perpendicular to the x-axis toward node 2.
After you clicked the 3 nodes, there will be a pop up window asking for Reference number
of new CS and its type. The Reference number starts at 11 by default. Choose Cartesian
CS. Click OK.
Select List > Other > Local Coord Sys. You can see that the Active CS is now CS no. 11
(which is the local CS we just created). CS numbers 0 to 6 are global CS. Check the origin
and orientation of CS 11.
Now we have to rotate the orientation of node 3 from global CS to the local CS
, Page 63
Main Menu > Preprocessor > Modeling > Move/Modify > Rotate Node CS > To Active
CS Pick node 3. Click OK next, constrain “UX” at node 3. Check the orientation of the
triangle at node 3 (Plot > Multi- Plots).
Apply Loading:
Main Menu > Preprocessor > Loads > Define Loads > Apply > Structural > Force/Moment
> On Nodes Now select Node 4 and 6 In the menu that appears, select FY for Direction of
force. Enter -200e3 for Force/ moment value. Click Apply. Similarly, you can apply other
forces. You can check your applied loads by from the graphic window or
List > Load > Forces > On All Nodes
Step 7: Solve
Main Menu > Solution > Solve > Current LS
Click OK
Step 8: Post Processing
Plot Deformed Shape
Main Menu > General Postproc > Plot Results > Deformed Shape
Select Deformed+Undeformed

Click OK

Animate Deformation
PlotCtrls > Animate > Deformed Shape
List Member Forces & Stresses
Main Menu > General Postproc > Element Table > Define Element Table > Add > Select
By Sequence number in the left list box, and SMISC in the right list box. Type “1” after
the comma in the box at the bottom of the window.
Click Apply
For member stresses, choose By Sequence num> LS, 1
Main Menu > General Postproc > Element Table > List Element Table >
, Page 64
Select SMIS1 and LS1
Click OK
Now you can see the element forces and the stresses .
List the Deflections and Reaction Forces
Main Menu > General Postproc > List Results > Nodal Solution
Click DOF Solution and in the sub-list select Displacement vector sum
Click OK
(b)
From (a), the maximum member force (consider both from compression and tension) for P
equal to 200 kN is 1146.4 kN. Since this is an elastic problem, you can find the maximum
P that the member forces do not exceed 600 kN simply by

1. Nodal solution and Displacements

Node No Ux ( ANSYS ) Uy ( ANSYS)


1
2
3
4
5
6
1. Elemental Solution and Displacement

Element Stress Stress Stress


Element No Element No
No (ANSYS) (ANSYS) (ANSYS)
1 6 11
2 7
3 8
4 9
5 10

, Page 65
EXPERMENT TYPE: III

A.III.(1) In the plate with a hole under plane stress, find deformed shape of the hole
and Determine the maximum stress distribution along A-B (you may use t = 1 mm).
E = 210GPa, t = 1 mm, Poisson’s ratio = 0.3, Dia of the circle = 10 mm, Analysis
assumption – plane stress with thickness is used.

Procedure:

Step 1: Ansys Utility Menu


File – clear and start new – do not read file – ok – yes.
Step 2: Ansys Main Menu – Preferences
select – STRUCTURAL - ok
Step 3: Preprocessor
Element type – Add/Edit/Delete – Add – Solid – Quad 4 node – 42 – ok – option –
element behavior K3 – Plane stress with thickness – ok – close.
Real constants – Add – ok – real constant set no – 1 – Thickness – 1 – ok.
Material Properties – material models – Structural – Linear – Elastic – Isotropic – EX –
2.1e5 –PRXY – 0.3 – ok – close.
Step 4: Preprocessor
Modeling – Create – Area – Rectangle – by dimensions – X1, X2, Y1, Y2 – 0, 60, 0, 40
– ok. Create – Area – Circle – solid circle – X, Y, radius – 30, 20, 5 – ok.
Operate – Booleans – Subtract – Areas – pick area which is not to be deleted (rectangle)
– apply – pick area which is to be deleted (circle) – ok.
Meshing – Mesh Tool – Mesh Areas – Quad – Free – Mesh – pick all – ok. Mesh Tool –
Refine– pick all – Level of refinement – 3 – ok.
Step 5: Preprocessor

Page 88
Loads – Define loads – apply – Structural – Displacement – on Nodes – select box – drag
the left side of the area – apply – DOFs to be constrained – ALL DOF – ok.
Loads – Define loads – apply – Structural – Force/Moment – on Nodes – select box – drag
the right side of the area – apply – direction of For/Mom – FX – Force/Moment value –
2000 (+ve value) – ok.
Step 6: Solution
Solve – current LS – ok (Solution is done is displayed) – close.
Step 7: General Post Processor
Plot Results – Deformed Shape – def+undeformed – ok.
Plot results – contour plot – Element solu – Stress – Von Mises Stress – ok (the stress
distribution diagram will be displayed).
Step 8: PlotCtrls – Animate – Deformed shape – def+undeformed-ok

Page 89
EXPERMENT TYPE: IV

AIV.(1)A pipe of 100mm external dia. And 20mm thickness carries water at a
pressure of 20MPa. Determine the maximum and minimum intensities of hoop
stresses in the section of pipe. Also plot the variation of hoop and radial
stresses across the thickness of pipe.

Step1 : Preprocessor > Element Type > Add/Edit/Delete > Add > Solid > select Quad 4
Node 182 >
OK > Options (Element Behavior)> Axisymmetric > OK > Close
Step 2: Preprocessor > Material Props > Material Models > Structural > Linear > Elastic >
Isotropic >Enter Ex = 2.e5 and PRXY = 0.3 > OK > Close.
Note: In ANSYS the Y axis is always the axis of symmetry for axisymmetric problems.
Step 3: Preprocessor -> Create -> Areas -> Rectangle ->By 2 Corners

4. Preprocessor -> Meshing -> mesh tool -> (Click on smart size and reduce to fine mesh-3)
>pick the rectangular area>ok

Page 90
5. Solution -> Loads ->Apply ->Displacement -> On Lines (Pick the bottom line of the
rectangle)
uy = 0 along this line. This simply prevents rigid body motion in the Y direction. No other
displacement boundary conditions are required. The radial movement is prevented by the 'hoop'
tension in the cylinder.
6. Solutions -> Loads ->Apply ->Pressure -> On Lines (Pick the left hand line of the
rectangle).
Enter a pressure of 20

7. Solution -> Solve -> Current LS ->OK


8. General Post Processor -> Plot Results -> Deformed Shape . . . ->Def +undeformed ->
OK

9. General Postprocessor -> Plot Results ->Contour plot> Element Solu >Stress>X
component
of stress>ok (Pick Sx, Sz and examine each).
Sx (Radial stresses)……………….

Page 91
The SX stress is the radial stress that is equal to the pressure (20MPa) on the interior of the
cylinder
and is zero on the exterior. We will need to examine the computed values more closely evaluate
this
further.
10. General Postprocessor -> Plot Results ->Contour plot> Element Solu >Stress>Z
component
of stress>ok (Pick Sx, Sz and examine each).
Sz (hoop stresses)……………….

SZ is the 'hoop' stress perpendicular to the plane of this rectangle and varies from
22.5613 to 42.2178 MPa in the legend above.

Page 92
11.Graph Stresses in Cross Section:
MAIN MENU: General Postproc > Path Operations > Define Path-By Nodes
DEFINE PATH: Pick nodes along the Radius (Horizontal ) from inner radius to outer radius.
Click OK.
In the Define Path Name box, type: Dist, click OK.
PATH OPERATIONS: Map Onto Path> Highlight Stress
MAP ONTO PATH: User Label Item >Hoop> StressHighlight Z-Direction SZ(Hoop) >OK
MAP ONTO PATH: User Label Item >Radial> StressHighlight X-Direction SX(Radial) >OK
PATH OPERATIONS: Plot Path Items -On Graph > Highlight SZ & SX > OK
A graph of the stresses along the chosen path will appear as shown in the figure below.

Variation of Hoop and Radial Stress across thickness


We can calculate SX and SZ from solid mechanics formulas for thick walled cylinders. These
equations are given by

Page 93
At the inside of the cylinder SX(Radial Stresses) = 20MPa and SZ(Hoop Stresses) = 42.2178
At the outside of the cylinder SX = 0 MPa and SZ = 22.5613
Thus the ANSYS calculated results agree pretty well with the theory. Here, radial stress is
negative and Hoop stress is positive.

Variation of hoop and Radial stress in MPa across radius

AIV.(2) A thick cylinder has inner and outer dia as 120mm and 180mm respectively, it is
subjected to an external pressure of 9MPa. Determine the maximum and minimum
intensities of Hoop stresses in the section of pipe also plot the variation of hoop and radial
stresses across the thickness of pipe.

Page 94
EXPERMENT TYPE: V

AV.(1) Modal Analysis of Cantilever beam for natural frequency


determination. Modulus of elasticity = 200GPa, Density = 7800
Kg/m3

Procedure:

Step 1: Ansys Utility Menu


File – clear and start new – do not read file – ok – yes.
Step 2: Ansys Main
Menu –
Preferences
select –
STRUCTUR
AL - ok
Step 3: Preprocessor
Element type – Add/Edit/Delete – Add – BEAM – 2D elastic 3 – ok- close.
constants – Add – ok – real constant set no – 1 – c/s area – 0.01*0.01 moment of
inertia
–0.01*0.01**3/12 – total beam height – 0.01 – ok.
Material Properties – material models – Structural – Linear –
Elastic – Isotropic – EX – 200e9 – PRXY – 0.27 – Density – 7800 –
ok – close.
Step 4: Preprocessor
Modeling – Create – Keypoints – in Active CS – x,y,z locations – 0,0
– apply – x,y,z locations –1,0 – ok (Keypoints created).
Create – Lines – lines – in Active Coord – pick keypoints 1 and 2 – ok.
Meshing – Size Cntrls – ManualSize – Lines – All Lines – element
edge length – 0.1 – ok. Mesh – Lines – Pick All – ok.
Step 5: Solution
Solution – Analysis Type – New Analysis – Modal – ok.
Solution – Analysis Type – Subspace – Analysis options – no of
modes to extract – 5 – no of modes to expand – 5 – ok – (use default
values) – ok.
Page 95
Solution – Define Loads – Apply – Structural – Displacement – On
Keypoints – Pick first keypoint – apply – DOFs to be constrained –
ALL DOF – ok.
Solve – current LS – ok (Solution is done is displayed) – close.
Step 7: General Post Processor
Result Summary
Step 8: General Post Processor
Read Results – First Set Plot Results – Deformed Shape – def+undeformed – ok.
PlotCtrls – Animate – Deformed shape – def+undeformed-ok. Read Results – Next
Set Plot Results – Deformed Shape – def+undeformed – ok.
PlotCtrls – Animate – Deformed shape – def+undeformed-ok.

Page 96
EXPERMENT TYPE: VI

AVI.(1).Solve the 2-D heat conduction problem for the temperature distribution within the
rectangular plate. Thermal conductivity of the plate, KXX=401 W/(m-K).

Procedure:

Step 1: Ansys Utility Menu


File – clear and start new – do not read file – ok – yes.
Step 2: Ansys Main Menu – Preferences select – THERMAL - ok
Step 3: Preprocessor
Element type – Add/Edit/Delete – Add – Solid – Quad 4 node – 55 –
ok – option – element behavior K3 – Plane stress with thickness – ok –
close.
Material Properties – material models – Thermal – Conductivity – Isotropic – KXX – 401.
Step 4: Preprocessor
Modeling – Create – Area – Rectangle – by dimensions – X1, X2, Y1, Y2
– 0, 10, 0, 20 – ok. Meshing – Mesh Tool – Mesh Areas – Quad – Free –
Mesh – pick all – ok. Mesh Tool – Refine
– pick all – Level of refinement – 3 – ok.
Step 5: Preprocessor
Loads – Define loads – apply – Thermal – Temperature – on Lines – select 1000 C lines –
apply
– DOFs to be constrained – TEMP – Temp value – 1000 C – ok.
Loads – Define loads – apply – Thermal – Temperature – on Lines – select 1000 C lines –
apply
– DOFs to be constrained – TEMP – Temp value – 2000 C – ok.
Page 97
Step 6: Solution
Solve – current LS – ok (Solution is done is displayed) – close.
Step 7: General Post Processor
Plot results – contour plot – Nodal solu – DOF solu – Nodal Temperature –– ok
Step 8: PlotCtrls – Animate – Deformed results – DOF Solution – Temperature – ok.

Page 98
1. What is the total degree of freedom of Ansys commercial package.
2. What are the different menus in ANSYS.
3. What is Work space and Swap space.
4. What is default value of workspace and Swapspace?
5. What file format ANSYS can support
6. What is the current ANSYS version
7. What is optimization in ANSYS.
8. What is sub structuring and adaptive meshing?
9. Which package is better – ANSYS or NASTRAN.
10.What is Resume in ANSYS?
11.What is P-method and H-method
12.What are scalar parameters in ANSYS?
13.What are primary nodes and Secondary nodes?
14.What is Mirror (Reflection).
15.What are subroutines.

Page 99

You might also like