ENGN 2290: Plasticity Computational plasticity in Abaqus

Size: px
Start display at page:

Download "ENGN 2290: Plasticity Computational plasticity in Abaqus"

Transcription

1 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 program which implicitly solves the equations of equilibrium. Briefly, consider the strong form of the boundary-value problem on a domain : σ ij +b i = i in, σ ij n j = t i on t, u i = û i on u, where t and u are complementary subsurfaces of the surface ( t u =, t u = ), b i is the externally-applied body force, t i is the externally-applied surface traction on t, and û i are the prescribed displacements on u. We recast the strong form in the weak form by introducing a vectorial test function w i and writing ( σij +b i ) w i dv = for all test functions w i. Following standard arguments, we have ( ) ( ) σij (σij w i ) w i +b i w i dv = σ ij +b i w i dv (product rule) w i = σ ij w i n j da σ ij dv+ b i w i dv (divergence theorem) = =, t i w i da σ ij w i dv + b i w i dv (traction condition) which gives the weak form of the boundary-value problem w i σ ij dv = t i w i da+ b i w i dv. (1) In the finite-element method, the domain is approximated using finite elements, = e. The nodal solution variables are the displacements, which are interpolated inside each element by u i = u A i NA, (2) with the index A = 1,2,... denoting the nodes of the element, u A i the nodal displacements, and N A the shape functions. In a Galerkin approach, the test functions are interpolated by the same shape functions w i = w A i NA. () 1

2 Using (2) and () in (1), we obtain the following element-level system of equations: e N A σ ij dv = t i N A da+ b i N A dv. e e Abaqus/Standard solves this system of equations interactively using a Newton-Raphson procedure by defining the following residuals, e Ru A N A i = σ ij dv+ t i N A da+ b i N A dv, e e and using the corresponding tangents, K AB u i u k = RA u i u B k = e N A σ ij ǫ kl N B x l dv, where we have assumed that the traction and body force are fixed. The task of a UMAT is to calculate the stress σ ij and material tangent σ ij / ǫ ij at a given time so that Abaqus/ Standard may perform its Newton-Raphson iteration. For the time-discrete version of elastoplasticity, this amounts to calculating the stress σ n+1, updating internal variables, and calculating the algorithmically-consistent tangent C alg = σ n+1 / ǫ n+1 at a time t n+1. We undertook these tasks on the first exam for three-dimensional, small-deformation, rate-independent plasticity with isotropic hardening and a summary of these algorithms are included at the end of this document. Posted on Canvas, you will find a UMAT corresponding to this model with Vocé-type isotropic hardening, umat iso plasticity.for. The UMAT is written for three-dimensional and plane-strain problems; it is not intended for plane stress problems. There are also five input files, which you may use to familiarize yourself with the capability of the code. It is easiest to submit jobs using subroutines using the Abaqus Command interface. The command for submitting an Abaqus job is abaqus double inp=input filename.inp user=umat filename.for j=jobname inter 1. The first exercise is for simple shear of a single element, one shear.inp. The input file is set up to perform five load/unload cycles. Using this input file and the hardening parameters Y = 1 MPa, H = 125 MPa, and Y s = 25 MPa, calculate and plot the shear stress/strain relation, σ 2 versus γ 2. Your result should look like the following: 15 1 σ2 (MPa) γ 2 2

3 2. It is always good practice to exercise your code using a multi-element calculation involving inhomogeneous deformation. Such a calculation often exposes bugs not evident in a single element simulation. For this purpose, see the input file CurvedBar.inp. A schematic of this problem is shown below: Undeformed mesh Deformed mesh Moved face Fixed face The input file is set up to displace the surface denoted as the moved face above in the 2-direction through three cycles. Such a loading involves bending and torsion in different parts of the bar. The calculation result of the load applied to the face versus the displacement of the face in the 2-direction is shown below: 5 x 14 Force (N) Displacement (m). The next exercise involves tension/compression of a single element in the 1-direction, one ten.inp. In this input file, you may also specify a lateral normal stress σ 22. Consider a perfectly-plastic material, Y = 1 MPa, H = MPa, and Y s = 1 MPa. You may specify a value for the lateral normal stress σ 22 in the range from Y to Y and subsequently deform the element in tension or compression in the 1-direction. The value of σ 11 obtained from the calculation result then defines a point (σ 11,σ 22 ) in a plane-stress projection of stress space. Following this procedure, map out the plane-stress projection of the Mises yield surface. Your result should look like the following:

4 1.5 σ2/y σ 1 /Y 4. Next, consider the problem of plane-strain pure bending of a beam of thickness t, beam.inp. The input file is set up to impose a constant curvature deformation to the beam. Generate a plot of the the applied moment versus the bending angle. (The bending angle is simply the curvature times the length of the beam.) Your result should look like the following: 25 Moment (N-m) Angle (radians) The fully-plastic moment for a perfectly-plastic material in plane-strain is M p = 1 2 t2 Y, denoted as the dotted line above. Indeed, the calculated fully-plastic moment matches the analytical expression. 5. Finally, let us once again consider the problem of Hill indentation, HillIndent.inp. This input file is set up to perform plane-strain flat punch indentation of a perfectlyplastic material. (a) Verify that the calculated collapse load matches the analytical result of slip line theory P = kw(2+π). (b) In the *solid section command, change the material from the user material mat1 to built-in Abaqus perfect plasticity mat2, and verify that the result is the same. Open the.sta files for both jobs and compare the respective performances of the two calculations. 4

5 A plot of normalized indenter force P/kW versus the indent depth for both cases is given below: P/kW 2 UMAT plasticity 1 Abaqus plasticity Analytical solution Indent depth (m) The result of the UMAT is indistinguishable from the result of built-in Abaqus plasticity. Both calculation results asymptote to the analytical solution. 5

6 Summary of the constitutive equations for three-dimensional, small-deformation rate-independent plasticity with isotropic hardening 1. Kinematics: For small deformations, the strain is additively decomposed into elastic and plastic parts ǫ = ǫ e +ǫ p, with trǫ p = due to plastic incompressibility. 2. Elastic stress-strain relationship: The stress is given by σ = C[ǫ ǫ p ], where the fourth-order elasticity tensor, C, for an isotropic material given by C ijkl = G(δ ik δ jl +δ il δ jk )+ (K 2 ) G δ ij δ kl, with G and K denoting the shear and bulk moduli, respectively. The equivalent tensile stress (Mises stress) is then σ = 2 σ.. Flow rule: The evolution of ǫ p is given by ǫ p = 2 ǫ p N p, N p = σ 2 σ, ǫ p = 2 ǫp. 4. Flow strength: We introduce a stress-dimensioned flow strength with Y = Y( ǫ p ), Y() = Y, ǫ p (t) = t ǫ p (ζ)dζ denoting the equivalent tensile accumulated plastic strain. 5. Yield function: We introduce the yield function, defined as f = σ Y( ǫ p ). 6. Kuhn-Tucker complementary conditions: The values of the yield function f and ǫ p are constrained by f, ǫ p, f ǫ p =. 7. Consistency condition: The consistency condition, ǫ p f = when f =, determines the magnitude of ǫ p whenever it is non-zero. 6

7 Summary of the implicit time-integration procedure for three-dimensional, rate-independent plasticity with isotropic hardening Problem: Given: {ǫ n,ǫ p n, ǫ p n} at time t n, as well as ǫ n+1 at time t n+1 = t n + t Calculate: {σ n+1,ǫ p n+1, ǫp n+1 } 1. Calculate trial quantities σ tr = C[ǫ n+1 ǫ p n ], σ tr = 2 σ tr,, N p σ tr, tr =, 2 σ tr f tr = σ tr Y( ǫ p n). 2. Determine whether the step is elastic or plastic. if f tr then elastic step else plastic step end if. Elastic step: Plastic step: Solve σ n+1 = σ tr, ǫ p n+1 = ǫ p n, and ǫ p n+1 = ǫ p n, g( ǫ p ) = σ tr G ǫ p Y( ǫ p n + ǫp ) = for ǫ p and update σ n+1 = σ tr 6G ǫ p N p tr, ǫ p n+1 = ǫ p n + /2 ǫ p N p tr, ǫ p n+1 = ǫ p n + ǫp. 7

8 Algorithmically consistent tangent if f tr then elastic step C alg = C else plastic step end if C alg = C where 6G 2 G+H( ǫ p n+1) Np tr N p tr ǫ p6g2 σ tr (I N p tr N p tr) H( ǫ p n+1) = dy( ǫp ) d ǫ p ǫ p = ǫ p n+1 8

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

DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS

DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS Mohsen Safaei, Wim De Waele Ghent University, Laboratory Soete, Belgium Abstract The present work relates to the

More information

Lecture 15 Strain and stress in beams

Lecture 15 Strain and stress in beams Spring, 2019 ME 323 Mechanics of Materials Lecture 15 Strain and stress in beams Reading assignment: 6.1 6.2 News: Instructor: Prof. Marcial Gonzalez Last modified: 1/6/19 9:42:38 PM Beam theory (@ ME

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 2018 A non-linear elasto-plastic problem General instructions A written report should be submitted to the Division of Solid Mechanics no later than November

More information

MODELING OF ELASTO-PLASTIC MATERIALS IN FINITE ELEMENT METHOD

MODELING OF ELASTO-PLASTIC MATERIALS IN FINITE ELEMENT METHOD MODELING OF ELASTO-PLASTIC MATERIALS IN FINITE ELEMENT METHOD Andrzej Skrzat, Rzeszow University of Technology, Powst. Warszawy 8, Rzeszow, Poland Abstract: User-defined material models which can be used

More information

Mechanics PhD Preliminary Spring 2017

Mechanics PhD Preliminary Spring 2017 Mechanics PhD Preliminary Spring 2017 1. (10 points) Consider a body Ω that is assembled by gluing together two separate bodies along a flat interface. The normal vector to the interface is given by n

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

Lecture #6: 3D Rate-independent Plasticity (cont.) Pressure-dependent plasticity

Lecture #6: 3D Rate-independent Plasticity (cont.) Pressure-dependent plasticity Lecture #6: 3D Rate-independent Plasticity (cont.) Pressure-dependent plasticity by Borja Erice and Dirk Mohr ETH Zurich, Department of Mechanical and Process Engineering, Chair of Computational Modeling

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

HÅLLFASTHETSLÄRA, LTH Examination in computational materials modeling

HÅLLFASTHETSLÄRA, LTH Examination in computational materials modeling HÅLLFASTHETSLÄRA, LTH Examination in computational materials modeling TID: 2016-28-10, kl 14.00-19.00 Maximalt 60 poäng kan erhållas på denna tenta. För godkänt krävs 30 poäng. Tillåtet hjälpmedel: räknare

More information

STRESS UPDATE ALGORITHM FOR NON-ASSOCIATED FLOW METAL PLASTICITY

STRESS UPDATE ALGORITHM FOR NON-ASSOCIATED FLOW METAL PLASTICITY STRESS UPDATE ALGORITHM FOR NON-ASSOCIATED FLOW METAL PLASTICITY Mohsen Safaei 1, a, Wim De Waele 1,b 1 Laboratorium Soete, Department of Mechanical Construction and Production, Ghent University, Technologiepark

More information

A short review of continuum mechanics

A short review of continuum mechanics A short review of continuum mechanics Professor Anette M. Karlsson, Department of Mechanical ngineering, UD September, 006 This is a short and arbitrary review of continuum mechanics. Most of this material

More information

MATERIAL MECHANICS, SE2126 COMPUTER LAB 2 PLASTICITY

MATERIAL MECHANICS, SE2126 COMPUTER LAB 2 PLASTICITY MATERIAL MECHANICS, SE2126 COMPUTER LAB 2 PLASTICITY PART A INTEGRATED CIRCUIT An integrated circuit can be thought of as a very complex maze of electronic components and metallic connectors. These connectors

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

Mechanical Engineering Ph.D. Preliminary Qualifying Examination Solid Mechanics February 25, 2002

Mechanical Engineering Ph.D. Preliminary Qualifying Examination Solid Mechanics February 25, 2002 student personal identification (ID) number on each sheet. Do not write your name on any sheet. #1. A homogeneous, isotropic, linear elastic bar has rectangular cross sectional area A, modulus of elasticity

More information

MOOSE Workshop MOOSE-PF/MARMOT Training Mechanics Part Nashville, February 14th Daniel Schwen

MOOSE Workshop MOOSE-PF/MARMOT Training Mechanics Part Nashville, February 14th Daniel Schwen www.inl.gov MOOSE Workshop MOOSE-PF/MARMOT Training Mechanics Part Nashville, February 14th Daniel Schwen www.inl.gov III. Mechanics Mechanics Outline 1. Introduction 2. Tensor-based System 1. Compute

More information

Nonlinear Static - 1D Plasticity - Isotropic and Kinematic Hardening Walla Walla University

Nonlinear Static - 1D Plasticity - Isotropic and Kinematic Hardening Walla Walla University Nonlinear Static - 1D Plasticity - Isotropic and Kinematic Hardening Walla Walla University Professor Louie L. Yaw c Draft date January 18, 2017 Copyright is reserved. Individual copies may be made for

More information

A return mapping algorithm for unified strength theory model

A return mapping algorithm for unified strength theory model INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 2015; 104:749 766 Published online 10 June 2015 in Wiley Online Library (wileyonlinelibrary.com)..4937 A return mapping

More information

MITOCW MITRES2_002S10nonlinear_lec15_300k-mp4

MITOCW MITRES2_002S10nonlinear_lec15_300k-mp4 MITOCW MITRES2_002S10nonlinear_lec15_300k-mp4 The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources

More information

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

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

More information

Elasto-plastic concrete beam analysis by 1-dimensional Finite Element Method

Elasto-plastic concrete beam analysis by 1-dimensional Finite Element Method AALBORG UNIVERSITY MASTER S THESIS Elasto-plastic concrete beam analysis by 1-dimensional Finite Element Method Authors: Niels F. Overgaard Martin B. Andreasen Supervisors: Johan Clausen Lars V. Andersen

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

Basic concepts to start Mechanics of Materials

Basic concepts to start Mechanics of Materials Basic concepts to start Mechanics of Materials Georges Cailletaud Centre des Matériaux Ecole des Mines de Paris/CNRS Notations Notations (maths) (1/2) A vector v (element of a vectorial space) can be seen

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

Supplementary Figures

Supplementary Figures Fracture Strength (GPa) Supplementary Figures a b 10 R=0.88 mm 1 0.1 Gordon et al Zhu et al Tang et al im et al 5 7 6 4 This work 5 50 500 Si Nanowire Diameter (nm) Supplementary Figure 1: (a) TEM image

More information

HERCULES-2 Project. Deliverable: D4.4. TMF model for new cylinder head. <Final> 28 February March 2018

HERCULES-2 Project. Deliverable: D4.4. TMF model for new cylinder head. <Final> 28 February March 2018 HERCULES-2 Project Fuel Flexible, Near Zero Emissions, Adaptive Performance Marine Engine Deliverable: D4.4 TMF model for new cylinder head Nature of the Deliverable: Due date of the Deliverable:

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

Modelling the behaviour of plastics for design under impact

Modelling the behaviour of plastics for design under impact Modelling the behaviour of plastics for design under impact G. Dean and L. Crocker MPP IAG Meeting 6 October 24 Land Rover door trim Loading stages and selected regions Project MPP7.9 Main tasks Tests

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

Nonlinear Static - 1D Plasticity - Various Forms of Isotropic Hardening by Louie L. Yaw Walla Walla University Draft Date January 25, 2012

Nonlinear Static - 1D Plasticity - Various Forms of Isotropic Hardening by Louie L. Yaw Walla Walla University Draft Date January 25, 2012 1 Nonlinear Static - 1D Plasticity - Various Forms of Isotropic Hardening by Louie L. Yaw Walla Walla University Draft Date January 25, 2012 key words: plasticity, algorithms, nonlinear analysis, isotropic

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

Constitutive model for quasi-static deformation of metallic sandwich cores

Constitutive model for quasi-static deformation of metallic sandwich cores INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 2004; 61:2205 2238 Published online 18 October 2004 in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/nme.1142

More information

Constitutive models: Incremental plasticity Drücker s postulate

Constitutive models: Incremental plasticity Drücker s postulate Constitutive models: Incremental plasticity Drücker s postulate if consistency condition associated plastic law, associated plasticity - plastic flow law associated with the limit (loading) surface Prager

More information

Exercise: concepts from chapter 8

Exercise: concepts from chapter 8 Reading: Fundamentals of Structural Geology, Ch 8 1) The following exercises explore elementary concepts associated with a linear elastic material that is isotropic and homogeneous with respect to elastic

More information

NUMERICAL SIMULATION OF THE INELASTIC SEISMIC RESPONSE OF RC STRUCTURES WITH ENERGY DISSIPATORS

NUMERICAL SIMULATION OF THE INELASTIC SEISMIC RESPONSE OF RC STRUCTURES WITH ENERGY DISSIPATORS NUMERICAL SIMULATION OF THE INELASTIC SEISMIC RESPONSE OF RC STRUCTURES WITH ENERGY DISSIPATORS ABSTRACT : P Mata1, AH Barbat1, S Oller1, R Boroschek2 1 Technical University of Catalonia, Civil Engineering

More information

(MPa) compute (a) The traction vector acting on an internal material plane with normal n ( e1 e

(MPa) compute (a) The traction vector acting on an internal material plane with normal n ( e1 e EN10: Continuum Mechanics Homework : Kinetics Due 1:00 noon Friday February 4th School of Engineering Brown University 1. For the Cauchy stress tensor with components 100 5 50 0 00 (MPa) compute (a) The

More information

Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount

Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount Min Ding* 1, and Jian Lin 2 1 MIT/WHOI Joint Program, 2 Woods Hole Oceanographic Institution *Woods Hole Oceanographic

More information

Theory of Plasticity. Lecture Notes

Theory of Plasticity. Lecture Notes Theory of Plasticity Lecture Notes Spring 2012 Contents I Theory of Plasticity 1 1 Mechanical Theory of Plasticity 2 1.1 Field Equations for A Mechanical Theory.................... 2 1.1.1 Strain-displacement

More information

Fundamentals of Linear Elasticity

Fundamentals of Linear Elasticity Fundamentals of Linear Elasticity Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy

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

16.21 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive Equations

16.21 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive Equations 6.2 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive quations Constitutive quations For elastic materials: If the relation is linear: Û σ ij = σ ij (ɛ) = ρ () ɛ ij σ ij =

More information

Plasticity R. Chandramouli Associate Dean-Research SASTRA University, Thanjavur

Plasticity R. Chandramouli Associate Dean-Research SASTRA University, Thanjavur Plasticity R. Chandramouli Associate Dean-Research SASTRA University, Thanjavur-613 401 Joint Initiative of IITs and IISc Funded by MHRD Page 1 of 9 Table of Contents 1. Plasticity:... 3 1.1 Plastic Deformation,

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

Lecture 4 Implementing material models: using usermat.f. Implementing User-Programmable Features (UPFs) in ANSYS ANSYS, Inc.

Lecture 4 Implementing material models: using usermat.f. Implementing User-Programmable Features (UPFs) in ANSYS ANSYS, Inc. Lecture 4 Implementing material models: using usermat.f Implementing User-Programmable Features (UPFs) in ANSYS 1 Lecture overview What is usermat.f used for? Stress, strain and material Jacobian matrix

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

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

Lecture 8. Stress Strain in Multi-dimension

Lecture 8. Stress Strain in Multi-dimension Lecture 8. Stress Strain in Multi-dimension Module. General Field Equations General Field Equations [] Equilibrium Equations in Elastic bodies xx x y z yx zx f x 0, etc [2] Kinematics xx u x x,etc. [3]

More information

Mechanical Properties of Materials

Mechanical Properties of Materials Mechanical Properties of Materials Strains Material Model Stresses Learning objectives Understand the qualitative and quantitative description of mechanical properties of materials. Learn the logic of

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

Abstract. I. Introduction

Abstract. I. Introduction On elastoplastic analysis of 1-D structural member subj ect to combined bending and torsion M. Moestopo Structural Mechanics Laboratory, Inter-University Center for Engineering Sciences, Bandung Institute

More information

Practice Final Examination. Please initial the statement below to show that you have read it

Practice Final Examination. Please initial the statement below to show that you have read it EN175: Advanced Mechanics of Solids Practice Final Examination School of Engineering Brown University NAME: General Instructions No collaboration of any kind is permitted on this examination. You may use

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

HONGJUN LI Department of Mechanical Engineering University of Strathclyde Glasgow, Scotland, UK

HONGJUN LI Department of Mechanical Engineering University of Strathclyde Glasgow, Scotland, UK HONGJUN LI Department of Mechanical Engineering University of Strathclyde Glasgow, Scotland, UK Introduction FEA is an established analysis method used in Pressure Vessel Design Most DBA is still based

More information

NONLINEAR CONTINUUM FORMULATIONS CONTENTS

NONLINEAR CONTINUUM FORMULATIONS CONTENTS NONLINEAR CONTINUUM FORMULATIONS CONTENTS Introduction to nonlinear continuum mechanics Descriptions of motion Measures of stresses and strains Updated and Total Lagrangian formulations Continuum shell

More information

Elements of Continuum Elasticity. David M. Parks Mechanics and Materials II February 25, 2004

Elements of Continuum Elasticity. David M. Parks Mechanics and Materials II February 25, 2004 Elements of Continuum Elasticity David M. Parks Mechanics and Materials II 2.002 February 25, 2004 Solid Mechanics in 3 Dimensions: stress/equilibrium, strain/displacement, and intro to linear elastic

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

PURE BENDING. If a simply supported beam carries two point loads of 10 kn as shown in the following figure, pure bending occurs at segment BC.

PURE BENDING. If a simply supported beam carries two point loads of 10 kn as shown in the following figure, pure bending occurs at segment BC. BENDING STRESS The effect of a bending moment applied to a cross-section of a beam is to induce a state of stress across that section. These stresses are known as bending stresses and they act normally

More information

6. NON-LINEAR PSEUDO-STATIC ANALYSIS OF ADOBE WALLS

6. NON-LINEAR PSEUDO-STATIC ANALYSIS OF ADOBE WALLS 6. NON-LINEAR PSEUDO-STATIC ANALYSIS OF ADOBE WALLS Blondet et al. [25] carried out a cyclic test on an adobe wall to reproduce its seismic response and damage pattern under in-plane loads. The displacement

More information

Sensitivity and Reliability Analysis of Nonlinear Frame Structures

Sensitivity and Reliability Analysis of Nonlinear Frame Structures Sensitivity and Reliability Analysis of Nonlinear Frame Structures Michael H. Scott Associate Professor School of Civil and Construction Engineering Applied Mathematics and Computation Seminar April 8,

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

Computational models of diamond anvil cell compression

Computational models of diamond anvil cell compression UDC 519.6 Computational models of diamond anvil cell compression A. I. Kondrat yev Independent Researcher, 5944 St. Alban Road, Pensacola, Florida 32503, USA Abstract. Diamond anvil cells (DAC) are extensively

More information

MECHANICS OF MATERIALS. EQUATIONS AND THEOREMS

MECHANICS OF MATERIALS. EQUATIONS AND THEOREMS 1 MECHANICS OF MATERIALS. EQUATIONS AND THEOREMS Version 2011-01-14 Stress tensor Definition of traction vector (1) Cauchy theorem (2) Equilibrium (3) Invariants (4) (5) (6) or, written in terms of principal

More information

EMA 3702 Mechanics & Materials Science (Mechanics of Materials) Chapter 2 Stress & Strain - Axial Loading

EMA 3702 Mechanics & Materials Science (Mechanics of Materials) Chapter 2 Stress & Strain - Axial Loading MA 3702 Mechanics & Materials Science (Mechanics of Materials) Chapter 2 Stress & Strain - Axial Loading MA 3702 Mechanics & Materials Science Zhe Cheng (2018) 2 Stress & Strain - Axial Loading Statics

More information

On Nonlinear Buckling and Collapse Analysis using Riks Method

On Nonlinear Buckling and Collapse Analysis using Riks Method Visit the SIMULIA Resource Center for more customer examples. On Nonlinear Buckling and Collapse Analysis using Riks Method Mingxin Zhao, Ph.D. UOP, A Honeywell Company, 50 East Algonquin Road, Des Plaines,

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

1 332 Laboratories 1. 2 Computational Exercises 1 FEA of a Cantilever Beam... 1 Experimental Laboratory: Tensile Testing of Materials...

1 332 Laboratories 1. 2 Computational Exercises 1 FEA of a Cantilever Beam... 1 Experimental Laboratory: Tensile Testing of Materials... 1 332 Laboratories Contents 1 332 Laboratories 1 2 Computational Exercises 1 FEA of a Cantilever Beam.......................................... 1 Experimental Laboratory: Tensile Testing of Materials..........................

More information

ANSYS Mechanical Basic Structural Nonlinearities

ANSYS Mechanical Basic Structural Nonlinearities Lecture 4 Rate Independent Plasticity ANSYS Mechanical Basic Structural Nonlinearities 1 Chapter Overview The following will be covered in this Chapter: A. Background Elasticity/Plasticity B. Yield Criteria

More information

Virtual Work and Variational Principles

Virtual Work and Variational Principles Virtual Work and Principles Mathematically, the structural analysis problem is a boundary value problem (BVP). Forces, displacements, stresses, and strains are connected and computed within the framework

More information

MHA042 - Material mechanics: Duggafrågor

MHA042 - Material mechanics: Duggafrågor MHA042 - Material mechanics: Duggafrågor 1) For a static uniaxial bar problem at isothermal (Θ const.) conditions, state principle of energy conservation (first law of thermodynamics). On the basis of

More information

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February.

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February. Engineering Sciences 241 Advanced Elasticity, Spring 2001 J. R. Rice Homework Problems / Class Notes Mechanics of finite deformation (list of references at end) Distributed Thursday 8 February. Problems

More information

Force-based Element vs. Displacement-based Element

Force-based Element vs. Displacement-based Element Force-based Element vs. Displacement-based Element Vesna Terzic UC Berkeley December 211 Agenda Introduction Theory of force-based element (FBE) Theory of displacement-based element (DBE) Examples Summary

More information

Reference material Reference books: Y.C. Fung, "Foundations of Solid Mechanics", Prentice Hall R. Hill, "The mathematical theory of plasticity",

Reference material Reference books: Y.C. Fung, Foundations of Solid Mechanics, Prentice Hall R. Hill, The mathematical theory of plasticity, Reference material Reference books: Y.C. Fung, "Foundations of Solid Mechanics", Prentice Hall R. Hill, "The mathematical theory of plasticity", Oxford University Press, Oxford. J. Lubliner, "Plasticity

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

Modelling of ductile failure in metal forming

Modelling of ductile failure in metal forming Modelling of ductile failure in metal forming H.H. Wisselink, J. Huetink Materials Innovation Institute (M2i) / University of Twente, Enschede, The Netherlands Summary: Damage and fracture are important

More information

FE FORMULATIONS FOR PLASTICITY

FE FORMULATIONS FOR PLASTICITY G These slides are designed based on the book: Finite Elements in Plasticity Theory and Practice, D.R.J. Owen and E. Hinton, 1970, Pineridge Press Ltd., Swansea, UK. 1 Course Content: A INTRODUCTION AND

More information

FCP Short Course. Ductile and Brittle Fracture. Stephen D. Downing. Mechanical Science and Engineering

FCP Short Course. Ductile and Brittle Fracture. Stephen D. Downing. Mechanical Science and Engineering FCP Short Course Ductile and Brittle Fracture Stephen D. Downing Mechanical Science and Engineering 001-015 University of Illinois Board of Trustees, All Rights Reserved Agenda Limit theorems Plane Stress

More information

Comparison of Models for Finite Plasticity

Comparison of Models for Finite Plasticity Comparison of Models for Finite Plasticity A numerical study Patrizio Neff and Christian Wieners California Institute of Technology (Universität Darmstadt) Universität Augsburg (Universität Heidelberg)

More information

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS Multimedia Course on Continuum Mechanics Overview Introduction Fluid Mechanics What is a Fluid? Pressure and Pascal s Law Constitutive Equations in Fluids Fluid Models

More information

A Demonstrative Computer Session Using ADINA- Nonlinear Analysis

A Demonstrative Computer Session Using ADINA- Nonlinear Analysis Topic 22 A Demonstrative Computer Session Using ADINA- Nonlinear Analysis Contents: Use of ADINA for elastic-plastic analysis of a plate with a hole Computer laboratory demonstration-part II Selection

More information

Module 10: Free Vibration of an Undampened 1D Cantilever Beam

Module 10: Free Vibration of an Undampened 1D Cantilever Beam Module 10: Free Vibration of an Undampened 1D Cantilever Beam Table of Contents Page Number Problem Description Theory Geometry 4 Preprocessor 6 Element Type 6 Real Constants and Material Properties 7

More information

Material parameter identification for the numerical simulation of deep-drawing drawing of aluminium alloys

Material parameter identification for the numerical simulation of deep-drawing drawing of aluminium alloys Material parameter identification for the numerical simulation of deep-drawing drawing of aluminium alloys B.M. Chaparro, J.M. Antunes, A.J. Baptista, D.M. Rodrigues,, J.V. Fernandes, L.F. Menezes M2D'26

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

A MECHANISM FOR DUCTILE FRACTURE IN SHEAR. Viggo Tvergaard Department of Mechanical Engineering,

A MECHANISM FOR DUCTILE FRACTURE IN SHEAR. Viggo Tvergaard Department of Mechanical Engineering, A MECHANISM FOR DUCTILE FRACTURE IN SHEAR Viggo Tvergaard Department of Mechanical Engineering, Solid Mechanics Technical University of Denmark, Bldg. 44, DK-8 Kgs. Lyngby, Denmark N.A. Fleck, J.W. Hutchinson

More information

For an imposed stress history consisting of a rapidly applied step-function jump in

For an imposed stress history consisting of a rapidly applied step-function jump in Problem 2 (20 points) MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 0239 2.002 MECHANICS AND MATERIALS II SOLUTION for QUIZ NO. October 5, 2003 For

More information

Optimization of blank dimensions to reduce springback in the flexforming process

Optimization of blank dimensions to reduce springback in the flexforming process Journal of Materials Processing Technology 146 (2004) 28 34 Optimization of blank dimensions to reduce springback in the flexforming process Hariharasudhan Palaniswamy, Gracious Ngaile, Taylan Altan ERC

More information

ALGORITHM FOR NON-PROPORTIONAL LOADING IN SEQUENTIALLY LINEAR ANALYSIS

ALGORITHM FOR NON-PROPORTIONAL LOADING IN SEQUENTIALLY LINEAR ANALYSIS 9th International Conference on Fracture Mechanics of Concrete and Concrete Structures FraMCoS-9 Chenjie Yu, P.C.J. Hoogenboom and J.G. Rots DOI 10.21012/FC9.288 ALGORITHM FOR NON-PROPORTIONAL LOADING

More information

A FINITE ELEMENT MODEL TO PREDICT MULTI- AXIAL STRESS-STRAIN RESPONSE OF CERAMIC MATRIX COMPOSITES WITH STRAIN INDUCED DAMAGE

A FINITE ELEMENT MODEL TO PREDICT MULTI- AXIAL STRESS-STRAIN RESPONSE OF CERAMIC MATRIX COMPOSITES WITH STRAIN INDUCED DAMAGE A FINITE ELEMENT MODEL TO PREDICT MULTI- AXIAL STRESS-STRAIN RESPONSE OF CERAMIC MATRIX COMPOSITES WITH STRAIN INDUCED DAMAGE Daxu Zhang and D. R. Hayhurst School of Mechanical, Aerospace and Civil Engineering,

More information

Numerical simulation of tensile tests of prestrained sheets

Numerical simulation of tensile tests of prestrained sheets Materials Science and Engineering A264 (1999) 130 138 Numerical simulation of tensile tests of prestrained sheets L.F. Menezes *, J.V. Fernandes, D.M. Rodrigues Departamento de Engenharia Mecânica, CEMUC,

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

Mathematical Modeling. of Large Elastic-Plastic Deformations

Mathematical Modeling. of Large Elastic-Plastic Deformations Applied Mathematical Sciences, Vol. 8, 04, no. 60, 99 996 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/0.988/ams.04.447 Mathematical Modeling of Large Elastic-Plastic Deformations L. U. Sultanov Kazan

More information

Modeling and Simulation of Two-Dimensional Consolidation for Thermoset Matrix Composites

Modeling and Simulation of Two-Dimensional Consolidation for Thermoset Matrix Composites Modeling and Simulation of Two-Dimensional Consolidation for Thermoset Matrix Composites Min Li and Charles L. Tucker III Department of Mechanical and Industrial Engineering University of Illinois at Urbana-Champaign

More information

MATERIAL MECHANICS, SE2126 COMPUTER LAB 3 VISCOELASTICITY. k a. N t

MATERIAL MECHANICS, SE2126 COMPUTER LAB 3 VISCOELASTICITY. k a. N t MATERIAL MECHANICS, SE2126 COMPUTER LAB 3 VISCOELASTICITY N t i Gt () G0 1 i ( 1 e τ = α ) i= 1 k a k b τ PART A RELAXING PLASTIC PAPERCLIP Consider an ordinary paperclip made of plastic, as they more

More information

MECHANICS OF MATERIALS Sample Problem 4.2

MECHANICS OF MATERIALS Sample Problem 4.2 Sample Problem 4. SOLUTON: Based on the cross section geometry, calculate the location of the section centroid and moment of inertia. ya ( + Y Ad ) A A cast-iron machine part is acted upon by a kn-m couple.

More information

Modelling Anisotropic, Hyperelastic Materials in ABAQUS

Modelling Anisotropic, Hyperelastic Materials in ABAQUS Modelling Anisotropic, Hyperelastic Materials in ABAQUS Salvatore Federico and Walter Herzog Human Performance Laboratory, Faculty of Kinesiology, The University of Calgary 2500 University Drive NW, Calgary,

More information

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering University of Liège Aerospace & Mechanical Engineering Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE Van Dung NGUYEN Innocent NIYONZIMA Aerospace & Mechanical engineering

More information

A Simple and Accurate Elastoplastic Model Dependent on the Third Invariant and Applied to a Wide Range of Stress Triaxiality

A Simple and Accurate Elastoplastic Model Dependent on the Third Invariant and Applied to a Wide Range of Stress Triaxiality A Simple and Accurate Elastoplastic Model Dependent on the Third Invariant and Applied to a Wide Range of Stress Triaxiality Lucival Malcher Department of Mechanical Engineering Faculty of Tecnology, University

More information

Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods of Structural Analysis

Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods of Structural Analysis uke University epartment of Civil and Environmental Engineering CEE 42L. Matrix Structural Analysis Henri P. Gavin Fall, 22 Review of Strain Energy Methods and Introduction to Stiffness Matrix Methods

More information

Lecture #8: Ductile Fracture (Theory & Experiments)

Lecture #8: Ductile Fracture (Theory & Experiments) Lecture #8: Ductile Fracture (Theory & Experiments) by Dirk Mohr ETH Zurich, Department of Mechanical and Process Engineering, Chair of Computational Modeling of Materials in Manufacturing 2015 1 1 1 Ductile

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

Fire Analysis of Reinforced Concrete Beams with 2-D Plane Stress Concrete Model

Fire Analysis of Reinforced Concrete Beams with 2-D Plane Stress Concrete Model Research Journal of Applied Sciences, Engineering and Technology 5(2): 398-44, 213 ISSN: 24-7459; E-ISSN: 24-7467 Maxwell Scientific Organization, 213 Submitted: April 29, 212 Accepted: May 23, 212 Published:

More information