15 - finite element method

Slides:



Advertisements
Similar presentations
NONLINEAR DYNAMIC FINITE ELEMENT ANALYSIS IN ZSOIL :
Advertisements

4. Spring Element Dr. Ahmet Zafer Şenalp Mechanical Engineering Department Gebze Technical University.
Modeling of Neo-Hookean Materials using FEM
MECH593 Introduction to Finite Element Methods
ECIV 720 A Advanced Structural Mechanics and Analysis
Nonlinearity Structural Mechanics Displacement-based Formulations.
FEM and X-FEM in Continuum Mechanics Joint Advanced Student School (JASS) 2006, St. Petersburg, Numerical Simulation, 3. April 2006 State University St.
12/21/2001Numerical methods in continuum mechanics1 Continuum Mechanics On the scale of the object to be studied the density and other fluid properties.
Finite Element Method Introduction General Principle
FEA Simulations Usually based on energy minimum or virtual work Component of interest is divided into small parts – 1D elements for beam or truss structures.
Finite Element Method in Geotechnical Engineering
MECH300H Introduction to Finite Element Methods
ECIV 720 A Advanced Structural Mechanics and Analysis Lecture 10: Solution of Continuous Systems – Fundamental Concepts Mixed Formulations Intrinsic Coordinate.
Isoparametric elements and solution techniques. Advanced Design for Mechanical System - Lec 2008/10/092.
ECIV 720 A Advanced Structural Mechanics and Analysis Lecture 12: Isoparametric CST Area Coordinates Shape Functions Strain-Displacement Matrix Rayleigh-Ritz.
CST ELEMENT STIFFNESS MATRIX
CHAP 4 FINITE ELEMENT ANALYSIS OF BEAMS AND FRAMES
MECH593 Introduction to Finite Element Methods
Beam Design for Geometric Nonlinearities
Finite Element: Theory, Applications & Implementation Presented By: Arthur Anconetani Barbara Gault Ryan Whitney.
Outline Lesson 1. Introduction to ANSYS Lesson 2. Basics Lesson 3. Solution phases Lesson 4. Modeling Lesson 5. Material Lesson 6. Loading Lesson 7. Solution.
Finite element method Among up-to-date methods of mechanics and specifically stress analyses, finite element method (abbreviated as FEM below, or often.
An introduction to the finite element method using MATLAB
1 Variational and Weighted Residual Methods. 2 The Weighted Residual Method The governing equation for 1-D heat conduction A solution to this equation.
1 20-Oct-15 Last course Lecture plan and policies What is FEM? Brief history of the FEM Example of applications Discretization Example of FEM softwares.
NBCR Summer Institute 2006: Multi-Scale Cardiac Modeling with Continuity 6.3 Friday: Cardiac Biomechanics Andrew McCulloch, Fred Lionetti and Stuart Campbell.
HEAT TRANSFER FINITE ELEMENT FORMULATION
09 - finite element method
finite element method 08 - finite element method - density growth - theory.
The Generalized Interpolation Material Point Method.
MECH4450 Introduction to Finite Element Methods
Material Point Method Solution Procedure Wednesday, 10/9/2002 Map from particles to grid Interpolate from grid to particles Constitutive model Boundary.
CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS
Discretization Methods Chapter 2. Training Manual May 15, 2001 Inventory # Discretization Methods Topics Equations and The Goal Brief overview.
1/61/6 M.Chrzanowski: Strength of Materials SM1-08: Continuum Mechanics: Stress distribution CONTINUUM MECHANICS (STRESS DISTRIBUTION)
Partial Derivatives Example: Find If solution: Partial Derivatives Example: Find If solution: gradient grad(u) = gradient.
1 Non-Linear Piezoelectric Exact Geometry Solid-Shell Element Based on 9-Parameter Model Gennady M. Kulikov Department of Applied Mathematics & Mechanics.
Finite Element: Theory, Applications & Implementation Presented By: Arthur Anconetani Barbara Gault Ryan Whitney.
14 - finite element method
1 CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS FINITE ELEMENT ANALYSIS AND DESIGN Nam-Ho Kim.
Our task is to estimate the axial displacement u at any section x
Finite Element Method Weak form Monday, 11/4/2002.
Boundary Element Method
Finite Element Method in Geotechnical Engineering
Truss Element Equations
1D OF FINITE ELEMENT METHOD Session 4 – 6
14 - finite element method
12 - finite element method
15 - finite element method
09 - finite element method
روش عناصر محدود غیرخطی II Nonlinear Finite Element Procedures II
FEA Simulations Boundary conditions are applied
ECIV 720 A Advanced Structural Mechanics and Analysis
Implementation of 2D stress-strain Finite Element Modeling on MATLAB
روش عناصر محدود غیرخطی II Nonlinear Finite Element Procedures II
FEM Steps (Displacement Method)
Scientific Computing Lab
finite element method node point based strong form
GENERAL VIEW OF KRATOS MULTIPHYSICS
finite element method node point based strong form
Objective Numerical methods Finite volume.
FINITE ELEMENT METHOD (INTRODUCTION)
OVERVIEW OF FINITE ELEMENT METHOD
8-1 Introduction a) Plane Stress y
08 - finite element method
FINITE ELEMENT METHOD (INTRODUCTION)
Programming assignment #1 Solving an elliptic PDE using finite differences Numerical Methods for PDEs Spring 2007 Jim E. Jones.
Finite element analysis of the wrinkling of orthotropic membranes
Finite Element Modelling in Geosciences FEM in 2D for viscous materials Introduction to Finite Element Modelling in Geosciences Summer 2018.
Presentation transcript:

15 - finite element method volume growth - implementation 15 - finite element method

integration point based loop over all time steps global newton iteration loop over all elements loop over all quadrature points local newton iteration to determine determine element residual & partial derivative determine global residual and iterational matrix determine determine state of biological equilibrium staggered solution finite element method

integration point based loop over all time steps nlin_fem global newton iteration nlin_fem loop over all elements tetra_3d loop over all quadrature points cnst_vol local newton iteration updt_vol determine element residual & tangent cnst_vol determine global residual and tangent tetra_3d determine nlin_fem determine state of biological equilibrium nlin_fem staggered solution finite element method

integration point based • discrete residual check in matlab! • residual of mechanical equilibrium/balance of momentum discrete residual finite element method

integration point based • stiffness matrix / iteration matrix check in matlab! • linearization of residual wrt nodal dofs linearization finite element method

finite element method tetra_3d.m function [Ke,Re,Ie] =tetra_3d(e_mat,e_spa,i_var,mat) %%% stiffness matrix Ke and righthand side Re for linear tets %%%%%%%%%% [nmat,ngrw]=size(mat); nod=4; ndim=3; delta=eye(ndim); Ie = i_var; Re = zeros(12, 1); Ke = zeros(12,12); indx =[1;4;7;10]; ex_mat=e_mat(indx); ex_spa=e_spa(indx); indy =[2;5;8;11]; ey_mat=e_mat(indy); ey_spa=e_spa(indy); indz =[3;6;9;12]; ez_mat=e_mat(indz); ez_spa=e_spa(indz); %%% integration points %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% gp(1)=(ex_mat(1)+ex_mat(2)+ex_mat(3)+ex_mat(4)) / 4.0; gp(2)=(ey_mat(1)+ey_mat(2)+ey_mat(3)+ey_mat(4)) / 4.0; gp(3)=(ez_mat(1)+ez_mat(2)+ez_mat(3)+ez_mat(4)) / 4.0; w = 1/6; %%% shape functions in isoparametric space %%%%%%%%%%%%%%%%%%%%%%%%%%%%% N(1)=1-gp(1)-gp(2)-gp(3); N(2)= +gp(1); N(3)= +gp(2); N(4)= +gp(3); %%% partial derivatives of shape functions wrt r and s and t %%%%%%%%%%% dNr(1,1)=-1; dNr(1,2)=+1; dNr(1,3)= 0; dNr(1,4)= 0; dNr(2,1)=-1; dNr(2,2)= 0; dNr(2,3)=+1; dNr(2,4)= 0; dNr(3,1)=-1; dNr(3,2)= 0; dNr(3,3)= 0; dNr(3,4)=+1; JT=dNr*[ex_mat;ey_mat;ez_mat]'; %%% element stiffness matrix Ke, residual Re, internal variables Ie %%%% finite element method

finite element method tetra_3d.m %%% element stiffness matrix Ke, residual Re, internal variables Ie %%%%%%%%%% detJ=det(JT); JTinv=inv(JT); dNx=JTinv*dNr; F = zeros(3,3); for i=1:4 indx=[3*i-2; 3*i-1; 3*i]; F=F+e_spa(indx)'*dNx(:,i)'; end var = i_var(1); [A,P,var]=cnst_vol(F,var,mat,ndim); Ie(1) = var; for i=1:nod en=(i-1)*3; Re(en+1)=Re(en+1)+(P(1,1)*dNx(1,i)'+P(1,2)*dNx(2,i)'+P(1,3)*dNx(3,i)')*detJ*w; Re(en+2)=Re(en+2)+(P(2,1)*dNx(1,i)'+P(2,2)*dNx(2,i)'+P(2,3)*dNx(3,i)')*detJ*w; Re(en+3)=Re(en+3)+(P(3,1)*dNx(1,i)'+P(3,2)*dNx(2,i)'+P(3,3)*dNx(3,i)')*detJ*w;end finite element method

integration point based constitutive equations • constitutive equations - given calculate check in matlab! • stress calculation @ integration point level constitutive equations finite element method

integration point based constitutive equations • tangent operator / constitutive moduli check in matlab! • linearization of stress wrt deformation gradient constitutive equations finite element method

finite element method cnst_vol.m function [A,P,var]=cnst_vol(F,var,mat,ndim) %%% determine tangent, stress and internal variable %%%%%%%%%%%%%%%%%%% emod = mat(1); nue = mat(2); kt = mat(3); kc = mat(4); mt = mat(5); mc = mat(6); tt = mat(7); tc = mat(8); dt = mat(9); xmu = emod / 2.0 / (1.0+nue); xlm = emod * nue / (1.0+nue) / ( 1.0-2.0*nue ); %%% update internal variable %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% [var,ten1,ten2]=updt_vol(F,var,mat,ndim); theta = var(1) + 1; Fe = F/theta; Fe_inv=inv(Fe); Je=det(Fe); delta =eye(ndim); %%% first piola kirchhoff stress %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% P = xmu * Fe + (xlm * log(Je) - xmu) * Fe_inv'; %%% tangent %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% for i=1:ndim; for j=1:ndim; for k=1:ndim; for l=1:ndim A(i,j,k,l) = xlm * Fe_inv(j,i)*Fe_inv(l,k) ... - (xlm * log(Je) - xmu) * Fe_inv(l,i)*Fe_inv(j,k) ... + xmu * delta(i,k)* delta(j,l) ... + ten1(i,j)* ten2(k,l); end, end, end, end A = A / theta; finite element method

integration point based constitutive equations • discrete volume update check in matlab! • residual of biological equilibrium / volume growth constitutive equations finite element method

finite element method updt_vol.m function [var,ten1,ten2]=updt_vol(F,var,mat,ndim) %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% the_k0 = var(1)+1; the_k1=var(1)+1; iter=0; res = 1; %%% local newton-raphson iteration %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% while abs(res) > tol Fe=F/the_k1; Ce=Fe'*Fe; Fe_inv=inv(Fe); Ce_inv=inv(Ce); Je=det(Fe); Se = xmu * delta + (xlm * log(Je) - xmu) * Ce_inv; tr_Me = trace(Ce*Se); dtrM_dthe = - 1/the_k1 * ( 2*tr_Me + CeLeCe ); CeLeCe = ndim * ndim * xlm - 2 * ndim * (xlm * log(Je) - xmu); k = kt*((tt-the_k1)/(tt-1))^mt; dk_dthe = k /(the_k1-tt) *mt; res = k * tr_Me * dt - the_k1 + the_k0; dres = (dk_dthe * tr_Me + k * dtrM_dthe)*dt -1; dthe = -res/dres; the_k1 = the_k1 + dthe; end fac1 = -1 / the_k1; fac2 = -k / dres * dt; Pe = xmu * Fe + (xlm*log(Je) - xmu) * Fe_inv'; AeFe = xmu * Fe + (ndim*xlm - xlm*log(Je) + xmu) * Fe_inv'; ten1 = fac1 * AeFe; ten2 = fac2 * (Pe+AeFe);var(1) = the_k1 - 1 %%% update internal variable volume %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% finite element method

finite element method ex_beams.m function [q0,edof,emat,bc,F_ext,mat,ndim,nel,node,ndof,nip,nlod] = ex_beams %%% input data for frame example %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% emod = 100; nue = 0.3; kt = 2.0; kc = 2.0; mt = 2.0; mc = 2.0; tt = 2.0; tc = 0.5; dt = 1.0; mat = [emod,nue,kt,kc,mt,mc,tt,tc,dt]; xbox(1) = 0.0; xbox(2) = 8.0; nx =32; ybox(1) = 0.0; ybox(2) = 1.0; ny = 4; [q0,edof] = mesh_sqr(xbox,ybox,nx,ny); [nel, sizen]=size(edof); [ndof,sizen]=size(q0); node=ndof/2; nip=4; %%% dirichlet boundary conditions bc(1,1) = 6; bc(1,2) = 0; bc(2,1) = 159; bc(2,2) = 0; bc(3,1) = 326; bc(3,2) = 0; %%% neumann boundary conditions F_ext = zeros(ndof,1); F_ext(10) = Fp/2; F_ext(20:10:320) = Fp; F_ext(330) = Fp/2; %%% input data for beams example %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% finite element method

ex_frame.m finite element method