A Basic Primer on the Finite Element Method

Size: px
Start display at page:

Download "A Basic Primer on the Finite Element Method"

Transcription

1 A Basic Primer on the Finite Element Method C. Berdin A. Rossoll March 1st Purpose Complex geometry and/or boundary conditions Local solution Non-linearities: geometric (large deformations/displacements) material (e.g. elastic-plastic behaviour) Certain coupled problems (e.g. thermo-mechanical) 2 Principle 2.1 Definitions Discretization: continuous problem = finite number of variables (degrees of freedom "DOF"). Put into an algebraic form: = system of equations Rate of convergence towards the "exact" solution as a function of the "cost": "exact" solution cost (number of elements, of DOFs) Laboratoire de Mécanique des Sols, Structures et Matériaux, École Centrale de Paris. Laboratoire de Métallurgie Mécanique, Institut des Matériaux, École Polytechnique Fédérale de Lausanne. 1

2 2.2 Analysis of a problem in solid mechanics σ F, u Solid of volume, of surface S, with behaviour σ, under the effect of imposed volume forces f, surface tractions F and displacements u f S We want to obtain σ (and other variables) at each point of a solid for a given load and boundary conditions. = finite element method Linear problem linear geometry and material (σ = D ) Derivation from the principle of virtual work or (here) from the potential energy (attention with the notation: is used both for the potential and the volume.) (u) minimum = δ =0. (u) = 1 2 T σ(u) (u) d T FudS T fud (1) S where T σ(u) = T (u) D. D = D(E,ν) for a linear elastic material. 1. Discretization of the geometry and the displacement fields approximation by subdomains, definition of the elements e : (u) = e e (u) (2) The geometry and the displacement fields are interpolated from the element nodes. e.g. elements of the "solid" type in two dimensions: 2

3 triangle quadrangle linear interpolation quadratic linear interpolation quadratic In the case of an isoparametric element, the interpolation functions are identical for the coordinates and the displacements. Given, at each point of an element e : x e = n N e n X e n u e = n N e n q e n () where N n q e n u e x e X e n interpolation function, for a given element type nodal displacements of an element e displacements of a point in an element e coordinates of a point in an element e nodal coordinates of an element e Relations between the different variables of an element e, where B e is deduced from N e by derivation: u e = N e q e = B e q e σ = D For the potential energy of an element e one obtains: e = 1 T q e T B e DB e q e d T FN e q e ds T fn e q e d (4) 2 e S e e Integration: introduction of a reference element and Gaussian integration: e.g. in two dimensions: f(ξ,η) dξdη = i f(ξ i,η j )w i w j j for 4 integration points: w i,w j =(± 1 ; ± 1 )

4 ( 1, 1) η (1, 1) ξ ( 1, 1) (1, 1) nodal variables u and F integration point variables and σ 2. Assembling determination of the nodal displacements q that minimize the potential energy: δ dq =0= T BDBqd T FNdS T fnd =0 (5) S with T BDB= K one obtains the "fundamental" equation of the finite element method: Kq= Φ (6) where K is the stiffness matrix and Φ the generalized force vector. Global resolution = resolution of a system of N linear equations with N unknowns (the degrees of freedom) Non-linear problem Each load step (e.g. 1st step: cooling from processing temperature; 2nd step: mechanical loading) is divided into several increments; for each load increment, equilibrium is established iteratively. For each increment and each iteration, one tries to satisfy equilibrium following Eq. (??), here in generalized form: Φ int Φ ext = 0 where Φ int is the internal force vector and Φ ext the external force vector. However, in the general case, a residual force R remains. The equation then takes the form Φ int Φ ext = R (7) In a succession of iterations, one tries to reduce R till a very small tolerance (R 0). La procedure is shown in the following scheme: 4

5 Scheme of the convergence path for a problem with a single DOF: P exernal P i 1 P final Ri 2 P i R 1 i equilibrium path P 2 P 1 u 1 u 2 u i 1 u 1 i u 1 i u 2 i u i = u i u u 2 i u i At the end of the 1st iteration of the increment i, a residual R 1 i remains. At the 2nd iteration during the same increment, the residual is R 2 i etc. The Newtonian scheme guarantees quadratic convergence. Thus R decreases with each iteration by two orders of magnitude. 5

6 Element types for modelling solids plane strain axisymmetric plane stress plane stress: thin structures ("membranes"), (generalized) plane strain): thick structures, axisymmetric, -D. 6

7 4 Problem definition with the program ABAQUS Input file: extension.inp. A single asterisk (*) at the beginning of the line: key word & options, Two asterisks (**) or more: comments. The entries are made on the line below the key word in fields separated by commas. The input file is read and interpreted by the program ("pre-processing"). The extraction of the output variables is called "post-processing". Examples of some key words: Geometry nodal coordinates incremental node generation node set element definitions incremental element generation element sets definition of a solid, consisting of an element set and a material Material definition of the physical properties of a material elastic (plastic) properties) Boundary conditions nodes that remain blocked during an analysis Initial conditions Loading beginning of a load step solution type NLGEOM (non-linear geometry) imposed displacements (boundary conditions) imposed nodal tractions (concentrated load) imposed (distributed load) tracking of a nodal displacement (DOF...degree of freedom) output of nodal (element) variables in the.dat file in the.fil file in the.odb file writing of a restart (.res) file end of a load step *NODE *NGEN (*NFILL) *NSET,NSET= *ELEMENT,TYPE= *ELGEN *ELSET,ELSET= *SOLID SECTION,ELSET=,MATERIAL= *MATERIAL,NAME= *ELASTIC (*PLASTIC) *BOUNDARY *INITIAL CONDITIONS,TYPE= *STEP *STATIC(,NLGEOM) *BOUNDARY *CLOAD *DLOAD *MONITOR,NODE=,DOF= *NODE (*ELEMENT) PRINT,FREQ= *NODE (*ELEMENT) FILE,FREQ= *OUTPUT, HISTORY, FREQ= *NODE (*ELEMENT) OUTPUT *RESTART,WRITE,FREQUENCY= *END STEP 7

8 5 File extensions in the program ABAQUS.cae Abaqus/CAE input file ("Complete Abaqus Environment").com command informations on the system environment and operating system (UNIX).dat data informations from pre-processing (check of the user input) and possibly results output in text format (ASCII).f FORTRAN listing of a FORTRAN subroutine.fil file output file (normally in binary format; access with Abaqus/Post).inp input problem definition.jnl journal contains commands for automatic post-processing.msg message follow-up of the force residuals.odb output database output file (access with Abaqus/iewer or CAE).ps postscript postscript results file.res restart contains the informations necessary for a restart and for plotting the model, the deformed shape and contour plots.sta status monitoring of a DOF, increments and iterations 8

Stress analysis of a stepped bar

Stress analysis of a stepped bar Stress analysis of a stepped bar Problem Find the stresses induced in the axially loaded stepped bar shown in Figure. The bar has cross-sectional areas of A ) and A ) over the lengths l ) and l ), respectively.

More information

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM B Course Content: A INTRODUCTION AND OVERVIEW Numerical method and Computer-Aided Engineering; Phsical problems; Mathematical models; Finite element method;. B Elements and nodes, natural coordinates,

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

JEPPIAAR ENGINEERING COLLEGE

JEPPIAAR ENGINEERING COLLEGE JEPPIAAR ENGINEERING COLLEGE Jeppiaar Nagar, Rajiv Gandhi Salai 600 119 DEPARTMENT OFMECHANICAL ENGINEERING QUESTION BANK VI SEMESTER ME6603 FINITE ELEMENT ANALYSIS Regulation 013 SUBJECT YEAR /SEM: III

More information

PLAXIS. Scientific Manual

PLAXIS. Scientific Manual PLAXIS Scientific Manual 2016 Build 8122 TABLE OF CONTENTS TABLE OF CONTENTS 1 Introduction 5 2 Deformation theory 7 2.1 Basic equations of continuum deformation 7 2.2 Finite element discretisation 8 2.3

More information

The Finite Element Method for Solid and Structural Mechanics

The Finite Element Method for Solid and Structural Mechanics The Finite Element Method for Solid and Structural Mechanics Sixth edition O.C. Zienkiewicz, CBE, FRS UNESCO Professor of Numerical Methods in Engineering International Centre for Numerical Methods in

More information

Eshan V. Dave, Secretary of M&FGM2006 (Hawaii) Research Assistant and Ph.D. Candidate. Glaucio H. Paulino, Chairman of M&FGM2006 (Hawaii)

Eshan V. Dave, Secretary of M&FGM2006 (Hawaii) Research Assistant and Ph.D. Candidate. Glaucio H. Paulino, Chairman of M&FGM2006 (Hawaii) Asphalt Pavement Aging and Temperature Dependent Properties through a Functionally Graded Viscoelastic Model I: Development, Implementation and Verification Eshan V. Dave, Secretary of M&FGM2006 (Hawaii)

More information

Non-linear and time-dependent material models in Mentat & MARC. Tutorial with Background and Exercises

Non-linear and time-dependent material models in Mentat & MARC. Tutorial with Background and Exercises Non-linear and time-dependent material models in Mentat & MARC Tutorial with Background and Exercises Eindhoven University of Technology Department of Mechanical Engineering Piet Schreurs July 7, 2009

More information

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup,

Using MATLAB and. Abaqus. Finite Element Analysis. Introduction to. Amar Khennane. Taylor & Francis Croup. Taylor & Francis Croup, Introduction to Finite Element Analysis Using MATLAB and Abaqus Amar Khennane Taylor & Francis Croup Boca Raton London New York CRC Press is an imprint of the Taylor & Francis Croup, an informa business

More information

Theoretical Manual Theoretical background to the Strand7 finite element analysis system

Theoretical Manual Theoretical background to the Strand7 finite element analysis system Theoretical Manual Theoretical background to the Strand7 finite element analysis system Edition 1 January 2005 Strand7 Release 2.3 2004-2005 Strand7 Pty Limited All rights reserved Contents Preface Chapter

More information

Finite Element Method

Finite Element Method Finite Element Method Finite Element Method (ENGC 6321) Syllabus Objectives Understand the basic theory of the FEM Know the behaviour and usage of each type of elements covered in this course one dimensional

More information

An Evaluation of Simplified Methods to Compute the Mechanical Steady State

An Evaluation of Simplified Methods to Compute the Mechanical Steady State An Evaluation of Simplified Methods to Compute the Mechanical Steady State T. Herbland a,b, G. Cailletaud a, S. Quilici a, H. Jaffal b, M. Afzali b a Mines Paris Paris Tech, CNRS UMR 7633, BP 87, 91003

More information

1 Nonlinear deformation

1 Nonlinear deformation NONLINEAR TRUSS 1 Nonlinear deformation When deformation and/or rotation of the truss are large, various strains and stresses can be defined and related by material laws. The material behavior can be expected

More information

Code No: RT41033 R13 Set No. 1 IV B.Tech I Semester Regular Examinations, November - 2016 FINITE ELEMENT METHODS (Common to Mechanical Engineering, Aeronautical Engineering and Automobile Engineering)

More information

Chapter 5 Structural Elements: The truss & beam elements

Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 1 Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 2 Chapter Goals Learn how to formulate the Finite Element Equations

More information

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Journal of Computational and Applied Mechanics, Vol.., No. 1., (2005), pp. 83 94 BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Vladimír Kutiš and Justín Murín Department

More information

Structural Analysis of Truss Structures using Stiffness Matrix. Dr. Nasrellah Hassan Ahmed

Structural Analysis of Truss Structures using Stiffness Matrix. Dr. Nasrellah Hassan Ahmed Structural Analysis of Truss Structures using Stiffness Matrix Dr. Nasrellah Hassan Ahmed FUNDAMENTAL RELATIONSHIPS FOR STRUCTURAL ANALYSIS In general, there are three types of relationships: Equilibrium

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

CAEFEM v9.5 Information

CAEFEM v9.5 Information CAEFEM v9.5 Information Concurrent Analysis Corporation, 50 Via Ricardo, Thousand Oaks, CA 91320 USA Tel. (805) 375 1060, Fax (805) 375 1061 email: info@caefem.com or support@caefem.com Web: http://www.caefem.com

More information

An example of panel solution in the elastic-plastic regime

An example of panel solution in the elastic-plastic regime An example of panel solution in the elastic-plastic regime Piotr Mika May, 2014 2013-05-08 1. Example solution of the panel with ABAQUS program The purpose is to analyze the elastic-plastic panel. The

More information

Course in. Geometric nonlinearity. Nonlinear FEM. Computational Mechanics, AAU, Esbjerg

Course in. Geometric nonlinearity. Nonlinear FEM. Computational Mechanics, AAU, Esbjerg Course in Nonlinear FEM Geometric nonlinearity Nonlinear FEM Outline Lecture 1 Introduction Lecture 2 Geometric nonlinearity Lecture 3 Material nonlinearity Lecture 4 Material nonlinearity it continued

More information

Finite Element Method in Geotechnical Engineering

Finite Element Method in Geotechnical Engineering Finite Element Method in Geotechnical Engineering Short Course on + Dynamics Boulder, Colorado January 5-8, 2004 Stein Sture Professor of Civil Engineering University of Colorado at Boulder Contents Steps

More information

3. Overview of MSC/NASTRAN

3. Overview of MSC/NASTRAN 3. Overview of MSC/NASTRAN MSC/NASTRAN is a general purpose finite element analysis program used in the field of static, dynamic, nonlinear, thermal, and optimization and is a FORTRAN program containing

More information

The following syntax is used to describe a typical irreducible continuum element:

The following syntax is used to describe a typical irreducible continuum element: ELEMENT IRREDUCIBLE T7P0 command.. Synopsis The ELEMENT IRREDUCIBLE T7P0 command is used to describe all irreducible 7-node enhanced quadratic triangular continuum elements that are to be used in mechanical

More information

. D CR Nomenclature D 1

. D CR Nomenclature D 1 . D CR Nomenclature D 1 Appendix D: CR NOMENCLATURE D 2 The notation used by different investigators working in CR formulations has not coalesced, since the topic is in flux. This Appendix identifies the

More information

Nonlinear bending analysis of laminated composite stiffened plates

Nonlinear bending analysis of laminated composite stiffened plates Nonlinear bending analysis of laminated composite stiffened plates * S.N.Patel 1) 1) Dept. of Civi Engineering, BITS Pilani, Pilani Campus, Pilani-333031, (Raj), India 1) shuvendu@pilani.bits-pilani.ac.in

More information

Dynamic Analysis in FEMAP. May 24 th, presented by Philippe Tremblay Marc Lafontaine

Dynamic Analysis in FEMAP. May 24 th, presented by Philippe Tremblay Marc Lafontaine Dynamic Analysis in FEMAP presented by Philippe Tremblay Marc Lafontaine marc.lafontaine@mayasim.com 514-951-3429 date May 24 th, 2016 Agenda NX Nastran Transient, frequency response, random, response

More information

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES A Thesis by WOORAM KIM Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the

More information

GEO E1050 Finite Element Method Autumn Lecture. 9. Nonlinear Finite Element Method & Summary

GEO E1050 Finite Element Method Autumn Lecture. 9. Nonlinear Finite Element Method & Summary GEO E1050 Finite Element Method Autumn 2016 Lecture. 9. Nonlinear Finite Element Method & Summary To learn today The lecture should give you overview of how non-linear problems in Finite Element Method

More information

D && 9.0 DYNAMIC ANALYSIS

D && 9.0 DYNAMIC ANALYSIS 9.0 DYNAMIC ANALYSIS Introduction When a structure has a loading which varies with time, it is reasonable to assume its response will also vary with time. In such cases, a dynamic analysis may have to

More information

Nonlinear analysis in ADINA Structures

Nonlinear analysis in ADINA Structures Nonlinear analysis in ADINA Structures Theodore Sussman, Ph.D. ADINA R&D, Inc, 2016 1 Topics presented Types of nonlinearities Materially nonlinear only Geometrically nonlinear analysis Deformation-dependent

More information

Fig. 1. Circular fiber and interphase between the fiber and the matrix.

Fig. 1. Circular fiber and interphase between the fiber and the matrix. Finite element unit cell model based on ABAQUS for fiber reinforced composites Tian Tang Composites Manufacturing & Simulation Center, Purdue University West Lafayette, IN 47906 1. Problem Statement In

More information

An example solution of a panel in the elastic-plastic regime

An example solution of a panel in the elastic-plastic regime An example solution of a panel in the elastic-plastic regime Piotr Mika May, 2013 1. Example solution of the panel with ABAQUS program The purpose is to analyze an elastic-plastic panel. The elastic solution

More information

ELASTOPLASTIC STEEL BEAM BENDING ANALYSIS BY USING ABAQUS

ELASTOPLASTIC STEEL BEAM BENDING ANALYSIS BY USING ABAQUS 11 ELASTOPLASTIC STEEL BEAM BENDING ANALYSIS BY USING ABAQUS Biswajit Jena * * Corresponding author: biswa.tech88@gmail.com Abstract: In recent years tremendous efforts have been made in development of

More information

Computational Materials Modeling FHLN05 Computer lab

Computational Materials Modeling FHLN05 Computer lab Motivation Computational Materials Modeling FHLN05 Computer lab In the basic Finite Element (FE) course, the analysis is restricted to materials where the relationship between stress and strain is linear.

More information

Post Graduate Diploma in Mechanical Engineering Computational mechanics using finite element method

Post Graduate Diploma in Mechanical Engineering Computational mechanics using finite element method 9210-220 Post Graduate Diploma in Mechanical Engineering Computational mechanics using finite element method You should have the following for this examination one answer book scientific calculator No

More information

Solution Manual A First Course in the Finite Element Method 5th Edition Logan

Solution Manual A First Course in the Finite Element Method 5th Edition Logan Solution Manual A First Course in the Finite Element Method 5th Edition Logan Instant download and all chapters Solution Manual A First Course in the Finite Element Method 5th Edition Logan https://testbandata.com/download/solution-manual-first-course-finite-elementmethod-5th-edition-logan/

More information

NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS

NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS IGC 009, Guntur, INDIA NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS Mohammed Younus Ahmed Graduate Student, Earthquake Engineering Research Center, IIIT Hyderabad, Gachibowli, Hyderabad 3, India.

More information

ENGN 2290: Plasticity Computational plasticity in Abaqus

ENGN 2290: Plasticity Computational plasticity in Abaqus ENGN 229: Plasticity Computational plasticity in Abaqus The purpose of these exercises is to build a familiarity with using user-material subroutines (UMATs) in Abaqus/Standard. Abaqus/Standard is a finite-element

More information

Chapter 3 Variational Formulation & the Galerkin Method

Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 1 Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 2 Today s Lecture Contents: Introduction Differential formulation

More information

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

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 06 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 06 In the last lecture, we have seen a boundary value problem, using the formal

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Lecture 15: Revisiting bars and beams.

Lecture 15: Revisiting bars and beams. 3.10 Potential Energy Approach to Derive Bar Element Equations. We place assumptions on the stresses developed inside the bar. The spatial stress and strain matrices become very sparse. We add (ad-hoc)

More information

A two-dimensional FE truss program

A two-dimensional FE truss program A two-dimensional FE truss program 4M020: Design Tools Eindhoven University of Technology Introduction The Matlab program fem2d allows to model and analyze two-dimensional truss structures, where trusses

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

More information

POST-BUCKLING BEHAVIOUR OF IMPERFECT SLENDER WEB

POST-BUCKLING BEHAVIOUR OF IMPERFECT SLENDER WEB Engineering MECHANICS, Vol. 14, 007, No. 6, p. 43 49 43 POST-BUCKLING BEHAVIOUR OF IMPERFECT SLENDER WEB Martin Psotný, Ján Ravinger* The stability analysis of slender web loaded in compression is presented.

More information

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen Steps in the Finite Element Method Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen General Idea Engineers are interested in evaluating effects such as deformations, stresses,

More information

EML4507 Finite Element Analysis and Design EXAM 1

EML4507 Finite Element Analysis and Design EXAM 1 2-17-15 Name (underline last name): EML4507 Finite Element Analysis and Design EXAM 1 In this exam you may not use any materials except a pencil or a pen, an 8.5x11 formula sheet, and a calculator. Whenever

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

More information

Composite FEM Lab-work

Composite FEM Lab-work Composite FEM Lab-work You may perform these exercises in groups of max 2 persons. You may also between exercise 5 and 6. Be critical on the results obtained! Exercise 1. Open the file exercise1.inp in

More information

Direct calculation of critical points in parameter sensitive systems

Direct calculation of critical points in parameter sensitive systems Direct calculation of critical points in parameter sensitive systems Behrang Moghaddasie a, Ilinca Stanciulescu b, a Department of Civil Engineering, Ferdowsi University of Mashhad, P.O. Box 91775-1111,

More information

Computational Inelasticity FHLN05. Assignment A non-linear elasto-plastic problem

Computational Inelasticity FHLN05. Assignment A non-linear elasto-plastic problem Computational Inelasticity FHLN05 Assignment 2017 A non-linear elasto-plastic problem General instructions A written report should be submitted to the Division of Solid Mechanics no later than October

More information

ENGN2340 Final Project: Implementation of a Euler-Bernuolli Beam Element Michael Monn

ENGN2340 Final Project: Implementation of a Euler-Bernuolli Beam Element Michael Monn ENGN234 Final Project: Implementation of a Euler-Bernuolli Beam Element Michael Monn 12/11/13 Problem Definition and Shape Functions Although there exist many analytical solutions to the Euler-Bernuolli

More information

NEW QUADRANGULAR SHELL ELEMENT IN SAFIR

NEW QUADRANGULAR SHELL ELEMENT IN SAFIR NEW QUADRANGULAR SHELL ELEMENT IN SAFIR Didier TALAMONA Jean-Marc FRANSSEN Univ. of Liège, SPEC, Chemin des Chevreuils, 4000 Liège, Belgium d.talamona@ulg.ac.be jm.franssen@ulg.ac.be Abstract SAFIR is

More information

Chapter 11 Three-Dimensional Stress Analysis. Chapter 11 Three-Dimensional Stress Analysis

Chapter 11 Three-Dimensional Stress Analysis. Chapter 11 Three-Dimensional Stress Analysis CIVL 7/87 Chapter - /39 Chapter Learning Objectives To introduce concepts of three-dimensional stress and strain. To develop the tetrahedral solid-element stiffness matri. To describe how bod and surface

More information

Lecture 21: Isoparametric Formulation of Plane Elements.

Lecture 21: Isoparametric Formulation of Plane Elements. 6.6. Rectangular Plane Stress/Strain Element. he CS element uses a triangular shape. he 3 nodes of the CS element allow us to employ linear multivariate approximations to the u and v displacements. he

More information

Settlement and Bearing Capacity of a Strip Footing. Nonlinear Analyses

Settlement and Bearing Capacity of a Strip Footing. Nonlinear Analyses Settlement and Bearing Capacity of a Strip Footing Nonlinear Analyses Outline 1 Description 2 Nonlinear Drained Analysis 2.1 Overview 2.2 Properties 2.3 Loads 2.4 Analysis Commands 2.5 Results 3 Nonlinear

More information

Biomechanics. Soft Tissue Biomechanics

Biomechanics. Soft Tissue Biomechanics Biomechanics cross-bridges 3-D myocardium ventricles circulation Image Research Machines plc R* off k n k b Ca 2+ 0 R off Ca 2+ * k on R* on g f Ca 2+ R0 on Ca 2+ g Ca 2+ A* 1 A0 1 Ca 2+ Myofilament kinetic

More information

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS The Q4 element has four nodes and eight nodal dof. The shape can be any quadrilateral; we ll concentrate on a rectangle now. The displacement field in terms

More information

Nonlinear Modeling for Health Care Applications Ashutosh Srivastava Marc Horner, Ph.D. ANSYS, Inc.

Nonlinear Modeling for Health Care Applications Ashutosh Srivastava Marc Horner, Ph.D. ANSYS, Inc. Nonlinear Modeling for Health Care Applications Ashutosh Srivastava Marc Horner, Ph.D. ANSYS, Inc. 2 Motivation 12 Motivation Linear analysis works well for only small number of applications. The majority

More information

GEOMETRIC NONLINEAR ANALYSIS

GEOMETRIC NONLINEAR ANALYSIS GEOMETRIC NONLINEAR ANALYSIS The approach for solving problems with geometric nonlinearity is presented. The ESAComp solution relies on Elmer open-source computational tool [1] for multiphysics problems.

More information

Shape Function Generation and Requirements

Shape Function Generation and Requirements Shape Function Generation and Requirements Requirements Requirements (A) Interpolation condition. Takes a unit value at node i, and is zero at all other nodes. Requirements (B) Local support condition.

More information

MODELLING MIXED-MODE RATE-DEPENDENT DELAMINATION IN LAYERED STRUCTURES USING GEOMETRICALLY NONLINEAR BEAM FINITE ELEMENTS

MODELLING MIXED-MODE RATE-DEPENDENT DELAMINATION IN LAYERED STRUCTURES USING GEOMETRICALLY NONLINEAR BEAM FINITE ELEMENTS PROCEEDINGS Proceedings of the 25 th UKACM Conference on Computational Mechanics 12-13 April 217, University of Birmingham Birmingham, United Kingdom MODELLING MIXED-MODE RATE-DEPENDENT DELAMINATION IN

More information

University of Groningen

University of Groningen University of Groningen Nature-inspired microfluidic propulsion using magnetic actuation Khaderi, S. N.; Baltussen, M. G. H. M.; Anderson, P. D.; Ioan, D.; den Toonder, J.M.J.; Onck, Patrick Published

More information

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

Analysis of a portal steel frame subject to fire by use of a truss model

Analysis of a portal steel frame subject to fire by use of a truss model Analysis of a portal steel frame subject to fire by use of a truss model P. G. Papadopoulos & A. Mathiopoulou Department of Civil Engineering, Aristotle University of Thessaloniki, Greece Abstract A plane

More information

Analytical formulation of Modified Upper Bound theorem

Analytical formulation of Modified Upper Bound theorem CHAPTER 3 Analytical formulation of Modified Upper Bound theorem 3.1 Introduction In the mathematical theory of elasticity, the principles of minimum potential energy and minimum complimentary energy are

More information

Linear Static Analysis of a Simply-Supported Truss (SI)

Linear Static Analysis of a Simply-Supported Truss (SI) APPENDIX C Linear Static Analysis of a Simply-Supported Truss (SI) Objectives: Create a MSC.Nastran model comprised of CROD elements. Prepare a MSC.Nastran input file for a Linear Static analysis. Visualize

More information

As an example, the two-bar truss structure, shown in the figure below will be modelled, loaded and analyzed.

As an example, the two-bar truss structure, shown in the figure below will be modelled, loaded and analyzed. Program tr2d 1 FE program tr2d The Matlab program tr2d allows to model and analyze two-dimensional truss structures, where trusses are homogeneous and can behave nonlinear. Deformation and rotations can

More information

Lecture 2: Finite Elements

Lecture 2: Finite Elements Materials Science & Metallurgy Master of Philosophy, Materials Modelling, Course MP7, Finite Element Analysis, H. K. D. H. Bhadeshia Lecture 2: Finite Elements In finite element analysis, functions of

More information

Abstract. 1 Introduction

Abstract. 1 Introduction Contact analysis for the modelling of anchors in concrete structures H. Walter*, L. Baillet** & M. Brunet* *Laboratoire de Mecanique des Solides **Laboratoire de Mecanique des Contacts-CNRS UMR 5514 Institut

More information

Using Energy History Data to Obtain Load vs. Deflection Curves from Quasi-Static Abaqus/Explicit Analyses

Using Energy History Data to Obtain Load vs. Deflection Curves from Quasi-Static Abaqus/Explicit Analyses Using Energy History Data to Obtain Load vs. Deflection Curves from Quasi-Static Abaqus/Explicit Analyses Brian Baillargeon, Ramesh Marrey, Randy Grishaber 1, and David B. Woyak 2 1 Cordis Corporation,

More information

COUPLED FINITE-INFINITE ELEMENTS MODELING OF BUILDING FRAME-SOIL INTERACTION SYSTEM

COUPLED FINITE-INFINITE ELEMENTS MODELING OF BUILDING FRAME-SOIL INTERACTION SYSTEM VOL. 4, NO. 10, DECEMBER 009 SSN 1819-6608 006-009 Asian Research Publishing Network (ARPN. All rights reserved. COUPLED FNTE-NFNTE ELEMENTS MODELNG OF BULDNG FRAME-SOL NTERACTON SYSTEM Ramakant Agrawal

More information

BECAS - an Open-Source Cross Section Analysis Tool

BECAS - an Open-Source Cross Section Analysis Tool BECAS - an Open-Source Cross Section Analysis Tool José P. Blasques and Robert D. Bitsche Presented at DTU Wind Energy stand at the EWEA 2012 conference, Copenhagen, 16.4.2012 BECAS-DTUWind@dtu.dk Motivation

More information

Introduction to Finite Element computations

Introduction to Finite Element computations Non Linear Computational Mechanics Athens MP06/2012 Introduction to Finite Element computations Vincent Chiaruttini, Georges Cailletaud vincent.chiaruttini@onera.fr Outline Continuous to discrete problem

More information

MSC Nastran N is for NonLinear as in SOL400. Shekhar Kanetkar, PhD

MSC Nastran N is for NonLinear as in SOL400. Shekhar Kanetkar, PhD MSC Nastran N is for NonLinear as in SOL400 Shekhar Kanetkar, PhD AGENDA What is SOL400? Types of Nonlinearities Contact Defining Contact Moving Rigid Bodies Friction in Contact S2S Contact CASI Solver

More information

Contact analysis - theory and concepts

Contact analysis - theory and concepts Contact analysis - theory and concepts Theodore Sussman, Ph.D. ADINA R&D, Inc, 2016 1 Overview Review of contact concepts segments, surfaces, groups, pairs Interaction of contactor nodes and target segments

More information

Chapter 6 2D Elements Plate Elements

Chapter 6 2D Elements Plate Elements Institute of Structural Engineering Page 1 Chapter 6 2D Elements Plate Elements Method of Finite Elements I Institute of Structural Engineering Page 2 Continuum Elements Plane Stress Plane Strain Toda

More information

MECh300H Introduction to Finite Element Methods. Finite Element Analysis (F.E.A.) of 1-D Problems

MECh300H Introduction to Finite Element Methods. Finite Element Analysis (F.E.A.) of 1-D Problems MECh300H Introduction to Finite Element Methods Finite Element Analysis (F.E.A.) of -D Problems Historical Background Hrenikoff, 94 frame work method Courant, 943 piecewise polynomial interpolation Turner,

More information

Interval Finite Element Methods for Uncertainty Treatment in Structural Engineering Mechanics Rafi L. Muhanna Georgia Institute of Technology USA

Interval Finite Element Methods for Uncertainty Treatment in Structural Engineering Mechanics Rafi L. Muhanna Georgia Institute of Technology USA Interval Finite Element Methods for Uncertainty Treatment in Structural Engineering Mechanics Rafi L. Muhanna Georgia Institute of Technology USA Second Scandinavian Workshop on INTERVAL METHODS AND THEIR

More information

A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE AND MOVING-POLE APPROACHES IN STATIC AND DYNAMIC ANALYSIS OF NON-LINEAR SPATIAL BEAM STRUCTURES

A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE AND MOVING-POLE APPROACHES IN STATIC AND DYNAMIC ANALYSIS OF NON-LINEAR SPATIAL BEAM STRUCTURES European Congress on Computational Methods in Applied Sciences and Engineering (ECCOMAS 212) J. Eberhardsteiner et.al. (eds.) Vienna, Austria, September 1-14, 212 A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE

More information

FEA A Guide to Good Practice. What to expect when you re expecting FEA A guide to good practice

FEA A Guide to Good Practice. What to expect when you re expecting FEA A guide to good practice FEA A Guide to Good Practice What to expect when you re expecting FEA A guide to good practice 1. Background Finite Element Analysis (FEA) has transformed design procedures for engineers. Allowing more

More information

Finite Elements for Thermal Analysis

Finite Elements for Thermal Analysis Chapter 4 Finite Elements for Thermal Analysis 4.1 Governing Equations for the Thermal Problem CONSTITUTIVE EQUATIONS Introducing the temperature field T(x i,t ), the heat flux vector q(x i,t) q n (x i,t)

More information

BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I

BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I BHAR AT HID AS AN ENGIN E ERI N G C O L L E G E NATTR A MPA LL I 635 8 54. Third Year M E C H A NICAL VI S E M ES TER QUE S T I ON B ANK Subject: ME 6 603 FIN I T E E LE ME N T A N A L YSIS UNI T - I INTRODUCTION

More information

Leaf Spring (Material, Contact, geometric nonlinearity)

Leaf Spring (Material, Contact, geometric nonlinearity) 00 Summary Summary Nonlinear Static Analysis - Unit: N, mm - Geometric model: Leaf Spring.x_t Leaf Spring (Material, Contact, geometric nonlinearity) Nonlinear Material configuration - Stress - Strain

More information

midas Civil Dynamic Analysis

midas Civil Dynamic Analysis Edgar De Los Santos Midas IT August 23 rd 2017 Contents: Introduction Eigen Value Analysis Response Spectrum Analysis Pushover Analysis Time History Analysis Seismic Analysis Seismic Analysis The seismic

More information

Plane and axisymmetric models in Mentat & MARC. Tutorial with some Background

Plane and axisymmetric models in Mentat & MARC. Tutorial with some Background Plane and axisymmetric models in Mentat & MARC Tutorial with some Background Eindhoven University of Technology Department of Mechanical Engineering Piet J.G. Schreurs Lambèrt C.A. van Breemen March 6,

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

ENGN 2340 Final Project Report. Optimization of Mechanical Isotropy of Soft Network Material

ENGN 2340 Final Project Report. Optimization of Mechanical Isotropy of Soft Network Material ENGN 2340 Final Project Report Optimization of Mechanical Isotropy of Soft Network Material Enrui Zhang 12/15/2017 1. Introduction of the Problem This project deals with the stress-strain response of a

More information

Cable Tension APPENDIX D. Objectives: Demonstrate the use of elastic-plastic material properties. Create an enforced displacement on the model.

Cable Tension APPENDIX D. Objectives: Demonstrate the use of elastic-plastic material properties. Create an enforced displacement on the model. APPENDIX D Cable Tension Objectives: Demonstrate the use of elastic-plastic material properties. Create an enforced displacement on the model. Run an MSC.Nastran nonlinear static analysis. Create an accurate

More information

Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method

Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method 9210-203 Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method You should have the following for this examination one answer book No additional data is attached

More information

Using Thermal Boundary Conditions in SOLIDWORKS Simulation to Simulate a Press Fit Connection

Using Thermal Boundary Conditions in SOLIDWORKS Simulation to Simulate a Press Fit Connection Using Thermal Boundary Conditions in SOLIDWORKS Simulation to Simulate a Press Fit Connection Simulating a press fit condition in SOLIDWORKS Simulation can be very challenging when there is a large amount

More information

CRITERIA FOR SELECTION OF FEM MODELS.

CRITERIA FOR SELECTION OF FEM MODELS. CRITERIA FOR SELECTION OF FEM MODELS. Prof. P. C.Vasani,Applied Mechanics Department, L. D. College of Engineering,Ahmedabad- 380015 Ph.(079) 7486320 [R] E-mail:pcv-im@eth.net 1. Criteria for Convergence.

More information

Methods of Analysis. Force or Flexibility Method

Methods of Analysis. Force or Flexibility Method INTRODUCTION: The structural analysis is a mathematical process by which the response of a structure to specified loads is determined. This response is measured by determining the internal forces or stresses

More information

Finite Element Modeling and Analysis. CE 595: Course Part 2 Amit H. Varma

Finite Element Modeling and Analysis. CE 595: Course Part 2 Amit H. Varma Finite Element Modeling and Analysis CE 595: Course Part 2 Amit H. Varma Discussion of planar elements Constant Strain Triangle (CST) - easiest and simplest finite element Displacement field in terms of

More information

University of Sheffield The development of finite elements for 3D structural analysis in fire

University of Sheffield The development of finite elements for 3D structural analysis in fire The development of finite elements for 3D structural analysis in fire Chaoming Yu, I. W. Burgess, Z. Huang, R. J. Plank Department of Civil and Structural Engineering StiFF 05/09/2006 3D composite structures

More information

Code_Aster. SSNP161 Biaxial tests of Kupfer

Code_Aster. SSNP161 Biaxial tests of Kupfer Titre : SSNP161 Essais biaxiaux de Kupfer Date : 10/10/2012 Page : 1/8 SSNP161 Biaxial tests of Kupfer Summary: Kupfer [1] is interested to characterize the performances of the concrete under biaxial loadings.

More information

Development of discontinuous Galerkin method for linear strain gradient elasticity

Development of discontinuous Galerkin method for linear strain gradient elasticity Development of discontinuous Galerkin method for linear strain gradient elasticity R Bala Chandran Computation for Design and Optimizaton Massachusetts Institute of Technology Cambridge, MA L. Noels* Aerospace

More information

An Energy Dissipative Constitutive Model for Multi-Surface Interfaces at Weld Defect Sites in Ultrasonic Consolidation

An Energy Dissipative Constitutive Model for Multi-Surface Interfaces at Weld Defect Sites in Ultrasonic Consolidation An Energy Dissipative Constitutive Model for Multi-Surface Interfaces at Weld Defect Sites in Ultrasonic Consolidation Nachiket Patil, Deepankar Pal and Brent E. Stucker Industrial Engineering, University

More information