CHAPTER 1. Introduction

Size: px
Start display at page:

Download "CHAPTER 1. Introduction"

Transcription

1 ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization and Typical Finite Elements 1.5 Solution Validation

2 ME 475: Computer-Aided Design of Structures Analysis versus Design Analysis: Given loading conditions and the system properties, determine the performance of the system. In other words, given the inputs, determine the outputs. Example: Given the loading and cross-sectional geometry of an I-beam, determine its deflection. Linear analysis involves a direct solution procedure. Non-linear analysis typically involves an iterative solution procedure. In this class, we will use the finite element method to analyze the linear structural response of engineering systems. Design: Given loading conditions and the system performance targets, determine the system properties that satisfy those response targets. In other words, given the outputs, determine the inputs. Example: Given the loading and allowable deflection of an I-beam, determine the cross-sectional shape of the beam such that the mass is minimized and the deflection constraint is satisfied. Except in the simplest cases, design always involves an iterative process or search for a design that satisfies the performance objectives. In general, each iteration requires a complete analysis of a proposed design, so this process can be very computationally

3 ME 475: Computer-Aided Design of Structures 1-3 intensive. In this class we will use automated design optimization methods to identify the optimal design of engineering systems. Graphically, the design process can be described as follows: Initial Design Concept Specific Design Candidate Modify Design Build Analysis Model(s) Execute the Analyses No Design Requirements Met? Yes Final Design

4 ME 475: Computer-Aided Design of Structures Basic Steps in Analysis For any kind of engineering analysis: 1. Define the goals of the analysis. 2. Anticipate the physical behavior. 3. Identify a reasonable mathematical idealization (governing differential equations). a. Classify the predominant phenomena, and identify the most appropriate mathematical representation of each component. b. Taking into account the choice made in step 3a, determine an appropriate geometrical representation of the mathematical domain. c. Describe the boundary conditions. d. Identify key material behaviors (constitutive equations). 4. Solve for the desired response quantities (FEM, FDM, BEM, EFG, etc.). 5. Interpret and validate results and verify assumptions made in step Return to step 1, if necessary.

5 ME 475: Computer-Aided Design of Structures 1-5 These steps can be explained further as follows: 1. Define the goals of the analysis. Typical objectives are: Predict the stress or deflection at a particular point in a structure. Predict the first three natural frequencies of a structure. Determine the temperature distribution near a cutout. Predict the pressure variation in an internal flow. The goal(s) of the analysis will determine what kind of model is needed. This is a critical step, and one that should not be taken lightly. 2. Anticipate the physical behavior. For example: Stresses should be high near regions of geometric discontinuity. Thermal stresses should be small in regions that are loosely constrained. Turbulent flow often occurs near reentrant corners. Here, intuition is extremely valuable. It is sometimes helpful to perform a quick back of the envelope calculation to estimate certain response values.

6 ME 475: Computer-Aided Design of Structures Identify a reasonable mathematical idealization. a. Classify each part to be analyzed, and identify the most appropriate representation of each component. Possible representations include: Solid/Structural Mechanics: A continuum representation (based on elasticity theory): 1D a bar subjected to only axial load 2D a region exhibiting plane stress, plane strain, generalized plain strain, or axisymmetric response 3D a three dimensional solid A structural representation (based on mechanics of materials theory): Beam Plate/Shell A special representation: Spring Rigid link

7 ME 475: Computer-Aided Design of Structures 1-7 Fluid Mechanics: Ideal Inviscid (Potential) Flow Viscous Flow Non-Newtonian Flow Associated with each classification is a set of differential equations that govern the anticipated behavior and account for the assumptions made. Numerical methods provide approximations to these differential equations. b. Taking into account the choice made in step 3a, determine an appropriate geometrical representation of the mathematical domain. ** The mathematical and computational domain is that domain upon which the governing differential equations and boundary conditions are defined. It is not always necessary to explicitly represent every detail of a system. Often it is possible to represent the geometry in a simplified (or idealized) way without adversely affecting the predicted response in the

8 ME 475: Computer-Aided Design of Structures 1-8 primary region(s) of interest, provided the geometrical simplifications are not near the region(s) of interest. Small features, such as fillets and holes, may require significant effort to represent accurately. If these features do not affect the main results sought, as defined in step 1, then it may be possible to ignore them. This is sometimes called defeaturing the geometry. In the plate shown below, for example, the main region of concern may be the domain near the elliptical cutout. Since the rounded corners are a reasonable distance away from the region of primary concern, they may be represented as sharp corners. Likewise, the small holes near these corners may be neglected. This approach simplifies the geometry (and the analysis) but should have little or no effect on the predicted response near the cutout. Note that a clear definition of analysis objectives (step 1) is required to justify such simplifications. Actual Geometry Idealized Geometry

9 ME 475: Computer-Aided Design of Structures 1-9 c. Describe boundary conditions. These should be represented as accurately as possible. However, if the primary region(s) of interest are a significant distance away from the location of loading or constraint, it may be possible to simplify the representation of these boundary conditions (e.g., using Saint Venant s Principle). e. Identify key material behaviors. For many classes of problems, especially nonlinear ones, this aspect of the model is often the most challenging and the most important. 4. Solve for the desired response quantities. For example: Solid Mechanics: Displacements Strains Stresses Natural frequencies Buckling loads Transient response

10 ME 475: Computer-Aided Design of Structures 1-10 Fluid Mechanics Velocity Pressure Temperature 5. Interpret and validate the results and verify the assumptions made in step Return to step 1, if necessary. When defining a problem, there are two extreme approaches. 1. Simplify the mathematical representation to a form that allows a simple analytical solution. In this case, important physical behaviors may be neglected, leading to erroneous predictions. This approach is often useful in the early stages of an analysis or design effort, and is always useful to validate more detailed analyses. 2. Represent all existing physical behaviors in the mathematical model and obtain a computational solution. In this case, mathematical approximations and/or algorithm shortcomings may yield errors in predictions. The optimal approach often lies somewhere between these two bounds, and can usually be identified based on good engineering judgement and experience.

11 ME 475: Computer-Aided Design of Structures 1-11 When used correctly, present day computational methods and software can often produce solutions that are at least as accurate as the input data (material properties, loads, constraints, etc.). In other words, there is often at least as much error in the specification of the problem data as there is in the numerical solution of the differential equations. Nevertheless, only those features and phenomena deemed important should be included in a given model.

12 ME 475: Computer-Aided Design of Structures What is the Finite Element Method? Basic Steps: 1. Break up (discretize) the mathematical domain into many simple domains. element node A mesh of 3-noded triangular elements 2. Develop element equations that approximately describe the phenomena occurring within each element. The element equations are based on spatial approximations of the field variables (e.g., displacements or temperatures) within each element. These approximation functions are almost always polynomials. The resulting element equations are algebraic equations.

13 ME 475: Computer-Aided Design of Structures Enforce continuity of the solution across element boundaries, apply boundary conditions, and solve. 4. Check the accuracy of the solution. Both validation and convergence should be evaluated. These will be discussed in greater detail later in the course. Most physical phenomena can be well described by differential equations. These equations can be very difficult to solve, especially for problems with complex domains, loading or material properties. ** The essence of the finite element method (FEM) is to approximate the solution to differential equations by replacing them with a set of easily solvable algebraic equations based on subdomain (element) approximations. Thus, a differential equation that is difficult to solve is converted into a set of algebraic equations that are easily solved. The equations for each element are coupled to those equations in adjacent elements by enforcing continuity of the primary DOFs at the nodes. Thus a global system of equations is obtained that describes the solution in the entire domain. These equations relate generalized nodal displacements {U} to generalized nodal forces {F} through the equations [K]{U}={F}, where [K] is called the stiffness matrix.

14 ME 475: Computer-Aided Design of Structures Geometrical Representation, Discretization and Typical Finite Elements Physical systems and structures are three-dimensional. However, for a given problem classification, the associated governing differential equations may be onedimensional, two-dimensional or three-dimensional. The particular form and dimensionality of the governing differential equations depends upon the assumptions about how the system or structure will behave. ** Since the finite element method provides approximate solutions to these differential equations, the dimensionality of the computational domain will be the same as that of the mathematical domain over which the differential equations are defined. Example: In an axisymmetric problem, the geometry, material properties and boundary conditions do not vary in the circumferential direction. Hence, the solution of interest does not vary in the circumferential direction (as long as the problem is linear). So the three-dimensional problem can be reduced to two dimensions in the r-z plane. The corresponding differential equations are two-dimensional, as is the computational domain.

15 ME 475: Computer-Aided Design of Structures 1-15 θ r z a. Three-dimensional physical domain of a cylinder. θ r z b. Two-dimensional computational domain of the axisymmetric problem.

16 ME 475: Computer-Aided Design of Structures 1-16 Example: A beam with a complex cross-section may be subjected to a threedimensional loading state. Nevertheless, the overall beam behavior is usually predicted well using beam theory, which is described using onedimensional (ordinary) differential equations. So the three-dimensional problem can be reduced to a one-dimensional problem. The corresponding differential equations are one-dimensional, as is the computational domain. y x z a. Three-dimensional physical domain of the beam. x b. One-dimensional computational domain.

17 ME 475: Computer-Aided Design of Structures One-dimensional elements two-noded linear element three-noded quadratic element Two-dimensional elements three-noded linear triangle six-noded quadratic triangle four-noded bilinear quadrilateral eight-noded biquadratic quadrilateral

18 ME 475: Computer-Aided Design of Structures Three-dimensional elements four-noded linear tetrahedral ten-noded quadratic tetrahedral six-noded linear wedge fifteen-noded quadratic wedge eight-noded tri-linear hexahedral (brick) twenty-noded tri-quadratic hexahedral

19 ME 475: Computer-Aided Design of Structures Solution Validation Effective and responsible use of computational methods, such as the finite element method, requires a thorough understanding of the physical nature of the problem being solved, the mathematical description of the problem, and the nature or behavior of the computational algorithms and approximations. Without this knowledge, one often cannot create a suitable model or evaluate the quality of the results. Finite element results must always be validated against some other form of solution: analytical experimental computational

20 ME 475: Computer-Aided Design of Structures 1-20 The solution used for validation should be independent of the finite element solution being validated. For example, a re-solution of the problem using a modified or refined mesh is good practice, but does not constitute a proper solution for validation. If a finite element solution is used to validate another finite element solution, then the two models should be created independently, and the solutions should ideally be obtained using different codes, in case one of them is erroneous.

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Finite Element Method. Chapter 7. Practical considerations in FEM modeling

Finite Element Method. Chapter 7. Practical considerations in FEM modeling Finite Element Method Chapter 7 Practical considerations in FEM modeling Finite Element Modeling General Consideration The following are some of the difficult tasks (or decisions) that face the engineer

More information

COMPUTER AIDED ENGINEERING. Part-1

COMPUTER AIDED ENGINEERING. Part-1 COMPUTER AIDED ENGINEERING Course no. 7962 Finite Element Modelling and Simulation Finite Element Modelling and Simulation Part-1 Modeling & Simulation System A system exists and operates in time and space.

More information

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis

Module 1: Introduction to Finite Element Analysis. Lecture 4: Steps in Finite Element Analysis 25 Module 1: Introduction to Finite Element Analysis Lecture 4: Steps in Finite Element Analysis 1.4.1 Loading Conditions There are multiple loading conditions which may be applied to a system. The load

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 3, 2017, Lesson 1 1 Politecnico di Milano, February 3, 2017, Lesson 1 2 Outline

More information

Using three-dimensional CURVIC contact models to predict stress concentration effects in an axisymmetric model

Using three-dimensional CURVIC contact models to predict stress concentration effects in an axisymmetric model Boundary Elements XXVII 245 Using three-dimensional CURVIC contact models to predict stress concentration effects in an axisymmetric model J. J. Rencis & S. R. Pisani Department of Mechanical Engineering,

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 36 In last class, we have derived element equations for two d elasticity problems

More information

CAD - How Computer Can Aid Design?

CAD - How Computer Can Aid Design? CAD - How Computer Can Aid Design? Automating Drawing Generation Creating an Accurate 3D Model to Better Represent the Design and Allowing Easy Design Improvements Evaluating How Good is the Design and

More information

CHAPTER 8 FINITE ELEMENT ANALYSIS

CHAPTER 8 FINITE ELEMENT ANALYSIS If you have any questions about this tutorial, feel free to contact Wenjin Tao (w.tao@mst.edu). CHAPTER 8 FINITE ELEMENT ANALYSIS Finite Element Analysis (FEA) is a practical application of the Finite

More information

Element Order: Element order refers to the interpolation of an element s nodal results to the interior of the element. This determines how results can

Element Order: Element order refers to the interpolation of an element s nodal results to the interior of the element. This determines how results can TIPS www.ansys.belcan.com 鲁班人 (http://www.lubanren.com/weblog/) Picking an Element Type For Structural Analysis: by Paul Dufour Picking an element type from the large library of elements in ANSYS can be

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

Chapter 7 Practical Considerations in Modeling. Chapter 7 Practical Considerations in Modeling

Chapter 7 Practical Considerations in Modeling. Chapter 7 Practical Considerations in Modeling CIVL 7/8117 1/43 Chapter 7 Learning Objectives To present concepts that should be considered when modeling for a situation by the finite element method, such as aspect ratio, symmetry, natural subdivisions,

More information

ECE421: Electronics for Instrumentation

ECE421: Electronics for Instrumentation ECE421: Electronics for Instrumentation Lecture #8: Introduction to FEA & ANSYS Mostafa Soliman, Ph.D. March 23 rd 2015 Mostafa Soliman, Ph.D. 1 Outline Introduction to Finite Element Analysis Introduction

More information

CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING

CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING 113 CHAPTER 6 EXPERIMENTAL AND FINITE ELEMENT SIMULATION STUDIES OF SUPERPLASTIC BOX FORMING 6.1 INTRODUCTION Superplastic properties are exhibited only under a narrow range of strain rates. Hence, it

More information

Guidelines for proper use of Plate elements

Guidelines for proper use of Plate elements Guidelines for proper use of Plate elements In structural analysis using finite element method, the analysis model is created by dividing the entire structure into finite elements. This procedure is known

More information

Revised Sheet Metal Simulation, J.E. Akin, Rice University

Revised Sheet Metal Simulation, J.E. Akin, Rice University Revised Sheet Metal Simulation, J.E. Akin, Rice University A SolidWorks simulation tutorial is just intended to illustrate where to find various icons that you would need in a real engineering analysis.

More information

Generative Part Structural Analysis Fundamentals

Generative Part Structural Analysis Fundamentals CATIA V5 Training Foils Generative Part Structural Analysis Fundamentals Version 5 Release 19 September 2008 EDU_CAT_EN_GPF_FI_V5R19 About this course Objectives of the course Upon completion of this course

More information

ANSYS Element. elearning. Peter Barrett October CAE Associates Inc. and ANSYS Inc. All rights reserved.

ANSYS Element. elearning. Peter Barrett October CAE Associates Inc. and ANSYS Inc. All rights reserved. ANSYS Element Selection elearning Peter Barrett October 2012 2012 CAE Associates Inc. and ANSYS Inc. All rights reserved. ANSYS Element Selection What is the best element type(s) for my analysis? Best

More information

FEM Convergence Requirements

FEM Convergence Requirements 19 FEM Convergence Requirements IFEM Ch 19 Slide 1 Convergence Requirements for Finite Element Discretization Convergence: discrete (FEM) solution approaches the analytical (math model) solution in some

More information

Some Aspects for the Simulation of a Non-Linear Problem with Plasticity and Contact

Some Aspects for the Simulation of a Non-Linear Problem with Plasticity and Contact Some Aspects for the Simulation of a Non-Linear Problem with Plasticity and Contact Eduardo Luís Gaertner Marcos Giovani Dropa de Bortoli EMBRACO S.A. Abstract A linear elastic model is often not appropriate

More information

ME 345: Modeling & Simulation. Introduction to Finite Element Method

ME 345: Modeling & Simulation. Introduction to Finite Element Method ME 345: Modeling & Simulation Introduction to Finite Element Method Examples Aircraft 2D plate Crashworthiness 2 Human Heart Gears Structure Human Spine 3 F.T. Fisher, PhD Dissertation, 2002 Fluid Flow

More information

CHAPTER 5 FINITE ELEMENT METHOD

CHAPTER 5 FINITE ELEMENT METHOD CHAPTER 5 FINITE ELEMENT METHOD 5.1 Introduction to Finite Element Method Finite element analysis is a computer based numerical method to deduce engineering structures strength and behaviour. Its use can

More information

Finite Element Modeling Techniques (2) دانشگاه صنعتي اصفهان- دانشكده مكانيك

Finite Element Modeling Techniques (2) دانشگاه صنعتي اصفهان- دانشكده مكانيك Finite Element Modeling Techniques (2) 1 Where Finer Meshes Should be Used GEOMETRY MODELLING 2 GEOMETRY MODELLING Reduction of a complex geometry to a manageable one. 3D? 2D? 1D? Combination? Bulky solids

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

Types of Idealizations. Idealizations. Cylindrical Shaped Part. Cyclic Symmetry. 3D Shell Model. Axisymmetric

Types of Idealizations. Idealizations. Cylindrical Shaped Part. Cyclic Symmetry. 3D Shell Model. Axisymmetric Types of Idealizations Idealizations Selecting the model type 3D Solid Plane Stress Plane Strain 3D Shell Beam Cyclic Symmetry Cylindrical Shaped Part Interior Pressure Load 3D model can be used to model

More information

Computational methods - modelling and simulation

Computational methods - modelling and simulation Computational methods - modelling and simulation J. Pamin With thanks to: Authors of presented simulations C.A. Felippa (Univ. of Colorado at Boulder) www.colorado.edu/engineering/cas/courses.d/ifem.d

More information

Introduction to the Finite Element Method (3)

Introduction to the Finite Element Method (3) Introduction to the Finite Element Method (3) Petr Kabele Czech Technical University in Prague Faculty of Civil Engineering Czech Republic petr.kabele@fsv.cvut.cz people.fsv.cvut.cz/~pkabele 1 Outline

More information

Study of Convergence of Results in Finite Element Analysis of a Plane Stress Bracket

Study of Convergence of Results in Finite Element Analysis of a Plane Stress Bracket RESEARCH ARTICLE OPEN ACCESS Study of Convergence of Results in Finite Element Analysis of a Plane Stress Bracket Gowtham K L*, Shivashankar R. Srivatsa** *(Department of Mechanical Engineering, B. M.

More information

Modelling Flat Spring Performance Using FEA

Modelling Flat Spring Performance Using FEA Modelling Flat Spring Performance Using FEA Blessing O Fatola, Patrick Keogh and Ben Hicks Department of Mechanical Engineering, University of Corresponding author bf223@bath.ac.uk Abstract. This paper

More information

MEAM 550 Modeling and Design of MEMS Spring Solution to homework #3. In our notation and values, k = = =

MEAM 550 Modeling and Design of MEMS Spring Solution to homework #3. In our notation and values, k = = = MEAM 550 Modeling and Design of MEMS Spring 004 Solution to homework # Problem 1 A fixed-guided beam (length = l, width = b, depth = h ) with a transverse tip load of F has the following formulas for maximum

More information

Set No. 1 IV B.Tech. I Semester Regular Examinations, November 2010 FINITE ELEMENT METHODS (Mechanical Engineering) Time: 3 Hours Max Marks: 80 Answer any FIVE Questions All Questions carry equal marks

More information

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 11 Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 2.3.1 Choice of Displacement Function Displacement function is the beginning point for the structural

More information

The Finite Element Method

The Finite Element Method The Finite Element Method A Practical Course G. R. Liu and S. S. Quek Chapter 1: Computational modeling An overview 1 CONTENTS INTRODUCTION PHYSICAL PROBLEMS IN ENGINEERING COMPUTATIONAL MODELLING USING

More information

Introduction to FEM Modeling

Introduction to FEM Modeling Total Analysis Solution for Multi-disciplinary Optimum Design Apoorv Sharma midas NFX CAE Consultant 1 1. Introduction 2. Element Types 3. Sample Exercise: 1D Modeling 4. Meshing Tools 5. Loads and Boundary

More information

CHAPTER 4. Numerical Models. descriptions of the boundary conditions, element types, validation, and the force

CHAPTER 4. Numerical Models. descriptions of the boundary conditions, element types, validation, and the force CHAPTER 4 Numerical Models This chapter presents the development of numerical models for sandwich beams/plates subjected to four-point bending and the hydromat test system. Detailed descriptions of the

More information

NX Advanced FEM. fact sheet

NX Advanced FEM. fact sheet Advanced FEM fact sheet www.ugs.com Summary Advanced FEM is a comprehensive multi-cad finite element modeling and results visualization product that is designed to meet the needs of experienced CAE analysts.

More information

Chapter 1 Introduction

Chapter 1 Introduction Chapter 1 Introduction GTU Paper Analysis (New Syllabus) Sr. No. Questions 26/10/16 11/05/16 09/05/16 08/12/15 Theory 1. What is graphic standard? Explain different CAD standards. 2. Write Bresenham s

More information

Efficient Shape Optimisation of an Aircraft Landing Gear Door Locking Mechanism by Coupling Abaqus to GENESIS

Efficient Shape Optimisation of an Aircraft Landing Gear Door Locking Mechanism by Coupling Abaqus to GENESIS Efficient Shape Optimisation of an Aircraft Landing Gear Door Locking Mechanism by Coupling Abaqus to GENESIS Mark Arnold and Martin Gambling Penso Consulting Ltd GRM Consulting Ltd Abstract: The objective

More information

Introduction to Finite Element Analysis using ANSYS

Introduction to Finite Element Analysis using ANSYS Introduction to Finite Element Analysis using ANSYS Sasi Kumar Tippabhotla PhD Candidate Xtreme Photovoltaics (XPV) Lab EPD, SUTD Disclaimer: The material and simulations (using Ansys student version)

More information

Embedded Reinforcements

Embedded Reinforcements Embedded Reinforcements Gerd-Jan Schreppers, January 2015 Abstract: This paper explains the concept and application of embedded reinforcements in DIANA. Basic assumptions and definitions, the pre-processing

More information

MATLAB. Advanced Mathematics and Mechanics Applications Using. Third Edition. David Halpern University of Alabama CHAPMAN & HALL/CRC

MATLAB. Advanced Mathematics and Mechanics Applications Using. Third Edition. David Halpern University of Alabama CHAPMAN & HALL/CRC Advanced Mathematics and Mechanics Applications Using MATLAB Third Edition Howard B. Wilson University of Alabama Louis H. Turcotte Rose-Hulman Institute of Technology David Halpern University of Alabama

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Step Change in Design: Exploring Sixty Stent Design Variations Overnight

Step Change in Design: Exploring Sixty Stent Design Variations Overnight Step Change in Design: Exploring Sixty Stent Design Variations Overnight Frank Harewood, Ronan Thornton Medtronic Ireland (Galway) Parkmore Business Park West, Ballybrit, Galway, Ireland frank.harewood@medtronic.com

More information

Lecture 3 : General Preprocessing. Introduction to ANSYS Mechanical Release ANSYS, Inc. February 27, 2015

Lecture 3 : General Preprocessing. Introduction to ANSYS Mechanical Release ANSYS, Inc. February 27, 2015 Lecture 3 : General Preprocessing 16.0 Release Introduction to ANSYS Mechanical 1 2015 ANSYS, Inc. February 27, 2015 Chapter Overview In this chapter we cover basic preprocessing operations that are common

More information

CITY AND GUILDS 9210 UNIT 135 MECHANICS OF SOLIDS Level 6 TUTORIAL 15 - FINITE ELEMENT ANALYSIS - PART 1

CITY AND GUILDS 9210 UNIT 135 MECHANICS OF SOLIDS Level 6 TUTORIAL 15 - FINITE ELEMENT ANALYSIS - PART 1 Outcome 1 The learner can: CITY AND GUILDS 9210 UNIT 135 MECHANICS OF SOLIDS Level 6 TUTORIAL 15 - FINITE ELEMENT ANALYSIS - PART 1 Calculate stresses, strain and deflections in a range of components under

More information

CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS

CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS 54 CHAPTER 4 CFD AND FEA ANALYSIS OF DEEP DRAWING PROCESS 4.1 INTRODUCTION In Fluid assisted deep drawing process the punch moves in the fluid chamber, the pressure is generated in the fluid. This fluid

More information

NX Advanced FEM. Benefits

NX Advanced FEM. Benefits Advanced FEM fact sheet Siemens PLM Software www.siemens.com/plm Summary Advanced FEM software is a comprehensive multi-cad finite element modeling and results visualization product that is designed to

More information

Computational methods - modelling and simulation

Computational methods - modelling and simulation Computational methods - modelling and simulation J. Pamin Institute for Computational Civil Engineering Civil Engineering Department, Cracow University of Technology URL: www.l5.pk.edu.pl Lecture contents

More information

CHAPTER 5 USE OF STL FILE FOR FINITE ELEMENT ANALYSIS

CHAPTER 5 USE OF STL FILE FOR FINITE ELEMENT ANALYSIS CHAPTER 5 USE OF STL FILE FOR FINITE ELEMENT ANALYSIS 5.1 Introduction: Most CAD software in the market can generate STL files, and these are generally used for prototyping and rendering purposes. These

More information

Computer Life (CPL) ISSN: Finite Element Analysis of Bearing Box on SolidWorks

Computer Life (CPL) ISSN: Finite Element Analysis of Bearing Box on SolidWorks Computer Life (CPL) ISSN: 1819-4818 Delivering Quality Science to the World Finite Element Analysis of Bearing Box on SolidWorks Chenling Zheng 1, a, Hang Li 1, b and Jianyong Li 1, c 1 Shandong University

More information

Calculate a solution using the pressure-based coupled solver.

Calculate a solution using the pressure-based coupled solver. Tutorial 19. Modeling Cavitation Introduction This tutorial examines the pressure-driven cavitating flow of water through a sharpedged orifice. This is a typical configuration in fuel injectors, and brings

More information

Purdue e-pubs. Purdue University. Jeongil Park Samsung Electronics Co. Nasir Bilal Purdue University. Douglas E. Adams Purdue University

Purdue e-pubs. Purdue University. Jeongil Park Samsung Electronics Co. Nasir Bilal Purdue University. Douglas E. Adams Purdue University Purdue University Purdue e-pubs International Compressor Engineering Conference School of Mechanical Engineering 26 Development of a Two-Dimensional Finite Element Model of a Suction Valve for Reduction

More information

An explicit feature control approach in structural topology optimization

An explicit feature control approach in structural topology optimization th World Congress on Structural and Multidisciplinary Optimisation 07 th -2 th, June 205, Sydney Australia An explicit feature control approach in structural topology optimization Weisheng Zhang, Xu Guo

More information

Using MSC.Nastran for Explicit FEM Simulations

Using MSC.Nastran for Explicit FEM Simulations 3. LS-DYNA Anwenderforum, Bamberg 2004 CAE / IT III Using MSC.Nastran for Explicit FEM Simulations Patrick Doelfs, Dr. Ingo Neubauer MSC.Software GmbH, D-81829 München, Patrick.Doelfs@mscsoftware.com Abstract:

More information

NUMERICAL ANALYSIS OF ENGINEERING STRUCTURES (LINEAR ELASTICITY AND THE FINITE ELEMENT METHOD)

NUMERICAL ANALYSIS OF ENGINEERING STRUCTURES (LINEAR ELASTICITY AND THE FINITE ELEMENT METHOD) NUMERICAL ANALYSIS OF ENGINEERING STRUCTURES (LINEAR ELASTICITY AND THE FINITE ELEMENT METHOD) NUMERICAL ANALYSIS OF ENGINEERING STRUCTURES (LINEAR ELASTICITY AND THE FINITE ELEMENT METHOD) Author: Tamás

More information

IJMH - International Journal of Management and Humanities ISSN:

IJMH - International Journal of Management and Humanities ISSN: EXPERIMENTAL STRESS ANALYSIS SPUR GEAR USING ANSYS SOFTWARE T.VADIVELU 1 (Department of Mechanical Engineering, JNTU KAKINADA, Kodad, India, vadimay28@gmail.com) Abstract Spur Gear is one of the most important

More information

AN IMPROVED METHOD TO MODEL SEMI-ELLIPTICAL SURFACE CRACKS USING ELEMENT MISMATCH IN ABAQUS

AN IMPROVED METHOD TO MODEL SEMI-ELLIPTICAL SURFACE CRACKS USING ELEMENT MISMATCH IN ABAQUS AN IMPROVED METHOD TO MODEL SEMI-ELLIPTICAL SURFACE CRACKS USING ELEMENT MISMATCH IN ABAQUS R. H. A. Latiff and F. Yusof School of Mechanical Engineering, UniversitiSains, Malaysia E-Mail: mefeizal@usm.my

More information

The part to be analyzed is the bracket from the tutorial of Chapter 3.

The part to be analyzed is the bracket from the tutorial of Chapter 3. Introduction to Solid Modeling Using SolidWorks 2007 COSMOSWorks Tutorial Page 1 In this tutorial, we will use the COSMOSWorks finite element analysis (FEA) program to analyze the response of a component

More information

Meshing of flow and heat transfer problems

Meshing of flow and heat transfer problems Meshing of flow and heat transfer problems Luyao Zou a, Zhe Li b, Qiqi Fu c and Lujie Sun d School of, Shandong University of science and technology, Shandong 266590, China. a zouluyaoxf@163.com, b 1214164853@qq.com,

More information

Finite element method - tutorial no. 1

Finite element method - tutorial no. 1 Martin NESLÁDEK Faculty of mechanical engineering, CTU in Prague 11th October 2017 1 / 22 Introduction to the tutorials E-mail: martin.nesladek@fs.cvut.cz Room no. 622 (6th floor - Dept. of mechanics,

More information

by Mahender Reddy Concept To Reality / Summer 2006

by Mahender Reddy Concept To Reality / Summer 2006 by Mahender Reddy Demand for higher extrusion rates, increased product quality and lower energy consumption have prompted plants to use various methods to determine optimum process conditions and die designs.

More information

SOLIDWORKS Simulation Avoiding Singularities

SOLIDWORKS Simulation Avoiding Singularities SOLIDWORKS Simulation Avoiding Singularities What is a Singularity? A singularity is a function s divergence into infinity. SOLIDWORKS Simulation occasionally produces stress (or heat flux) singularities.

More information

Coupled Analysis of FSI

Coupled Analysis of FSI Coupled Analysis of FSI Qin Yin Fan Oct. 11, 2008 Important Key Words Fluid Structure Interface = FSI Computational Fluid Dynamics = CFD Pressure Displacement Analysis = PDA Thermal Stress Analysis = TSA

More information

Learning Module 8 Shape Optimization

Learning Module 8 Shape Optimization Learning Module 8 Shape Optimization What is a Learning Module? Title Page Guide A Learning Module (LM) is a structured, concise, and self-sufficient learning resource. An LM provides the learner with

More information

SAMCEF for ROTORS. Chapter 3.2: Rotor modeling. This document is the property of SAMTECH S.A. MEF A, Page 1

SAMCEF for ROTORS. Chapter 3.2: Rotor modeling. This document is the property of SAMTECH S.A. MEF A, Page 1 SAMCEF for ROTORS Chapter 3.2: Rotor modeling This document is the property of SAMTECH S.A. MEF 101-03-2-A, Page 1 Table of contents Introduction Introduction 1D Model 2D Model 3D Model 1D Models: Beam-Spring-

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Stress Analysis of thick wall bellows using Finite Element Method

Stress Analysis of thick wall bellows using Finite Element Method Stress Analysis of thick wall bellows using Finite Element Method Digambar J. Pachpande Post Graduate Student Department of Mechanical Engineering V.J.T.I. Mumbai, India Prof. G. U. Tembhare Assistant

More information

Introduction to Design Optimization

Introduction to Design Optimization Introduction to Design Optimization First Edition Krishnan Suresh i Dedicated to my family. They mean the world to me. ii Origins of this Text Preface Like many other textbooks, this text has evolved from

More information

Solid and shell elements

Solid and shell elements Solid and shell elements Theodore Sussman, Ph.D. ADINA R&D, Inc, 2016 1 Overview 2D and 3D solid elements Types of elements Effects of element distortions Incompatible modes elements u/p elements for incompressible

More information

AS 5850 Finite Element Analysis

AS 5850 Finite Element Analysis AS 5850 Finite Element Analysis INTRODUCTION Prof. IIT Madras Goal of engineering computations Perform analysis and design of physical systems and processes subjected to imposed conditions (or loads) and

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

CHAPTER-10 DYNAMIC SIMULATION USING LS-DYNA

CHAPTER-10 DYNAMIC SIMULATION USING LS-DYNA DYNAMIC SIMULATION USING LS-DYNA CHAPTER-10 10.1 Introduction In the past few decades, the Finite Element Method (FEM) has been developed into a key indispensable technology in the modeling and simulation

More information

MAE Advanced Computer Aided Design. 01. Introduction Doc 02. Introduction to the FINITE ELEMENT METHOD

MAE Advanced Computer Aided Design. 01. Introduction Doc 02. Introduction to the FINITE ELEMENT METHOD MAE 656 - Advanced Computer Aided Design 01. Introduction Doc 02 Introduction to the FINITE ELEMENT METHOD The FEM is A TOOL A simulation tool The FEM is A TOOL NOT ONLY STRUCTURAL! Narrowing the problem

More information

Exercise 1. 3-Point Bending Using the GUI and the Bottom-up-Method

Exercise 1. 3-Point Bending Using the GUI and the Bottom-up-Method Exercise 1 3-Point Bending Using the GUI and the Bottom-up-Method Contents Learn how to... 1 Given... 2 Questions... 2 Taking advantage of symmetries... 2 A. Preprocessor (Setting up the Model)... 3 A.1

More information

5. Finite Element Analysis of Bellows

5. Finite Element Analysis of Bellows 5. Finite Element Analysis of Bellows 5.1 Introduction: Traditional design process and stress analysis techniques are very specific for each individual case based on fundamental principles. It can only

More information

Creo Simulate 3.0 Tutorial

Creo Simulate 3.0 Tutorial Creo Simulate 3.0 Tutorial Structure and Thermal Roger Toogood, Ph.D., P. Eng. SDC PUBLICATIONS Better Textbooks. Lower Prices. www.sdcpublications.com Powered by TCPDF (www.tcpdf.org) Visit the following

More information

Common Mistakes And Errors In Modelling

Common Mistakes And Errors In Modelling Common Mistakes And Errors In Modelling The modeling pitfalls listed below can be considered as appetizers with the intention of making you think (and worry) more about the model set-up. More in-depth

More information

3D Finite Element Software for Cracks. Version 3.2. Benchmarks and Validation

3D Finite Element Software for Cracks. Version 3.2. Benchmarks and Validation 3D Finite Element Software for Cracks Version 3.2 Benchmarks and Validation October 217 1965 57 th Court North, Suite 1 Boulder, CO 831 Main: (33) 415-1475 www.questintegrity.com http://www.questintegrity.com/software-products/feacrack

More information

Method of Finite Elements I

Method of Finite Elements I Institute of Structural Engineering Page 1 Held by Prof. Dr. E. Chatzi, Dr. P. Steffen Assistants: Adrian Egger (HIL E 13.3), Harry Mylonas (HIL H33.1), Konstantinos Tatsis (HIL H33.1) Lectures homepage:

More information

Stress Concentration Factors

Stress Concentration Factors CONSEIL INTERNATIONAL DES MACHINES A COMBUSTION INTERNATIONAL COUNCIL ON COMBUSTION ENGINES CO-ORDINATING WORKING GROUP "CLASSIFICATION SOCIETIES DIESEL" (WG2) Proposal by CIMAC WG4 11th May 2012 IACS

More information

Offshore Platform Fluid Structure Interaction (FSI) Simulation

Offshore Platform Fluid Structure Interaction (FSI) Simulation Offshore Platform Fluid Structure Interaction (FSI) Simulation Ali Marzaban, CD-adapco Murthy Lakshmiraju, CD-adapco Nigel Richardson, CD-adapco Mike Henneke, CD-adapco Guangyu Wu, Chevron Pedro M. Vargas,

More information

Executive Summary Sefea Basic Theory

Executive Summary Sefea Basic Theory Executive Summary Sefea is one of the newest generations of enriched finite element methods. Developed specifically for low-order 4-node tetrahedron and 3-node triangle in the CAE environment, Sefea achieves

More information

ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis

ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis R50 ANSYS 5.6 Tutorials Lecture # 2 - Static Structural Analysis Example 1 Static Analysis of a Bracket 1. Problem Description: The objective of the problem is to demonstrate the basic ANSYS procedures

More information

Exercise 2: Mesh Resolution, Element Shapes, Basis Functions & Convergence Analyses

Exercise 2: Mesh Resolution, Element Shapes, Basis Functions & Convergence Analyses Exercise 2: Mesh Resolution, Element Shapes, Basis Functions & Convergence Analyses Goals In this exercise, we will explore the strengths and weaknesses of different element types (tetrahedrons vs. hexahedrons,

More information

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering Introduction A SolidWorks simulation tutorial is just intended to illustrate where to

More information

Introduction to 2 nd -order Lagrangian Element in LS-DYNA

Introduction to 2 nd -order Lagrangian Element in LS-DYNA Introduction to 2 nd -order Lagrangian Element in LS-DYNA Hailong Teng Livermore Software Technology Corporation Nov, 2017 Motivation Users are requesting higher order elements for implicit. Replace shells.

More information

computational Fluid Dynamics - Prof. V. Esfahanian

computational Fluid Dynamics - Prof. V. Esfahanian Three boards categories: Experimental Theoretical Computational Crucial to know all three: Each has their advantages and disadvantages. Require validation and verification. School of Mechanical Engineering

More information

FEM Modeling: Mesh, Loads

FEM Modeling: Mesh, Loads 8 FEM Modeling: Mesh, Loads and BCs IFEM Ch 8 Slide 1 Topics in Chapter 8 General Modeling Rules Finite Element Mesh Layouts Distributed Loads Displacement BCs suppressing rigid body motions taking advantage

More information

CHAPTER 7 BEHAVIOUR OF THE COMBINED EFFECT OF ROOFING ELEMENTS

CHAPTER 7 BEHAVIOUR OF THE COMBINED EFFECT OF ROOFING ELEMENTS CHAPTER 7 BEHAVIOUR OF THE COMBINED EFFECT OF ROOFING ELEMENTS 7.1 GENERAL An analytical study on behaviour of combined effect of optimised channel sections using ANSYS was carried out and discussed in

More information

ME 475 FEA of a Composite Panel

ME 475 FEA of a Composite Panel ME 475 FEA of a Composite Panel Objectives: To determine the deflection and stress state of a composite panel subjected to asymmetric loading. Introduction: Composite laminates are composed of thin layers

More information

THREE DIMENSIONAL DYNAMIC STRESS ANALYSES FOR A GEAR TEETH USING FINITE ELEMENT METHOD

THREE DIMENSIONAL DYNAMIC STRESS ANALYSES FOR A GEAR TEETH USING FINITE ELEMENT METHOD THREE DIMENSIONAL DYNAMIC STRESS ANALYSES FOR A GEAR TEETH USING FINITE ELEMENT METHOD Haval Kamal Asker Department of Mechanical Engineering, Faculty of Agriculture and Forestry, Duhok University, Duhok,

More information

11.1 Optimization Approaches

11.1 Optimization Approaches 328 11.1 Optimization Approaches There are four techniques to employ optimization of optical structures with optical performance constraints: Level 1 is characterized by manual iteration to improve the

More information

course outline basic principles of numerical analysis, intro FEM

course outline basic principles of numerical analysis, intro FEM idealization, equilibrium, solutions, interpretation of results types of numerical engineering problems continuous vs discrete systems direct stiffness approach differential & variational formulation introduction

More information

Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA

Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA 14 th International LS-DYNA Users Conference Session: Simulation Recent Advances on Higher Order 27-node Hexahedral Element in LS-DYNA Hailong Teng Livermore Software Technology Corp. Abstract This paper

More information

Analysis of Distortion Parameters of Eight node Serendipity Element on the Elements Performance

Analysis of Distortion Parameters of Eight node Serendipity Element on the Elements Performance Analysis of Distortion Parameters of Eight node Serendipity Element on the Elements Performance Vishal Jagota & A. P. S. Sethi Department of Mechanical Engineering, Shoolini University, Solan (HP), India

More information

A Multiple Constraint Approach for Finite Element Analysis of Moment Frames with Radius-cut RBS Connections

A Multiple Constraint Approach for Finite Element Analysis of Moment Frames with Radius-cut RBS Connections A Multiple Constraint Approach for Finite Element Analysis of Moment Frames with Radius-cut RBS Connections Dawit Hailu +, Adil Zekaria ++, Samuel Kinde +++ ABSTRACT After the 1994 Northridge earthquake

More information

midas FEA V320 Table of Contents

midas FEA V320 Table of Contents midas FEA V320 New Feature 01 CFD Moving Mesh Pre Process 01 File Open > File Preview 02 Extract Surface 03 Frame to Solid > Import 04 Tetra Auto mesh generation 05 Mesh options 06 Auto mesh Solid Function

More information

LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence

LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence Allen T. Li 1, Zhe Cui 2, Yun Huang 2 1 Ford Motor Company 2 Livermore Software Technology Corporation Abstract This paper continues

More information

Engineering Analysis

Engineering Analysis Engineering Analysis with SOLIDWORKS Simulation 2018 Paul M. Kurowski SDC PUBLICATIONS Better Textbooks. Lower Prices. www.sdcpublications.com Powered by TCPDF (www.tcpdf.org) Visit the following websites

More information

MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING

MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING Mesh independence and convergence test in the oil film characteristics MESH INDEPENDENCE AND CONVERGENCE TEST IN THE OIL FILM CHARACTERISTICS OF A TILTING PAD THRUST BEARING D.V.Srikanth a, K.K.Chaturvedi

More information