simxpert r3.2 explicit workspace guide

242
1 Introduction MD Explicit Workspace Guide Introduction

Upload: paulkastle

Post on 12-Nov-2014

413 views

Category:

Documents


3 download

DESCRIPTION

This is the Workspace User's Guide for the SimXpert MD Explicit Workspace.

TRANSCRIPT

Page 1: SimXpert R3.2 Explicit Workspace Guide

1Introduction

MD Explicit Workspace GuideIntroduction

Page 2: SimXpert R3.2 Explicit Workspace Guide

Overview and Definition2

Overview and DefinitionAn overview of the SimXpert MD Explcit workspace is given here.

IntroductionSimXpert MD Explicit is a preprocessor for graphically preparing input data for MD Nastran Explcit, an explicit dynamic software, used in applications such as crash, crush, and drop test simulations. Use of this workspace allows users to work within one common modeling environment with other SimXpert workspaces such as Structures. Thus, for example, a model originally prepared for NVH, linear, or implicit nonlinear analysis can be easily used in explicit applications (e.g. crash). This dramatically reduces the time spent to build different models for implicit and explicit analysis and prevents you from making mistakes because of unfamiliarity between different programs.

TheoryA detailed theory of explicit analysis is outside the scope of this guide. However, it is important to understand the basics of the solution technique, since it is critical to many aspects of using the SimXpert MD Explicit workspace. If you are already familiar with explicit methods and how they differ from implicit methods, you may disregard this section.

Method of SolutionAlthough MD Nastran Explicit Nonlinear uses the Explicit methods, a brief overview of both the Implicit and the Explicit Methods for the solution of dynamic response calculations is given below.

Implicit Methods

Most finite element programs use implicit methods to carry out a transient solution. Normally, they use Newmark schemes to integrate in time. If the current time step is step , a good estimate of the acceleration at the end of step will satisfy the following equation of motion:

where:

= mass matrix of the structure

= damping matrix of the structure

= stiffness matrix of the structure

= vector of externally applied loads at step

nn 1+

Ma'n 1+ Cv'n 1+ Kd'n 1++ + Fn 1+ext

=

M

C

K

Fn 1+ext

n 1+

Page 3: SimXpert R3.2 Explicit Workspace Guide

3IntroductionOverview and Definition

and the prime denotes an estimated value.

The estimates of displacement and velocity are given by:

or

where is the time step, and and are constants.

The terms and are predictive and are based on values already calculated.

Substituting these values in the equation of motion results in

or

The equation of motion may then be defined as

The accelerations are obtained by inverting the matrix as follows:

= estimate of acceleration at step

= estimate of velocity at step

= estimate of displacement at step

a'n 1+ n 1+

v'n 1+ n 1+

d'n 1+ n 1+

d'n 1+ dn vnΔt 1 2β–( )anΔt2( ) 2 βa'n 1++⁄ Δt

2+ +=

v'n 1+ vn 1 γ–( )anΔt γa'n 1+ Δt+ +=

d'n 1+ dn* βa'n 1+ Δt

2+=

v'n 1+ vn* γa'n 1+ Δt+=

Δt β γ

dn* vn

*

Ma'n 1+ C v*n γa'n 1+ Δt+( ) K d*n βa'n 1+ Δt2

+( )+ + Fn 1+ext

=

M CγΔt KβΔt2

+ + ]a'n 1+ Fn 1+ext

Cvn*– Kd–=

M*a'n 1+ Fn 1+residual

=

M*

a'n 1+ M*1–Fn 1+

residual=

Page 4: SimXpert R3.2 Explicit Workspace Guide

Overview and Definition4

This is analogous to decomposing the stiffness matrix in a linear static analysis. However, in dynamics, mass and damping terms are also present.

Explicit Methods

The equation of motion

can be rewritten as

where

The acceleration can be found by inverting the mass matrix and multiplying it by the residual load vector.

In LS_DYNA, like any explicit finite element code, the mass matrix is lumped which results in a diagonal mass matrix.

Since is diagonal, its inversion is trivial, and the matrix equation is a set of independent equations for each degree of freedom, as follows:

The Leap-frog scheme is used to advance in time.

The position, forces, and accelerations are defined at time level , while the velocities are defined at time level . Graphically, this can be depicted as:

= vector of externally applied loads

= vector of internal loads (e.g., forces generated by the elements and hourglass forces)

=

= mass matrix

Man Cvn Kdn+ + Fnext

=

Man Fnext

Fnint

–=

an M1–Fn

residual=

Fnext

Fnint

Cvn Kdn+

M

M

ani Fniresidual

Mi⁄=

nn 1 2⁄+

Page 5: SimXpert R3.2 Explicit Workspace Guide

5IntroductionOverview and Definition

The Leap-frog scheme results in a central difference approximation for the acceleration, and is second-order accurate in .

Explicit methods with a lumped mass matrix do not require matrix decompositions or matrix solutions. Instead, the loop is carried out for each time step as shown in the following diagram:

Explicit Time Step

Implicit methods can be made unconditionally stable regardless of the size of the time step. However, for explicit codes to remain stable, the time step must subdivide the shortest natural period in the mesh. This means that the time step must be less than the time taken for a stress wave to cross the smallest element

n 1– n 1 2§– n n 1 2§+ n 1+ time

d F a, , d F a, , d F a, ,v v

vn 1 2⁄+ vn 1 2⁄– an Δtn 1 2⁄+ Δtn 1 2⁄–+( ) 2⁄+=

dn 1+ dn vn 1 2⁄+ Δtn 1 2⁄++=

Δt

Grid-Point Accelerations

Grid-Point Velocities Grid-Point Displacements

Element Stain Rates

Element Stresses

Element Forces at Grid-Points

+ External Forces at Grid Points

Leap-frog Integration in Time

Element Formulation and Gradient Operator

Constitutive Model and Integration

CONTACT, Fluid-Structure Interaction, Force/Pressure boundaries

Element Formulation and Divergence Operator

Page 6: SimXpert R3.2 Explicit Workspace Guide

Overview and Definition6

in the mesh. Typically, explicit time steps are 100 to 1000 times smaller than those used with implicit codes. However, since each iteration does not involve the costly formulation and decomposition of matrices, explicit techniques are very competitive with implicit methods.

Because the smallest element in an explicit solution determines the time step, it is extremely important to avoid very small elements in the mesh.

Courant Criterion

Since it is impossible to do a complete eigenvalue analysis every cycle to calculate the timestep, an approximate method, known as the Courant Criterion, is used. This is based on the minimum time which is required for a stress wave to cross each element:

where

For 1-D elements, the speed of sound is defined as:

where,

Implicit vs. Explicit Analysis

The time step for implicit solutions can be much larger than is possible for explicit solutions. This makes implicit methods more attractive for transient events that occur over a long time period and are dominated by low frequency structural dynamics. Explicit solutions are better for short, transient events where the effects of stress waves are important. There is, of course, an area where either method is equally advantageous and may be used.

Explicit solutions have a greater advantage over implicit solutions if the time step of the implicit solution has to be small for some reason. This may be necessary for problems that include:

= Timestep

= Timestep scale factor (<1)

= Smallest element dimension

= Speed of sound in the element material

= Young’s modulus

= density

tΔ SL/c=

Δt

S

L

c

c E ρ⁄=

E

ρ

Page 7: SimXpert R3.2 Explicit Workspace Guide

7IntroductionOverview and Definition

• Material nonlinearity. A high degree of material nonlinearity may require a small time step for accuracy.

• Large geometric nonlinearity. Contact and friction algorithms can introduce potential instabilities, and a small time step may be needed for accuracy and stability.

• Those analyses where the physics of the problem demands a small time step (e.g. stress wave effects as in crash, crush, and impact analyses).

• Material and geometric nonlinearity in combination with large displacements. Convergence in implicit methods becomes more difficult to achieve as the amount of nonlinearity for all types increases.

Explicit methods have increasing advantages over implicit methods as the model gets bigger, and bigger.

Typical ApplicationsSome of the typical structural applications which are well suited for the SOL 700 explicit analysis are:

• Automotive and Aircraft crash worthiness• Crash/Crush simulations• Drop testing• Ship Collision• Projectile penetration• Bird Strike Simulation with structural Bird• Metal forming, stamping, and deep drawing• Jet engine blade containment• Golf Club simulation• Rollover events

Page 8: SimXpert R3.2 Explicit Workspace Guide

Parts and Geometry8

Parts and GeometryThe geometry of the parts can be either created in SimXpert, or more likely imported from CAD program such as Catia, Pro/E.

UnitsSimXpert interprets all dimensions and input data with respect to a system of units. It is important to set the appropriate units prior to importing any unitless analysis files (such as a Nastran Bulk Data file) or creating materials, properties, or loads. You can control the system of units by selecting Units Manager from the Tools -> Options->Options Editor menu. If you import a file that contains units, SimXpert will convert them into those specified in the Units Manager.

Creating geometryIn the first release SimXpert has very limited geometry creation capabilities. It is possible to create curves and very simple surfaces. For the most part you will be importing geometry from an external source. The imported geometry can be edited in SimXpert

Importing geometryIf the geometry of the part is available in a CATIA, parasolid, IGES, or STL file, it can be directly imported into the SimXpert MD Explicit Workspace.

Creating local coordinate systemsSometimes it is convenient to use local coordinate systems for specifying loads, and or boundary conditions. For example, a certain node may have a roller support placed in an inclined plane. A local

Page 9: SimXpert R3.2 Explicit Workspace Guide

9IntroductionParts and Geometry

coordinate system with one of its axes normal to the inclined plane needs to be created and used to specify the fixity (SPC) of the displacement component along the direction normal to the inclined plane.

Local coordinate systems can be in cartesian, cylindrical or spherical systems. Coordinate system created in SimXpert are represented by the following icons, corresponding to the method selected.

You can create local coordinate systems by selecting Cartesian, Cylindrical, or Spherical from the Coordinate System group under the Geometry tab. There are numerous methods to create local coordinate systems in SimXpert:

Coordinate System

Direction 1

Direction 2

Direction 3 1-3 plane

Cartesian x y z x-z (y=0)

Cylindrical r z r-z ( =0)

Spherical r r- ( =0)

CONSTRAINTCONSTRAINT

Cartesian

Cylindrical

Spherical

θ θθ φ φ θ

Page 10: SimXpert R3.2 Explicit Workspace Guide

Parts and Geometry10

1. 3 Points: Three points are used to define the coordinate system. The first point corresponds to the location of origin. The second point defines the point on a specified axis and the third point defines a point in a specified plane.

2. Euler: Creates a coordinate system through three specified rotations about the axes of an existing coordinate system.

3. Normal: Creates a coordinate system with its origin at a point location on a surface. A specified axis is normal to the surface.

4. Two Vectors: Creates a coordinate system with its origin at a designated location and two of the coordinate frame axes are defined using vectors

5. Advanced: Location and orientation can be independently defined. There are 4 different ways to define the location of the origin of the coordinate system: Geometry, Point/Node, Coordinate System, and Center of Part. Further, the orientation can also be defined 3 ways: Global, Two Axes, and Coordinate System.

Page 11: SimXpert R3.2 Explicit Workspace Guide

11Elements

Elements

Page 12: SimXpert R3.2 Explicit Workspace Guide

Elements12

Elements

The heart of a finite element program lies in its element library which allows you to model a structure for analysis. MD Nastran has a very comprehensive element library which lets you model 1-D, 2-D, or 3-D structures. This section gives some basic definitions of the element types available in MD Nastran Explicit Nonlinear. For a more detailed description of all the available elements in MD Nastran Explicit, please refer to MD R2 Nastran Quick Reference Guide.

Element TypesEach element has five definitive characteristics that determine its behavior:

• Class• Number of Nodes• Interpolation• Degrees of Freedom• Integration Method

Class

The type of geometric domain that an element represents determines the class of the element. Listed below are the classes of elements in the MD Nastran Explicit Nonlinear element library.

• Beam Elements - a 3-D bar with axial, bending, and torsional stiffness.

• Shell Elements - a curved, thin or thick structure with membrane/bending capabilities.

• Plate Elements - a flat thin structure carrying in-plane and out-of-plane loads.

• Continuum Elements - Solid elements used to model thick sections.

• Plane stress - a thin plate with in-plane stresses only. All normal and shear stresses associated with the out-of-plane direction are assumed to be zero. (All plane strain elements lie in the global x-y plane.)

• Plane strain - a region where there is no out-of-plane motion and the normal and transverse strains are zero.

• Generalized plane strain is the same as plane strain except that the normal z-strain can be a prescribed constant or function of x and y.

• Axisymmetric elements are describe in 2-D, but represent a full 3-D structure where the geometry and loading are both axisymmetric.

• 3-D solid - a solid structure with only translational degrees of freedom for each node (linear or quadratic interpolation functions).

• Truss Elements - a 3-D rod with axial stiffness only (no bending).

• Membrane Elements - a thin sheet with in-plane stiffness only (no bending resistance).

• Concentrated mass/Springs/Damper Elements -

• Rigid Constraints -

Page 13: SimXpert R3.2 Explicit Workspace Guide

13ElementsElements

Number of Nodes

The number of nodes for an element define where the displacements are calculated in the analysis. Elements with only corner nodes are classified as first order elements and the calculation of displacements at locations within the element are made by linear interpolation. Elements that contain midside nodes are second order elements and quadratic interpolations are made for calculating displacements. MD Nastran SOL 700 do not support second order elements.

In MD Nastran the number of nodes is designated at the end of the element name. For example, a CQUAD4 has 4 nodes.

Interpolation

Interpolation (shape) function is an assumed function relating the displacements at a point inside an element to the displacements at the nodes of an element. In MD Nastran, three types of shape functions are used: linear, quadratic, and cubic.

Degrees of Freedom

Degrees of freedom is the number of unknowns at a node. In the general case, there are six degrees of freedom at a node in structural analysis (three translations, three rotations). For example there are three (translations) for 3-D truss element; six (three translations, three rotations) for a 3-D beam element and only three translations for the 3-D solid elements.

Integration

Numerical integration is a method used for evaluating integrals over an element. Element quantities – such as stresses, strains, and temperatures – are calculated at each integration point of the element. Full integration (quadrature) requires, for every element, 2-D integration points for linear interpolation and 3-D points for quadratic interpolation, where scalar “d” is the number of geometric dimensions of an element (that is, d = 2 for a quad; d = 3 for a hexahedron). Reduced integration uses a lower number of integration points than necessary to integrate exactly. For example, for an 8-node quadrilateral, the number of integration points is reduced from 9 to 4 and, for a 20-node hexahedron, from 27 to 8. For some elements, an “hourglass” control method is used to insure an accurate solution.

Table 0-1 summarizes the elements available in MD Nastran SOL 700. This section describes the characteristics of the elements. For shell element CTRIA3 and CQUAD4 shell elements, PARAM,DYNSHELLFORM is used to control the behavior.

Table 0-1 Elements in MD Nastran SOL 700

MD Nastran Available in SOL 700 Fatal Error

CBAR Y

CBEAM Y

CBELT Y

CBEND N Y

CBUSH N Y

Page 14: SimXpert R3.2 Explicit Workspace Guide

Elements14

CBUTT Y

CCONEAX N Y

CCRSFIL Y

CDAMP1 Y

CDAMP2 Y

CDAMP1D Y

CDAMP2D Y

CELAS1 Y

CELAS2 Y

CELAS1D Y

CELAS2D Y

CFILLET Y

CFLUID N Y

CGAP N Y

CHACAB N Y

CHACBR N Y

CHEXA Y (8 Nodes only)

COMBWLD Y

CONM2 Y

CONROD Y

CONSPOT Y

CPENTA Y (6 Nodes only)

CQUAD4 Y

CQUAD8 Y (4 Nodes only)

CQUADR Y

CQUADX N Y

CROD Y

CSHEAR N Y

CSPOT Y

CSPR Y

CTETRA Y (4 and 10 Nodes)

CTRIA3 Y

Table 0-1 Elements in MD Nastran SOL 700

MD Nastran Available in SOL 700 Fatal Error

Page 15: SimXpert R3.2 Explicit Workspace Guide

15ElementsElements

CTRIA6 Y (3 Nodes only)

CTRIA3R Y

CTRIAX N Y

CTRIAX6 N Y

CTQUAD Y

CTTRIA Y

CTUBE Y

CVISC Y

CWELD N Y

Table 0-1 Elements in MD Nastran SOL 700

MD Nastran Available in SOL 700 Fatal Error

Page 16: SimXpert R3.2 Explicit Workspace Guide

Preliminaries16

PreliminariesConsider the body shown in Figure 0-1. We are interested in time-dependent deformation in which a

point in b initially at in a fixed rectangular Cartesian coordinate system moves to a

point in the same coordinate system. Since a Lagrangian formulation is considered,

the deformation can be expressed in terms of the convected coordinates , and time

(0-1)

At time , we have the initial conditions

(0-2)

(0-3)

where defines the initial velocities.

Governing EquationsWe seek a solution to the momentum equation

(0-4)

satisfying the traction boundary conditions

(0-5)

on boundary , the displacement boundary conditions

(0-6)

on boundary , the contact discontinuity

(0-7)

Xα α 1 2 3, ,=( )

xi i 1 2 3, ,=( )

Xα t

xi xi Xα t,( )=

t 0=

xi Xα 0,( ) Xα=

x· i Xα 0,( ) Vi Xα( )=

Vi

σij j, ρfi+ ρx··i=

σijnj ti t( )=

∂b1

xi Xα t,( ) Di t( )=

∂b2

σij+ σij

-–( )ni 0=

Page 17: SimXpert R3.2 Explicit Workspace Guide

17ElementsPreliminaries

along an interior boundary when . Here is the Cauchy stress, is the current

density, is the body force density, is acceleration, the comma denotes covariant differentiation, and

is a unit outward normal to a boundary element of .

Figure 0-1 Notation

Mass conservation is trivially stated

(0-8)

where is the relative volume, i.e., the determinant of the deformation gradient matrix, ,

(0-9)

and is the reference density. The energy equation

(0-10)

∂b3 Xi+ xi

-= σij ρ

f x··

nj ∂b

x3 X3

x2 X2

t 0=

∂B

B0

b

n

∂b

x1X1

ρV ρ0=

V Fij

Fij

∂xi

∂Xj--------=

ρ0

E· Vsijε·

ij p q+( )V·–=

Page 18: SimXpert R3.2 Explicit Workspace Guide

Preliminaries18

is integrated in time and is used for equation of state evaluations and a global energy balance. In Equation

(0-10), and represent the deviatoric stresses and pressure,

(0-11)

(0-12)

respectively, is the bulk viscosity, is the Kronecker delta ( if ; otherwise

) and is the strain rate tensor. The strain rates and bulk viscosity are discussed later.

We can write:

(0-13)

where satisfies all boundary conditions on , and the integrations are over the current geometry.

Application of the divergence theorem gives

(0-14)

and noting that

(0-15)

leads to the weak form of the equilibrium equations:

(0-16)

a statement of the principle of virtual work.

We superimpose a mesh of finite elements interconnected at nodal points on a reference configuration and track particles through time; i.e.,

sij p

sij σij p q+( )δij+=

p13---σijδij– q–

13---σkk– q–= =

q δij δij 1= i j=

δij 0= ε· ij

ρx··i σij j,– ρfi–( )δxi ν σijnj ti–( )δxi s

σij+ σij

-–( )njδxi sd∂b3

+

d∂b1

+dv

0=

δxi ∂b2

σijδxi( ) dυj,υ σijnjδxi s σij

+ σij-–( )njδxi sd

∂b3

+d∂b1

=

σijδxi( ) σij j, δxi–j, σijδxi j,=

δπ ρx··iδxi υ σijδxi j, υ ρfiδxi υ tiδxi sd∂b1

–dυ–d

υ+d

υ 0= =

Page 19: SimXpert R3.2 Explicit Workspace Guide

19ElementsPreliminaries

(0-17)

where are shape (interpolation) functions of the parametric coordinates , is the number of

nodal points defining the element, and is the nodal coordinate of the jth node in the ith direction.

Summing over the n elements we may approximate with

(0-18)

and write

(0-19)

where

(0-20)

In matrix notation (0-19) becomes:

(0-21)

where is an interpolation matrix, is the stress vector

(0-22)

is the strain-displacement matrix, is the nodal acceleration vector

xi Xα t,( ) xi Xα ξ η ζ,,( ) t,( ) φj ξ η ζ,,( )xij t( )

j 1=

k

= =

φj ξ η ζ,,( ) k

xij

δπ

δπ δπm

m 1=

n

0= =

ρx··iΦim υ σij

mΦi j,m υ ρfiΦi

m υ tiΦim sd

∂b1

–d

υm

–d

υm

+d

υm

m 1=

n

0=

Φim φ1 φ2 … φk,,,( )i

m=

ρNtNa υ Btσ υ ρNtb υ Ntt sd∂b1

–dυm

–dυm

+dυm

m

m 1=

n

0=

N σ

σt σxx σyy σzz σxy σyz σzx, , , , ,( )=

B a

Page 20: SimXpert R3.2 Explicit Workspace Guide

Preliminaries20

(0-23)

is the body force load vector, and are applied traction loads.

(0-24)

x··1x··2x··3

N

ax1

ay1

ayk

azk

Na= =…

b t

b

fx

fy

fz

= t

tx

ty

tz

=

Page 21: SimXpert R3.2 Explicit Workspace Guide

21ElementsCHEXA Solid Elements

CHEXA Solid ElementsFor a mesh of 8-node hexahedron solid elements, (0-17) becomes:

(0-25)

The shape function is defined for the 8-node hexahedron as

(0-26)

where take on their nodal values of and is the nodal coordinate of the th

node in the th direction (see Figure 0-2).

Figure 0-2 Eight-node Solid Hexahedron Element

For a solid element, is the 3 x 24 rectangular interpolation matrix given by

xi Xα t,( ) xi Xα ξ η ζ,,( ) t,( ) φj ξ η ζ,,( )xij t( )

j 1=

8

= =

φj

φj18--- 1 ξξj+( ) 1 ηηj+( ) 1 ζζj+( )=

ξj ηj ζj,, 1 1 1±,±,±( ) xij j

i

2

3

4

8

7

5

6

ζ

η

Node12345678

ξ-111

-1-111

-1

η-1-111

-1-111

ζ-1-1-1-11111

N

Page 22: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements22

(0-27)

is the stress vector

(0-28)

is the 6 x 24 strain-displacement matrix

(0-29)

In order to achieve a diagonal mass matrix the rows are summed giving the th diagonal term as

(0-30)

since the basis functions sum to unity.

Terms in the strain-displacement matrix are readily calculated. Note that

N ξ η ζ,,( )φ1 0 0 φ2 0 … 0 0

0 φ1 0 0 φ2 … φ8 0

0 0 φ1 0 0 … 0 φ8

=

σ

σt σxx σyy σzz σxy σyz σzx, , , , ,( )=

B

B

∂∂x----- 0 0

0∂

∂y----- 0

0 0∂∂z-----

∂∂y----- ∂

∂x----- 0

0∂∂z----- ∂

∂y-----

∂∂z----- 0

∂∂x-----

N=

k

mkk ρφk φi

i 1=

8

υdυ ρφk υd

υ= =

Page 23: SimXpert R3.2 Explicit Workspace Guide

23ElementsCHEXA Solid Elements

(0-31)

which can be rewritten as

(0-32)

Inverting the Jacobian matrix, , we can solve for the desired terms

(0-33)

Volume IntegrationVolume integration is carried out with Gaussian quadrature. If is some function defined over the

volume, and is the number of integration points, then

(0-34)

is approximated by

∂φi

∂ξ-------

∂φi

∂x-------∂x

∂ξ------

∂φi

∂y-------∂y

∂ξ------

∂φi

∂z------- ∂z

∂ξ------+ +=

∂φi

∂η-------

∂φi

∂x------- ∂x

∂η------

∂φi

∂y------- ∂y

∂η------

∂φi

∂z------- ∂z

∂η------+ +=

∂φi

∂ζ-------

∂φi

∂x-------∂x

∂ζ------

∂φi

∂y-------∂y

∂ζ------

∂φi

∂z------- ∂z

∂ζ------+ +=

∂φi

∂ξ-------

∂φi

∂η-------

∂φi

∂ζ-------

∂x∂ξ------ ∂y

∂ξ------ ∂z

∂ξ------

∂x∂η------ ∂y

∂η------ ∂z

∂η------

∂x∂ζ------ ∂y

∂ζ------ ∂z

∂ζ------

∂φi

∂x-------

∂φi

∂y-------

∂φi

∂z-------

J

∂φi

∂x-------

∂φi

∂y-------

∂φi

∂z-------

= =

J

∂φi

∂x-------

∂φi

∂y-------

∂φi

∂z-------

J 1–

∂φi

∂ξ-------

∂φi

∂η-------

∂φi

∂ζ-------

=

g

n

g υd

υ g J ξd ηd ζd

1–

11–

11–

1=

Page 24: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements24

(0-35)

where are the weighting factors,

(0-36)

and is the determinant of the Jacobian matrix. For one-point quadrature

(0-37)

and we can write

(0-38)

Note that approximates the element volume.

Perhaps the biggest advantage to one-point integration is a substantial savings in computer time. An anti-symmetry property of the strain matrix

(0-39)

at reduces the amount of effort required to compute this matrix by more than 25 times over an 8-point integration. This cost savings extends to strain and element nodal force calculations where the number of multiplies is reduced by a factor of 16. Because only one constitutive evaluation is needed, the time spent determining stresses is reduced by a factor of eight. Operation counts for the

gjkl Jjkl wjwkwl

l 1=

n

k 1=

n

j 1=

n

wj wk wl, ,

gjkl g ξj ηk ζl, ,( )=

J

n 1=wi wj wk 2= = =ξ1 η1 ζ1 0= = =

g vd 8g 0 0 0,,( ) J 0 0 0,,( )=

8 J 0 0 0,,( )

∂φ1

∂xi--------

∂φ7

∂xi--------–=

∂φ3

∂xi--------

∂φ5

∂xi--------–=

∂φ2

∂xi--------

∂φ8

∂xi--------–=

∂φ4

∂xi--------

∂φ6

∂xi--------–=

ξ η ζ 0= = =

Page 25: SimXpert R3.2 Explicit Workspace Guide

25ElementsCHEXA Solid Elements

constant stress hexahedron are given in Table 0-2. Included are counts for the Flanagan and Belytschko [1981] hexahedron and the hexahedron used by Wilkins [1974] in his integral finite difference method, which was also implemented [Hallquist 1979].

.

It may be noted that 8-point integration has another disadvantage in addition to cost. Fully integrated elements used in the solution of plasticity problems and other problems where Poisson’s ratio approaches .5 lock up in the constant volume bending modes. To preclude locking, an average pressure must be used over the elements; consequently, the zero energy modes are resisted by the deviatoric stresses. If the deviatoric stresses are insignificant relative to the pressure or, even worse, if material failure causes loss of this stress state component, hourglassing will still occur, but with no means of resisting it. Sometimes, however, the cost of the fully integrated element may be justified by increased reliability and if used sparingly may actually increase the overall speed.

Hourglass ControlThe biggest disadvantage to one-point integration is the need to control the zero energy modes, which arise, called hourglassing modes. Undesirable hourglass modes tend to have periods that are typically much shorter than the periods of the structural response, and they are often observed to be oscillatory. However, hourglass modes that have periods that are comparable to the structural response periods may be a stable kinematic component of the global deformation modes and must be admissible. One way of resisting undesirable hourglassing is with a viscous damping or small elastic stiffness capable of stopping the formation of the anomalous modes but having a negligible affect on the stable global modes. Two of the early three-dimensional algorithms for controlling the hourglass modes were developed by Kosloff and Frazier [1974] and Wilkins et al. [1974].

Since the hourglass deformation modes are orthogonal to the strain calculations, work done by the hourglass resistance is neglected in the energy equation. This may lead to a slight loss of energy; however, hourglass control is always recommended for the under integrated solid elements. The energy

Table 0-2 Operation Counts for Constant Stress Hexahedron*

Flanagan-Wilkins

SOL 700 Belytschko [1981] FDM

Strain displacement matrix 94 357 843

Strain rates 87 56

Force 117 195 270

Subtotal 298 708 1,113

Hourglass control 130 620 680

Total 428 1,328 1,793

*Includes adds, subtracts, multiplies, and divides in major subroutines, and is independent of vectorization.

Page 26: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements26

dissipated by the hourglass forces reacting against the formations of the hourglass modes is tracked and reported in the output files MATSUM and GLSTAT. This is only provided if the PARM,DYENERGYGE is included.

It is easy to understand the reasons for the formation of the hourglass modes. Consider the following strain rate calculations for the 8-node solid element

(0-1)

Whenever diagonally opposite nodes have identical velocities; i.e.,

(0-2)

the strain rates are identically zero:

(0-3)

due to the asymmetries in (0-39). It is easy to prove the orthogonality of the hourglass shape vectors, which are listed in Table 0-3 and shown in Figure 0-2 with the derivatives of the shape functions:

(0-4)

Table 0-3 Hourglass Base Vectors

1 1 1 1

-1 1 -1 -1

1 -1 -1

-1 -1 1 -1

1 -1 -1 -1

-1 -1 1 1

ε· ij12---

∂φk

∂xi--------x· j

k ∂φk

∂xj--------x· i

k+

k 1=

8

=

x· i1 x· i

7 x· i2, x· i

8 x· i3, x· i

5 x· i4, x· i

6= = = =

ε· ij 0=

∂φk

∂xi--------Γαk

k 1=

8

0= i 1 2 3,,= α 1 2 3 4,,,=

α 1= α 2= α 3= α 4=

Γj1

Γj2

Γj3

Γj4

Γj5

Γj6

Page 27: SimXpert R3.2 Explicit Workspace Guide

27ElementsCHEXA Solid Elements

The hourglass modes of an 8-node element with one integration point are shown [Flanagan and Belytschko 1981] (Figure 0-3). A total of twelve modes exist.

Figure 0-3 Hourglass Modes

The product of the base vectors with the nodal velocities

(0-1)

are nonzero if hourglass modes are present. The 12 hourglass-resisting force vectors, are

(0-2)

where

1 1 1 -1

-1 1 -1 1

Table 0-3 Hourglass Base Vectors

α 1= α 2= α 3= α 4=

Γj7

Γj8

Γ1k Γ2k

Γ3k Γ4k

hiα x· ikΓαk

k 1=

8

0= =

fiαk

fiαk ahhiαΓαk=

Page 28: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements28

(0-3)

in which is the element volume, is the material sound speed, and is a user-defined constant

usually set to a value between .05 and .15. This is defined by DYHRGQH PARAM. The hourglass resisting forces of (0-2) are not orthogonal to rigid body rotations; however, the approach of Flanagan and Belytschko [1981] is orthogonal. This is controlled by using the DYHRGIHQ PARAM.

Material subroutines add as little as 60 operations for the bilinear elastic-plastic routine to ten times as much for multi-surface plasticity and reactive flow models. Unvectorized material models will increase that share of the cost a factor of four or more.

Instead of resisting components of the bilinear velocity field that are orthogonal to the strain calculation, Flanagan and Belytschko resist components of the velocity field that are not part of a fully linear field. They call this field, defined below, the hourglass velocity field

(0-4)

where

(0-5)

(0-6)

Flanagan and Belytschko construct geometry-dependent hourglass shape vectors that are orthogonal to the fully linear velocity field and the rigid body field. With these vectors they resist the hourglass velocity deformations. Defining hourglass shape vectors in terms of the base vectors as

(0-7)

ah Qhgρνe2 3⁄ c

4---=

νe c Qhg

x· ikHG x· i x· i

kLIN–=

x· ikLIN x· i x· i j, xj

k xj–( )+=

xi18--- xi

k

k 1=

8

= x· i18--- x· i

k

k 1=

8

=

γak Γak φk i, xinΓan

n 1=

8

–=

Page 29: SimXpert R3.2 Explicit Workspace Guide

29ElementsCHEXA Solid Elements

and setting

(0-8)

the 12 resisting force vectors become

(0-9)

where is a constant given in (0-2).

The hourglass forces given by (0-2) and (0-9) are identical if the, hexahedron element is a parallelepiped. The default hourglass control method for solid element is given by (0-2); however, we recommend the Flanagan-Belytschko approach for problems that have large rigid body rotations since the default approach is not orthogonal to rigid body rotations.

A cost comparison in Table 0-2 shows that the default hourglass viscosity requires approximately 130 adds or multiplies per hexahedron, compared to 620 and 680 for the algorithms of Flanagan-Belytschko and Wilkins.

Hourglass stabilization for the 3-D hexahedral element is available. Based on material properties and element geometry, this stiffness type stabilization is developed by an assumed strain method [Belytschko and Bindeman 1993] such that the element does not lock with nearly incompressible material. This is

activated by using the PARAM,DYHRGIHG,6. When the user-defined hourglass constant is set to

1.0, accurate coarse mesh bending stiffness is obtained for elastic material. For nonlinear material, a

smaller value of is suggested and the default value is set to 0.1.

Fully Integrated Brick Elements and Mid-Step Strain EvaluationTo avoid locking in the fully integrated brick elements strain increments at a point in a constant pressure, solid element are defined by [see Nagtegaal, Parks, and Rice 1974]

gia x· ikγαk

k 1=

8

0= =

fiαk ahgiαγαk=

ah

Qhg

Qhg

Page 30: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements30

(0-10)

where modifies the normal strains to ensure that the total volumetric strain increment at each integration point is identical

(0-11)

and is the average volumetric strain increment in the midpoint geometry

(0-12)

, and are displacement increments in the , and directions, respectively, and

(0-13)

(0-14)

(0-15)

Δεyy∂Δv

∂yn 1 2⁄+------------------- φ+= Δεyz

∂Δw∂yn 1 2⁄+------------------- ∂Δv

∂zn 1 2⁄+------------------+

2--------------------------------------------=

Δεxx∂Δu

∂xn 1 2⁄+------------------- φ+= Δεxy

∂Δν∂xn 1 2⁄+------------------- ∂Δu

∂yn 1 2⁄+-------------------+

2---------------------------------------------=

Δεzz∂Δw

∂zn 1 2⁄+------------------ φ+= Δεzx

∂Δu∂zn 1 2⁄+------------------ ∂Δw

∂xn 1 2⁄+-------------------+

2--------------------------------------------=

φ

φ Δεvn 1 2⁄+

∂Δu∂xn 1 2⁄+------------------- ∂Δν

∂yn 1 2⁄+------------------- ∂Δw

∂zn 1 2⁄+------------------+ +

3----------------------------------------------------------------------–=

Δενn 1 2⁄+

13--- ∂Δu

∂xn 1 2⁄+------------------- ∂Δν

∂yn 1 2⁄+------------------- ∂Δw

∂zn 1 2⁄+------------------+ +

vn 1 2⁄+d

vn 1 2⁄+

vn 1 2⁄+d

vn 1 2⁄+

-----------------------------------------------------------------------------------------------------------------

Δu Δv, Δw x y, z

xn 1 2⁄+ xn xn 1++( )2

----------------------------=

yn 1 2⁄+ yn yn 1++( )2

----------------------------=

zn 1 2⁄+ zn zn 1++( )2

----------------------------=

Page 31: SimXpert R3.2 Explicit Workspace Guide

31ElementsCHEXA Solid Elements

To satisfy the condition that rigid body rotations cause zero straining, it is necessary to use the geometry at the mid-step in the evaluation of the strain increments. The explicity formulation uses the geometry at

step to save operations; however, for calculations, which involve rotating parts, the mid-step geometry should be used especially if the number of revolutions is large.

Since the bulk modulus is constant in the plastic and viscoelastic material models, constant pressure solid elements result. In the thermoelastoplastic material, a constant temperature is assumed over the element. In the soil and crushable foam material, an average relative volume is computed for the element at time

step , and the pressure and bulk modulus associated with this relative volume is used at each integration point. For equations of state, one pressure evaluation is done per element and is added to the deviatoric stress tensor at each integration point.

The foregoing procedure requires that the strain-displacement matrix corresponding to (0-10) and

consistent with a constant volumetric strain, , be used in the nodal force calculations [Hughes 1980]. It is easy to show that:

(0-16)

and avoid the needless complexities of computing .

CTETRA - Four Node Tetrahedron ElementThe four node tetrahedron element with one point integration, shown in Figure 0-4, is a simple, fast, solid element that has proven to be very useful in modeling low density foams that have high compressibility. For most applications, however, this element is too stiff to give reliable results and is primarily used for transitions in meshes. The formulation follows the formulation for the one point solid element with the difference that there are no kinematic modes, so hourglass control is not needed. The basis functions are given by:

n 1+

n 1+

B

F Bn 1 t+ σn 1+ vn 1+d

vn 1+

Bn 1t+ σn 1+ vn 1+d

vn 1+

= =

B

Page 32: SimXpert R3.2 Explicit Workspace Guide

CHEXA Solid Elements32

(0-17)

Figure 0-4 Four-node tetrahedron

If a tetrahedron element is needed, this element should be used instead of the collapsed solid element since it is, in general, considerably more stable in addition to being much faster.

CPENTA - Six Node Pentahedron ElementThe pentahedron element with two point Gauss integration along its length, shown in Figure 0-5, is a solid element that has proven to be very useful in modeling axisymmetric structures where wedge shaped elements are used along the axis-of-revolution. The formulation follows the formulation for the one point solid element with the difference that, like the tetrahedron element, there are no kinematic modes, so hourglass control is not needed. The basis functions are given by:

N1 r s t, ,( ) r=N2 r s t, ,( ) s=N3 r s t, ,( ) 1 r– s– –=N4 r s t, ,( ) t=

r1

2

s

3

4

t

Page 33: SimXpert R3.2 Explicit Workspace Guide

33ElementsCHEXA Solid Elements

(0-18)

If a pentahedron element is needed, this element should be used instead of the collapsed solid element since it is, in general, more stable and significantly faster. Selective-reduced integration is used to prevent volumetric locking; i.e., a constant pressure over the domain of the element is assumed.

Figure 0-5 Six Node Pentahedron

N1 r s t, ,( ) 12--- 1 t–( )r=

N2 r s t, ,( ) 12--- 1 t–( ) 1 r– –(=

N3 r s t, ,( ) 12--- 1 t+( ) 1 r– –(=

N4 r s t, ,( ) 12--- 1 t+( )r=

N5 r s t, ,( ) 12--- 1 t–( )s=

N6 r s t, ,( ) 12--- 1 t+( )s=

51

r

4

2

6

s

t

Page 34: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam34

CBEAM - Belytschko BeamThe Belytschko beam element formulation [Belytschko et. al.1977] is part of a family of structural finite elements, by Belytschko and other researchers that employ a ‘co-rotational technique’ in the element formulation for treating large rotation. This section discusses the co-rotational formulation, since the formulation is most easily described for a beam element, and then describes the beam theory used to formulate the co-rotational beam element.

Co-rotational TechniqueIn any large displacement formulation, the goal is to separate the deformation displacements from the rigid body displacements, as only the deformation displacements give rise to strains and the associated generation of strain energy. This separation is usually accomplished by comparing the current configuration with a reference configuration.

The current configuration is a complete description of the deformed body in its current spatial location and orientation, giving locations of all points (nodes) comprising the body. The reference configuration can be either the initial configuration of the body (i.e., nodal locations at time zero) or the configuration of the body at some other state (time). Often, the reference configuration is chosen to be the previous

configuration, say at time .

The choice of the reference configuration determines the type of deformations that will be computed: total deformations result from comparing the current configuration with the initial configuration, while incremental deformations result from comparing with the previous configuration. In most time stepping (numerical) Lagrangian formulations, incremental deformations are used because they result in significant simplifications of other algorithms, chiefly constitutive models.

A direct comparison of the current configuration with the reference configuration does not result in a determination of the deformation, but rather provides the total (or incremental) displacements. We will use the unqualified term displacements to mean either the total displacements or the incremental displacements, depending on the choice of the reference configuration as the initial or the last state. This is perhaps most obvious if the reference configuration is the initial configuration. The direct comparison of the current configuration with the reference configuration yields displacements, which contain components due to deformations and rigid body motions. The task remains of separating the deformation and rigid body displacements. The deformations are usually found by subtracting from the displacements an estimate of the rigid body displacements. Exact rigid body displacements are usually only known for trivial cases where they are prescribed a priori as part of a displacement field. The co-rotational formulations provide one such estimate of the rigid body displacements.

The co-rotational formulation uses two types of coordinate systems: one system associated with each element; i.e., element coordinates which deform with the element, and another associated with each node; i.e., body coordinates embedded in the nodes. (The term ‘body’ is used to avoid possible confusion from referring to these coordinates as ‘nodal’ coordinates. Also, in the more general formulation presented in

tn tn 1+ Δt–=

Page 35: SimXpert R3.2 Explicit Workspace Guide

35ElementsCBEAM - Belytschko Beam

[Belytschko et al., 1977], the nodes could optionally be attached to rigid bodies. Thus, the term ‘body coordinates’ refers to a system of coordinates in a rigid body, of which a node is a special case.) These two coordinate systems are shown in the upper portion of Figure 0-6.

Figure 0-6 Co-rotational Coordinate System

Y

IX

Y^

e2

b2

e1

b1

J

X^

X

YY

X

e10

b1

e2

b2

e1 J

X

J

e10

I

e20

X

b1

b2

YY^

(a) Initial Configuration

(b) Rigid Rotation Configuration

(c) Deformed Configuration

Page 36: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam36

The element coordinate system is defined to have the local x-axis originating at node and

terminating at node ; the local y-axis and, in three dimension, the local z-axis , are constructed

normal to . The element coordinate system and associated unit vector triad are

updated at every time step by the same technique used to construct the initial system; thus the unit vector

deforms with the element since it always points from node to node .

The embedded body coordinate system is initially oriented along the principal inertial axes; either the assembled nodal mass or associated rigid body inertial tensor is used in determining the inertial principal values and directions. Although the initial orientation of the body axes is arbitrary, the selection of a principal inertia coordinate system simplifies the rotational equations of motion; i.e., no inertial cross product terms are present in the rotational equations of motion. Because the body coordinates are fixed in the node (or rigid body), they rotate and translate with the node and are updated by integrating the rotational equations of motion, as will be described subsequently.

The unit vectors of the two coordinate systems define rotational transformations between the global coordinate system and each respective coordinate system. These transformations operate on vectors with

global components , body coordinates components , and

element coordinate components which are defined as:

(0-19)

where are the global components of the body coordinate unit vectors. Similarly for the

element coordinate system:

(0-20)

where are the global components of the element coordinate unit vectors. The inverse

transformations are defined by the matrix transpose: i.e.,

x I

J y z

x x y z, ,( ) e1 e2 e3, ,( )

e1 I J

A Ax Ay Az, ,( )= A Ax Ay Az, ,=

A Ax Ay Az, ,=

A

Ax

Ay

Az

b1x b2x b3x

b1y b2y b3y

b1z b2z b3z

Ax

Ay

Az

λ[ ] A{ }= = =

bix biy biz, ,

A

Ax

Ay

Az

e1x e2x e3x

e1y e2y e3y

e1z e2z e3z

Ax

Ay

Az

μ[ ] A{ }= = =

eix eiy eiz, ,

Page 37: SimXpert R3.2 Explicit Workspace Guide

37ElementsCBEAM - Belytschko Beam

(0-21)

(0-22)

since these are proper rotational transformations.

The following two examples illustrate how the element and body coordinate system are used to separate the deformations and rigid body displacements from the displacements.

Rigid Rotation

First, consider a rigid body rotation of the beam element about node , as shown in the center of

Figure 0-6b; i.e., consider node to be a pinned connection. Because the beam does not deform during

the rigid rotation, the orientation of the unit vector in the initial and rotated configuration will be the

same with respect to the body coordinates. If the body coordinate components of the initial element unit

vector were stored, they would be identical to the body coordinate components of the current element

unit vector .

Deformation Rotation

Next, consider node to be constrained against rotation; i.e., a clamped connection. Now node is moved, as shown in the lower portion of Figure 0-6, causing the beam element to deform. The updated

element unit vector is constructed and its body coordinate components are compared to the body

coordinate components of the original element unit vector . Because the body coordinate system did

not rotate, as node was constrained, the original element unit vector and the current element unit vector are not co-linear. Indeed, the angle between these two unit vectors is the amount of rotational deformation

at node ; i.e.,

(0-23)

Thus the co-rotational formulation separates the deformation and rigid body deformations by using:

• a coordinate system that deforms with the element; i.e., the element coordinates or• a coordinate system that rigidly rotates with the nodes; i.e., the body coordinates.

Then, it compares the current orientation of the element coordinate system with the initial element coordinate system, using the rigidly rotated body coordinate system, to determine the deformations.

Belytschko Beam Element FormulationThe deformation displacements used in the Belytschko beam element formulation are:

A{ } λ[ ]TA{ }=

A{ } μ[ ]TA{ }=

I

I

e1

e10

e1

I J

e1

e10

I

I

e1 e10× θe3=

Page 38: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam38

(0-24)

where

= length change

= torsional deformation

= bending rotational deformations

The superscript emphasizes that these quantities are defined in the local element coordinate system,

and and are the nodes at the ends of the beam.

The beam deformations, defined in (0-19), are the usual small displacement beam deformations (see, for example, [Przemieniecki 1986]). Indeed, one advantage of the co-rotational formulation is the ease with which existing small displacement element formulations can be adapted to a large displacement formulation having small deformations in the element system. Small deformation theories can be easily accommodated because the definition of the local element coordinate system is independent of rigid body rotations and hence deformation displacement can be defined directly.

Calculation of DeformationsThe elongation of the beam is calculated directly from the original nodal coordinates and

the total displacements :

(0-25)

where

(0-26)

etc. (0-27)

The deformation rotations are calculated using the body coordinate components of the original element

coordinate unit vector along the beam axis; i.e., , as outlined in the previous section. Because the body

coordinate components of initial unit vector rotate with the node, in the deformed configuration it

dT δIJ θxJI θyI θyJ θzI θzJ, , , , ,{ }=

δIJ

θxJI

θyI θyJ θzI θzJ, , ,

ˆ

I J

XI YI ZI, ,( )

uxI uyI uzI, ,( )

δIJ1

l lo+------------ 2 XJIuxJI YJIuyJI ZJIuzJI+ +( ) uxJI

2 uyJI2 uzJI

2+ + +[ ]=

XJI XJ XI–=

uxJI uxJ uxI–=

e10

e10

Page 39: SimXpert R3.2 Explicit Workspace Guide

39ElementsCBEAM - Belytschko Beam

indicates the direction of the beam’s axis if no deformations had occurred. Thus comparing the initial unit

vector with its current orientation indicates the magnitude of deformation rotations. Forming the

vector cross product between and :

(0-28)

where

is the incremental deformation about the local axis

is the incremental deformation about the local axis

The calculation is most conveniently performed by transforming the body components of the initial element vector into the current element coordinate system:

(0-29)

Substituting the above into (0-28)

(0-30)

Thus,

(0-31)

(0-32)

e10 e1

e10 e1

e1 e10× θye2 θze3+=

θy y

θz z

e1x0

e1y0

e1z0

μ[ ]T λ[ ]e1x

0

e1y0

e1z0

=

e1 e10× det

e1 e2 e3

1 0 0

e1x0 e1y

0 e1z0

e1z0 e2– e1y

0 e3+ θye2 θze3+= = =

θyˆ e1z

0–=

θzˆ e1y

0=

Page 40: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam40

The torsional deformation rotation is calculated from the vector cross product of initial unit vectors, from

each node of the beam, that were normal to the axis of the beam, i.e., and ; note that and

could also be used. The result from this vector cross product is then projected onto the current axis

of the beam; i.e.,

(0-33)

Note that the body components of and are transformed into the current element coordinate

system before performing the indicated vector products.

Calculation of Internal ForcesThere are two methods for computing the internal forces for the Belytschko beam element formulation:

• Functional forms relating the overall response of the beam- e.g., moment-curvature relations,• Direct through-the-thickness integration of the stress.

Currently only the former method, as explained subsequently, is implemented; the direct integration method is detailed in [Belytschko et al., 1977].

Axial Force

The internal axial force is calculated from the elongation of the beam , as given by (0-25), and an axial stiffness:

(0-34)

where:

is the axial stiffness

is the cross sectional area of the beam

is Young’s Modulus

is the original length of the beam

e2I0 e2J

0 e3I0

e3J0

θxJI e1 e2I0 e2J

0×( )⋅ e1det

e1 e2 e3

ex2I0 ey2I

0 ez2I0

ex2J0 ey2J

0 ez2J0

ey2I0 ez2J

0 ey2J0 ez2I

0–= = =

e2I0 e2J

0

δ

fxJ Kaδ=

Ka AE l0⁄=

A

E

l0

Page 41: SimXpert R3.2 Explicit Workspace Guide

41ElementsCBEAM - Belytschko Beam

Bending Moments

The bending moments are related to the deformation rotations by

(0-35)

(0-36)

where (0-35) is for bending in the plane and (0-36) is for bending in the plane. The bending constants are given by

(0-37)

(0-38)

(0-39)

(0-40)

(0-41)

Hence is the shear factor, the shear modulus, and is the effective area in shear.

Torsional Moment

The torsional moment is calculated from the torsional deformation rotation as

(0-42)

where

myI

myJ Ky

b

1 φy+--------------

4 φy+ 2 φy–

2 φy– 4 φy+

θyI

θyJ

=

mzI

mzJ Kz

b

1 φz+--------------

4 φz+ 2 φz–

2 φz– 4 φz+

θzI

θzJ

=

x z– x y–

Kyb EIyy

l0----------=

Kzb EIzz

l0----------=

Iyy z2 yd zd=

Izz y2 yd zd=

φy

12EIyy

GAsl2

----------------= φz

12EIzz

GAsl2

----------------=

φ G As

mxJ KtθxJI=

Page 42: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam42

(0-43)

(0-44)

The above forces are conjugate to the deformation displacements given previously in (0-24); i.e.,

(0-45)

where

(0-46)

(0-47)

The remaining internal force components are found from equilibrium:

(0-48)

Updating the Body Coordinate Unit Vectors

The body coordinate unit vectors are updated using the Newmark -Method [Newmark 1959] with

, which is almost identical to the central difference method [Belytschko 1974]. In particular, the body component unit vectors are updated using the formula

(0-49)

where the superscripts refer to the time step and the subscripts refer to the three unit vectors comprising the body coordinate triad. The time derivatives in the above equation are replaced by their equivalent forms from vector analysis:

(0-50)

Kt GJl0

-------=

J yz yd zd=

dT δIJ θxJI θyI θyJ θzI θzJ, , , , ,{ }=

d{ }T f{ } Wint=

fT fxJ mxJ myI myJ mzI mzJ, , , , ,{ }=

fxI fxJ–= mxI m– xJ=

fzImyI myJ+

l0-----------------------–= fzI fzJ–=

fyJmzI mzJ+

l0-----------------------–= fyI fyJ–=

ββ 0=

bij 1+

bij Δt

dbij

dt-------- Δt2

2--------

d2bij

dt2----------+ +=

dbij

dt-------- ω bi×=

Page 43: SimXpert R3.2 Explicit Workspace Guide

43ElementsCBEAM - Belytschko Beam

(0-51)

where and are vectors of angular velocity and acceleration, respectively, obtained from the rotational equations of motion. With the above relations substituted into (0-49), the update formula for the unit vectors becomes

(0-52)

To obtain the formulation for the updated components of the unit vectors, the body coordinate system is temporarily considered to be fixed and then the dot product of (0-52) is formed with the unit vector to be

updated. For example, to update the component of , the dot product of (0-52), with , is

formed with , which can be simplified to the relation

(0-53)

Similarly,

(0-54)

(0-55)

The remaining components and are found by using normality and orthogonality, where it

is assumed that the angular velocities are small during a time step so that the quadratic terms in the

update relations can be ignored. Since is a unit vector, normality provides the relation

(0-56)

Next, if it is assumed that , orthogonality yields (0-57)

d2bij

dt2---------- ω ω bi×( )× αi bi×( )+=

ω α

bij 1+ bi

j Δt ω bi×( ) Δt2

2-------- ω ω bi×( ) αi bi×( )+×[ ]{ }+ +=

x b3 i 3=

b1

bx3j 1+

b1j by3

j 1+⋅ Δtωyj Δt2

2-------- ωx

j ωzj αy

j+( )+= =

by3j 1+

b2j b3

j 1+⋅ Δtωxj Δt2

2-------- ωy

j ωzj αx

j+( )+= =

bx2j 1+

b1j b2

j 1+⋅ Δtωzj Δt2

2-------- ωx

j ωyj αz

j+( )+= =

b3j 1+ b1

j 1+

ω

b3j 1+

bz3j 1+

1 bx3j 1+( )2

– by3j 1+( )2

–=

bx1j 1+

1≈

Page 44: SimXpert R3.2 Explicit Workspace Guide

CBEAM - Belytschko Beam44

(0-58)

The component is then found by enforcing normality:

(0-59)

The updated components of and are defined relative to the body coordinates at time step . To

complete the update and define the transformation matrix, (0-19), at time step , the updated unit

vectors and are transformed to the global coordinate system, using (0-19) with defined at

step , and their vector cross product is used to form

bz1j 1+ bx3

j 1+by1

j 1+by3

j 1++

bz3j 1+

------------------------------------------–=

bx1j 1+

bx1j 1+

1 by1j 1+( )2

– bz1j 1+( )2

–=

b1 b3 j

j 1+

b1 b3 λ[ ]

j b2

Page 45: SimXpert R3.2 Explicit Workspace Guide

45ElementsCBEAM - DYSHELFORM = 1, Hughes-Liu Beam

CBEAM - DYSHELFORM = 1, Hughes-Liu BeamThe Hughes-Liu beam element formulation, based on the shell [Hughes and Liu 1981a, 1981b] discussed later. It has several desirable qualities:

• It is incrementally objective (rigid body rotations do not generate strains), allowing for the treatment of finite strains that occur in many practical applications.

• It is simple, which usually translates into computational efficiency and robustness.

• It is compatible with the brick elements, because the element is based on a degenerated brick element formulation.

• It includes finite transverse shear strains. The added computations needed to retain this strain component, compare to those for the assumption of no transverse shear strain, are insignificant.

GeometryThe Hughes-Liu beam element is based on a degeneration of the isoparametric 8-node solid element, an approach originated by Ahmad et al., [1970]. Recall the solid element isoparametric mapping of the biunit cube

(0-60)

(0-61)

where is an arbitrary point in the element, are the parametric coordinates, are the global

nodal coordinates of node , and are the element shape functions evaluated at node , i.e.,

are evaluated at node .

In the beam geometry, determines the location along the axis of the beam and the coordinate pair

defines a point on the cross section. To degenerate the 8-node brick geometry into the 2-node

beam geometry, the four nodes at and at are combined into a single node with three translational and three rotational degrees of freedom. Orthogonal, inextensible nodal fibers are defined at each node for treating the rotational degrees of freedom. Figure 0-7 shows a schematic of the bi-unit cube and the beam element. The mapping of the bi-unit cube into the beam element is separated into three parts:

(0-62)

x ξ η ζ,,( ) Na ξ η ζ,,( )xa=

Na ξ η ζ,,( )1 ξaξ+( ) 1 ηaη+( ) 1 ζaζ+( )

8-----------------------------------------------------------------------=

x ξ η ζ,,( ) xa

a Na a

ξa ηa ζa,, ξ η ζ,,( ) a

ξη ζ,( )

ξ 1–= ξ 1=

x ξ η ζ,,( ) x ξ( ) X ξ η ζ,,( )+ x ξ( ) Xζ ξ ζ,( ) Xη ξ η,( )+ += =

Page 46: SimXpert R3.2 Explicit Workspace Guide

CBEAM - DYSHELFORM = 1, Hughes-Liu Beam46

Figure 0-7 Hughes-Liu Beam Element

where denotes a position vector to a point on the reference axis of the beam, and and are

position vectors at point on the axis that define the fiber directions through that point. In particular,

(0-63)

ζ

ξ

η

Bi-unit Cube

ξ

η

Beam Element

ζ

η

+

Xζ+

Xˆ ζ

zζ-1

0

+1Top Surface

Nodal Fibers

Bottom Surface

x Xζ Xη

x

x ξ( ) Na ξ( )xa=

Page 47: SimXpert R3.2 Explicit Workspace Guide

47ElementsCBEAM - DYSHELFORM = 1, Hughes-Liu Beam

(0-64)

(0-65)

With this description, arbitrary points on the reference line are interpolated by the one- dimensional

shape function operating on the global position of the two beam nodes that define the reference

axis, i.e., . Points off the reference axis are further interpolated by using a one-dimensional shape

function along the fiber directions; i.e., and where

(0-66)

(0-67)

(0-68)

(0-69)

(0-70)

(0-71)

(0-72)

(0-73)

where and are “thickness functions”.

The Hughes-Liu beam formulation uses four position vectors, in addition to , to locate the reference

axis and define the initial fiber directions. Consider the two position vectors and located on

the top and bottom surfaces, respectively, at node . Then

(0-74)

Xη ξ η,( ) Na ξ( )Xηa η( )=

Xζ ξ ζ,( ) Na ξ( )Xζa ζ( )=

x

N ξ( )xa

Xηa η( ) Xζa ζ( )

Xηa η( ) zη η( )Xηa=

zη η( ) N+ η( )zηa+ N- η( )zηa

-+=

N+ η( ) 1 η+( )2

-----------------=

N- η( ) 1 η–( )2

-----------------=

Xζa ζ( ) zζ ζ( )Xζa=

zζ ζ( ) N+ ζ( )zζa+ N- ζ( )zζa

-+=

N+ ζ( ) 1 ζ+( )2

-----------------=

N- ζ( ) 1 ζ–( )2

----------------=

zζ ζ( ) zη η( )

ξxζa

+ xζa-

a

xζa12--- 1 ζ–( )xηa

– 1 ζ+( )+[ ]xζa+=

Page 48: SimXpert R3.2 Explicit Workspace Guide

CBEAM - DYSHELFORM = 1, Hughes-Liu Beam48

(0-75)

(0-76)

(0-77)

(0-78)

(0-79)

(0-80)

(0-81)

where is the Euclidean norm. The reference surface may be located at the midsurface of the beam or offset at the outer surfaces. This capability is useful in several practical situations involving contact surfaces, connection of beam elements to solid elements, and offsetting elements such as for beam stiffeners in stiffened shells. The reference surfaces are located within the beam element by specifying

the value of the parameters and , (see lower portion of Figure 0-7). When these parameters take on

the values or , the reference axis is located on the outer surfaces of the beam. If they are set to zero, the reference axis is at the center.

The same parametric representation used to describe the geometry of the beam elements is used to interpolate the beam element displacements; i.e., an isoparametric representation. Again, the displacements are separated into the reference axis displacements and rotations associated with the fiber directions:

(0-82)

(0-83)

(0-84)

Xζaxζa

+ xζa-–( )

xζa+ xζa

-–--------------------------=

zζa+ 1

2--- 1 ζ–( ) xζa

+ xζa-–⋅=

zζa- 1

2--- 1 ζ+( ) xζa

+ xζa-–⋅–=

xηa12--- 1 ζ–( )xηa

– 1 ζ+( )+[ ]xηa+=

Xηaxηa

+ xηa-–( )

xηa+ xηa

-–---------------------------=

zηa+ 1

2--- 1 η–( ) xηa

+ xηa-–⋅=

zηa- 1

2--- 1 η+( ) xηa

+ xηa-–⋅–=

.

η ζ1– +1

u ξ η ζ, ,( ) u ξ( ) U ξ η ζ, ,( )+ u ξ( ) Uζ ξ ζ,( ) Uη ξ η,( )+ += =

u ξ( ) Na ξ( )ua=

Uη ξ η,( ) Na ξ( )Uηa η( )=

Page 49: SimXpert R3.2 Explicit Workspace Guide

49ElementsCBEAM - DYSHELFORM = 1, Hughes-Liu Beam

(0-85)

(0-86)

(0-87)

where is the displacement of a generic point, is the displacement of a point on the reference surface,

and is the ‘fiber displacement’ rotations. The motion of the fibers can be interpreted as either displacements or rotations as will be discussed.

Hughes and Liu introduced the notation that follows, and the associated schematic shown in Figure 0-8, to describe the current deformed configuration with respect to the reference configuration:

(0-88)

(0-89)

(0-90)

(0-91)

(0-92)

(0-93)

(0-94)

Figure 0-8 Schematic of Deformed Configuration Displacements and Position Vectors

Uζ ξ ζ,( ) Na ξ( )Uζa ζ( )=

Uηa η( ) zηa η( )Uηa=

Uζa ζ( ) zζa ζ( )Uζa=

u u

U

y y Y+=

y x u+=

ya xa ua+=

Y X U+=

Ya Xa Ua+=

Yηa Xηa Uηa+=

Yζa Xζa Uζa+=

Y

Uu

u

X

Deformed ConfigurationReference Surface

Reference axis inundeformed geometry

Parallel Construction

x

xy

y

Page 50: SimXpert R3.2 Explicit Workspace Guide

CBEAM - DYSHELFORM = 1, Hughes-Liu Beam50

In the above relations, and in Figure 0-8, the quantities refer to the reference configuration, the

quantities refer to the updated (deformed) configuration and the quantities are the displacements. The

notation consistently uses a superscript bar to indicate reference surface quantities, a superscript

caret to indicate unit vector quantities, lower case letter for translational displacements, and upper

case letters for fiber displacements. Thus to update to the deformed configuration, two vector quantities

are needed: the reference surface displacement and the associated nodal fiber displacement . The nodal fiber displacements are defined in the fiber coordinate system, described in the next subsection.

Fiber Coordinate SystemFor a beam element, the known quantities will be the displacements of the reference surface obtained from the translational equations of motion and the rotational quantities at each node obtained from the rotational equations of motion. What remains to complete the kinematics is a relation between nodal

rotations and fiber displacements . The linearized relationships between the incremental components

the incremental rotations are given by

(0-95)

(0-96)

(0-95) and (0-96) are used to transform the incremental fiber tip displacements to rotational increments in the equations of motion. The second-order accurate rotational update formulation due to Hughes and Winget [1980] is used to update the fiber vectors:

(0-97)

(0-98)

then

x y

u

( )ˆ( )

u U

u

U

ΔU

ΔUη1

ΔUη2

ΔUη3

0 Yη3 Yη2–

Yη3– 0 Yη1

Yη2 Yη1– 0

Δθ1

Δθ2

Δθ3

hηΔθ= =

ΔUζ1

ΔUζ2

ΔUζ3

0 Yζ3 Yζ2–

Yζ3– 0 Yζ1

Yζ2 Yζ1– 0

Δθ1

Δθ2

Δθ3

hζΔθ= =

Yηin 1+

Rij Δθ( )Yηjn=

Yζin 1+ Rij Δθ( )Yζi

n=

Page 51: SimXpert R3.2 Explicit Workspace Guide

51ElementsCBEAM - DYSHELFORM = 1, Hughes-Liu Beam

(0-99)

(0-100)

where

(0-101)

(0-102)

(0-103)

Here is the Kronecker delta and is the permutation tensor.

Local Coordinate System

In addition to the above described fiber coordinate system, a local coordinate system is needed to enforce

the zero normal stress conditions transverse to the axis. The orthonormal basis with two directions

and normal to the axis of the beam is constructed as follows:

(0-104)

(0-105)

From the vector cross product of these local tangents.

(0-106)

and to complete this orthonormal basis, the vector

(0-107)

is defined. This coordinate system rigidly rotates with the deformations of the element.

The transformation of vectors from the global to the local coordinate system can now be defined in terms of the basis vectors as

ΔUηa Yηan 1+

Yηan–=

ΔUζa Yζan 1+

Yζan–=

Rij Δθ( ) δij

2δik ΔSik+( )ΔSjk

2D-------------------------------------------+=

ΔSij eikjΔθk=

2D 212--- Δθ1

2 Δθ22 Δθ3

2+ +( )+=

δij eikj

e2

e3

e1

y2 y1–

y2 y1–--------------------=

e2′ Yη1 Yη2+

Yη1 Yη2+----------------------------=

e3 e1 e2′×=

e2 e3 e1×=

Page 52: SimXpert R3.2 Explicit Workspace Guide

CBEAM - DYSHELFORM = 1, Hughes-Liu Beam52

(0-108)

where are the global components of the local coordinate unit vectors, is a vector in the

local coordinates, and is the same vector in the global coordinate system.

Strains and Stress Update

Incremental Strain and Spin Tensors

The strain and spin increments are calculated from the incremental displacement gradient

(0-109)

where are the incremental displacements and are the deformed coordinates. The incremental

strain and spin tensors are defined as the symmetric and skew-symmetric parts, respectively, of :

(0-110)

(0-111)

The incremental spin tensor is used as an approximation to the rotational contribution of the

Jaumann rate of the stress tensor. Here the Jaumann rate update is approximated as

(0-112)

where the superscripts on the stress tensor refer to the updated and reference configurations. This update of the stress tensor is applied before the constitutive evaluation, and the stress and strain are stored in the global coordinate system.

A

Ax

Ay

Az

e1x e2x e3x

e1y e2y e3y

e1z e2z e3z

TAx

Ay

Az

q[ ] A{ }= = =

eix eiy eiz, , A

A

Gij

∂Δui

∂yj-----------=

Δui yj

Gij

Δεij12--- Gij Gji+( )=

Δωij12--- Gij Gji–( )=

Δωij

σij σijn σip

n Δωpj σjpn Δωpi+ +=

n 1+( ) n( )

Page 53: SimXpert R3.2 Explicit Workspace Guide

53ElementsCBEAM - DYSHELFORM = 1, Hughes-Liu Beam

Stress Update

To evaluate the constitutive relation, the stresses and strain increments are rotated from the global to the local coordinate system using the transformation defined previously in (0-108), viz.

(0-113)

(0-114)

where the superscript indicates components in the local coordinate system. The stress is incrementally updated:

(0-115)

and rotated back to the global system:

(0-116)

before computing the internal force vector.

Incremental Strain-Displacement Relations

After the constitutive evaluation is completed, the fully updated stresses are rotated back to the global coordinate system. These global stresses are then used to update the internal force vector

(0-117)

where are the internal forces at node and is the strain-displacement matrix in the global

coordinate system associated with the displacements at node . The matrix relates six global strain components to eighteen incremental displacements [three translational displacements per node and the

six incremental fiber tip displacements of (0-99)]. It is convenient to partition the matrix:

(0-118)

Each sub matrix is further partitioned into a portion due to strain and spin with the following sub

matrix definitions:

σijln

qikσknqjn=

Δεijl qikΔεknqjn=

l

σijln 1+

σijln

Δσijln

12---+

+=

σijn 1+ qkiσkn

ln 1+

qnj=

faint Ba

Tσ υd=

faint a Ba

a B

B

B B1 B2,[ ]=

Ba

Page 54: SimXpert R3.2 Explicit Workspace Guide

CBEAM - DYSHELFORM = 1, Hughes-Liu Beam54

(0-119)

where

(0-120)

With respect to the strain-displacement relations, note that:

• The derivative of the shape functions are taken with respect to the global coordinates;

• The matrix is computed on the cross-section located at the mid-point of the axis;

• The resulting matrix is a matrix.

The internal force, , given by

(0-121)

is assembled into the global right hand side internal force vector. is defined as (also see (0-95)):

(0-122)

where is a identity matrix.

Ba

B1 0 0 B4 0 0 B7 0 0

0 B2 0 0 B5 0 0 B8 0

0 0 B3 0 0 B6 0 0 B9

B2 B1 0 B5 B4 0 B8 B7 0

0 B3 B2 0 B6 B5 0 B9 B8

B3 0 B1 B6 0 B4 B9 0 B7

=

Bi =

Na i,∂Na

∂yi---------=

Naηa( ) i 3–( ),

∂ Nazηa( )∂yi 3–

----------------------=

Nazζa( ) i 6–( ),

∂ Nazηa( )∂yi 6–

----------------------=

for i = 1,2,3

for i = 4,5,6

for i = 7,8,9

B

B 6 18×

f

f ′ Ttfaint=

T

T

I 0

0 hη

0 hζ

=

I 3 3×

Page 55: SimXpert R3.2 Explicit Workspace Guide

55ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay ShellThe Belytschko-Lin-Tsay shell element ([Belytschko and Tsay 1981], [Belytschko et al., 1984a]) was implemented as a computationally efficient alternative to the Hughes-Liu shell element. For a shell element with five through thickness integration points, the Belytschko-Lin-Tsay shell elements requires 725 mathematical operations compared to 4050 operations for the under integrated Hughes-Liu element. The selectively reduced integration formulation of the explicit Hughes-Liu element requires 35,350 mathematical operations. Because of its computational efficiency, the Belytschko-Lin-Tsay shell element is usually the shell element formulation of choice. For this reason, it has become the default shell element formulation for explicit calculations.

The Belytschko-Lin-Tsay shell element is based on a combined co-rotational and velocity-strain formulation. The efficiency of the element is obtained from the mathematical simplifications that result from these two kinematical assumptions. The co-rotational portion of the formulation avoids the complexities of nonlinear mechanics by embedding a coordinate system in the element. The choice of velocity-strain or rate-of-deformation in the formulation facilitates the constitutive evaluation, since the conjugate stress is the physical Cauchy stress. We closely follow the notation of Belytschko, Lin, and Tsay in the following development.

Co-rotational CoordinatesThe midsurface of the quadrilateral shell element, or reference surface, is defined by the location of the element’s four corner nodes. An embedded element coordinate system (see Figure 0-9) that deforms with the element is defined in terms of these nodal coordinates. Then the procedure for constructing the co-rotational coordinate system begins by calculating a unit vector normal to the main diagonal of the element:

(0-123)

(0-124)

(0-125)

where the superscript caret is used to indicate the local (element) coordinate system.

e3

s3

s3---------=

s3 s312 s32

2 s332+ +=

s3 r31 r42×=

ˆ( )

Page 56: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell56

Figure 0-9 Construction of Element Coordinate System

It is desired to establish the local axis approximately along the element edge between nodes 1 and

2. This definition is convenient for interpreting the element stresses, which are defined in the local

coordinate system. The procedure for constructing this unit vector is to define a vector that is nearly

parallel to the vector , viz.

(0-126)

(0-127)

The remaining unit vector is obtained from the vector cross product

(0-128)

If the four nodes of the element are coplanar, then the unit vectors and are tangent to the midplane

of the shell and is in the fiber direction. As the element deforms, an angle may develop between the

actual fiber direction and the unit normal . The magnitude of this angle may be characterized as

(0-129)

3

r31

s1

2r21

x

e3

s3

4

y

r42

1

e2

e1

x x

x y–

s1

r21

s1 r21 r21 e3⋅( )e3–=

e1

s1

s1---------=

e2 e3 e1×=

e1 e2

e3

e3

e3 f 1–⋅ δ<

Page 57: SimXpert R3.2 Explicit Workspace Guide

57ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

where is the unit vector in the fiber direction and the magnitude of depends on the magnitude of the

strains. According to Belytschko et al., for most engineering applications, acceptable values of are on

the order of 10-2 and if the condition presented in (0-129) is met, then the difference between the rotation

of the co-rotational coordinates and the material rotation should be small.

The global components of this co-rotational triad define a transformation matrix between the global and local element coordinate systems. This transformation operates on vectors with global components

and element coordinate components , and is defined as:

(0-130)

where are the global components of the element coordinate unit vectors. The inverse

transformation is defined by the matrix transpose; i.e.,

(0-131)

Velocity-Strain Displacement RelationsThe above small rotation condition, (0-129), does not restrict the magnitude of the element’s rigid body rotations. Rather, the restriction is placed on the out-of-plane deformations, and, thus, on the element strain. Consistent with this restriction on the magnitude of the strains, the velocity-strain displacement relations used in the Belytschko-Lin-Tsay shell are also restricted to small strains.

As in the Hughes-Liu shell element, the displacement of any point in the shell is partitioned into a midsurface displacement (nodal translations) and a displacement associated with rotations of the element’s fibers (nodal rotations). The Belytschko-Lin-Tsay shell element uses the Mindlin [1951] theory of plates and shells to partition the velocity of any point in the shell as:

(0-132)

where is the velocity of the mid-surface, is the angular velocity vector, and is the distance along the fiber direction (thickness) of the shell element. The corresponding co-rotational components of the velocity strain (rate of deformation) are given by

f δδ

e

A Ax Ay Az, ,( )= A Ax Ay Az, ,( )=

A{ }Ax

Ay

Az

e1x e2x e3x

e1y e2y e3y

e1z e2z e3z

Ax

Ay

Az

μ[ ] A{ } q[ ]T A{ }= = = =

eix eiy eiz, ,

A{ } μ[ ]T A{ }=

v vm ze3 θ×–=

vm θ z

Page 58: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell58

(0-133)

Substitution of (0-132) into the above yields the following velocity-strain relations:

(0-134)

(0-135)

(0-136)

(0-137)

(0-138)

The above velocity-strain relations need to be evaluated at the quadrature points within the shell. Standard bilinear nodal interpolation is used to define the mid-surface velocity, angular velocity, and the element’s coordinates (isoparametric representation). These interpolations relations are given by

(0-139)

(0-140)

(0-141)

where the subscript is summed over all the nodes of the element and the nodal velocities are

obtained by differentiating the nodal coordinates with respect to time, i.e., . The bilinear

shape functions are

(0-142)

dij12---

∂υi

∂xj

--------∂υj

∂xi

--------+

=

dx∂vx

m

∂x--------- z

∂θy

∂x--------+=

dy∂υy

m

∂y---------- z

∂θx

∂y--------–=

2dxy∂υx

m

∂y----------

∂υym

∂x---------- z

∂θy

∂y--------

∂θx

∂x--------–

+ +=

2dyz∂υz

m

∂y---------- θx–=

2dxz∂υz

m

∂x---------- θy+=

νm NI ξ η,( )νI=

θm NI ξ η,( )θI=

xm NI ξ η,( )xI=

I

υI x· I=

N114--- 1 ξ–( ) 1 η–( )=

Page 59: SimXpert R3.2 Explicit Workspace Guide

59ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

(0-143)

(0-144)

(0-145)

The velocity-strains at the center of the element (i.e., at , and ) are obtained by substitution of the above relations into the previously defined velocity-strain displacement relations, (0-134) through (0-138). After some algebra, this yields

(0-146)

(0-147)

(0-148)

(0-149)

(0-150)

where

(0-151)

(0-152)

The shape function derivatives are also evaluated at the center of the element; i.e., at , and

.

Stress Resultants and Nodal ForcesAfter suitable constitutive evaluations using the above velocity-strains, the resulting stresses are integrated through the thickness of the shell to obtain local resultant forces and moments. The integration formula for the resultants are

N214--- 1 ξ+( ) 1 η–( )=

N314--- 1 ξ+( ) 1 η+( )=

N414--- 1 ξ–( ) 1 η+( )=

ξ 0= η 0=

dx B1IυxI zB1IθyI+=

dy B2IυyI zB2IθxI–=

2dxy B2IυxI B1IυyI z B2IθyI B1IθxI–( )+ +=

2dxz B1IυzI NIθyI+=

2dyz B2IυzI NIθxI–=

B1I

∂NI

∂x---------=

B2I

∂NI

∂y---------=

BaI ξ 0=

η 0=

Page 60: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell60

(0-153)

(0-154)

where the superscript, , indicates a resultant force or moment, and the Greek subscripts emphasize the limited range of the indices for plane stress plasticity.

The above element midplane force and moment resultants are related to the local nodal forces and moments by invoking the principle of virtual power and integrating with a one-point quadrature. The relations obtained in this manner are

(0-155)

(0-156)

(0-157)

(0-158)

(0-159)

(0-160)

where is the area of the element, and is the shear factor from the Mindlin theory. In the Belytschko-

Lin-Tsay formulation, is used as a penalty parameter to enforce the Kirchhoff normality condition as the shell becomes thin.

The above local nodal forces and moments are then transformed to the global coordinate system using the transformation relations given previously as (0-130). The global nodal forces and moments are then appropriately summed over all the nodes and the global equations of motion are solved for the next increment in nodal accelerations.

f αβR σαβ zd=

mαβR zσαβ zd–=

R

fxI A B1I fxxR

B2I fxyR

+( )=

fyI A B2I fyyR

B1I fxyR

+( )=

fzI Aκ B1I fxzR

B2I fyzR

+( )=

mxI A B2ImyyR B1Imxy

R κ4--- f yz

R–+

=

myI A B1ImxxR B2Imxy

R κ4--- f xz

R–+

–=

mzI 0=

A κκ

Page 61: SimXpert R3.2 Explicit Workspace Guide

61ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

Hourglass Control (Belytschko-Lin-Tsay)In part, the computational efficiency of the Belytschko-Lin-Tsay and the under integrated Hughes-Liu shell elements are derived from their use of one-point quadrature in the plane of the element. To suppress the hourglass deformation modes that accompany one-point quadrature, hourglass viscosity stresses are added to the physical stresses at the local element level. The discussion of the hourglass control that follows pertains to the Hughes-Liu and the membrane elements as well. The hourglass procedure is controlled by the DYHRGIHQ PARAM.

The hourglass control used by Belytschko et al., extends an earlier derivation by Flanagan and Belytschko [1981], (see also Kosloff and Frazier [1978], Belytschko and Tsay [1983]). The hourglass

shape vector, , is defined as

(0-161)

where

(0-162)

is the basis vector that generates the deformation mode that is neglected by one-point quadrature. In (0-161) and the reminder of this subsection, the Greek subscripts have a range of 2; e.g.,

.

The hourglass shape vector then operates on the generalized displacements, in a manner similar to (0-146) through (0-150), to produce the generalized hourglass strain rates

(0-163)

(0-164)

(0-165)

where the superscripts and denote bending and membrane modes, respectively. The corresponding hourglass stress rates are then given by

τI

τI hI hJxaJ( )BaI–=

h

+1

1–

+1

1–

=

xaI x1I x2I,( ) xI yI,( )= =

q· αB τIθαI=

q·3B τIυzI=

q· αM τIυαI=

B M

Page 62: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell62

(0-166)

(0-167)

(0-168)

where is the shell thickness and the parameters, , and are generally assigned values between

0.01 and 0.05.

Finally, the hourglass stresses, which are updated from the stress rates in the usual way; i.e.,

(0-169)

and the hourglass resultant forces are then

(0-170)

(0-171)

(0-172)

where the superscript emphasizes that these are internal force contributions from the hourglass deformations. These hourglass forces are added directly to the previously determined local internal forces due to deformations (0-155) through (0-160). These force vectors are orthogonalized with respect to rigid body motion.

Hourglass Control (Englemann and Whirley)Englemann and Whirley [1991] developed an alternative hourglass control, which they implemented in the framework of the Belytschko, Lin, and Tsay shell element. We will briefly highlight their procedure here that has proven to be cost effective-only twenty percent more expensive than the default control.

In the hourglass procedure, the in-plane strain field (subscript ) is decomposed into the one point strain field plus the stabilization strain field:

(0-173)

αB rθEt3A

192-----------------BβIBβI q· α

B=

3B rwκGt3A

12----------------------BβIBβI q·

3B=

αM rmEtA

8---------------BβIBβI q· α

M=

t rθ rw, rm

Qn 1+ Qn ΔtQ·

+=

mαIH τIQα

B=

f 3IH τIQ3

B=

f αIH τIQα

M=

H

p

ε·

p ε·

p0

ε·

ps

+=

Page 63: SimXpert R3.2 Explicit Workspace Guide

63ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

where the stabilization strain field, which is obtained from the assumed strain fields of Pian and Sumihara [1984], is given in terms of the hourglass velocity field as

(0-174)

Here, and play the role of stabilization strain velocity operators for membrane and bending:

(0-175)

(0-176)

where the terms , are rather complicated and the reader is referred to the

reference [Englemann and Whirley, 1991].

To obtain the transverse shear assumed strain field, the procedure given in [Bathe and Dvorkin, 1984] is used. The transverse shear strain field can again be decomposed into the one point strain field plus the stabilization field:

(0-177)

that is related to the hourglass velocities by

(0-178)

where the transverse shear stabilization strain-velocity operator is given by

(0-179)

ε·

ps

Wmq· m zWbq· b+=

Wm Wb

Wm

f1

pξ η,( ) f

4

pξ η,( )

f2

pξ η,( ) f

5

pξ η,( )

f3

pξ η,( ) f

6

pξ η,( )

=

Wb

f 4p ξ η,( ) – f

1p ξ η,( )

f5p ξ η,( ) – f2

p ξ η,( )

f6

pξ η,( ) – f3

pξ η,( )

=

f ip ξ η,( ) i 1 2 … 6, , ,=

ε·

s ε·

s0

ε·

ss

+=

ε·

ss

Wsq·s=

Ws

Wsf

1s ξ η,( ) g

1s ξ– g

2s η g

3s ξ g

3s η

f2s ξ η,( ) g

4s ξ g

4s η g

2s ξ– g

1s η

=

Page 64: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell64

Again, the coefficients and are defined in the reference.

In their formulation, the hourglass forces are related to the hourglass velocity field through an incremental hourglass constitutive equation derived from an additive decomposition of the stress into a “one-point stress,” plus a “stabilization stress.” The integration of the stabilization stress gives a resultant constitutive equation relating hourglass forces to hourglass velocities.

The in-plane and transverse stabilization stresses are updated according to:

(0-180)

where the tangent matrix is the product of a matrix , which is constant within the shell domain, and a

scalar that is constant in the plane but may vary through the thickness.

The stabilization stresses can now be used to obtain the hourglass forces:

(0-181)

CQUAD4 DYSHELLFORM = 10, Belytschko-Wong-Chiang ImprovementsSince the Belytschko-Tsay element is based on a perfectly flat geometry, warpage is not considered. Although this generally poses no major difficulties and provides for an efficient element, incorrect results in the twisted beam problem, See Figure 0-10, are obtained where the nodal points of the elements used in the discretization are not coplanar. The Hughes-Liu shell element considers non-planar geometry and gives good results on the twisted beam, but is relatively expensive. The effect of neglecting warpage in typical a application cannot be predicted beforehand and may lead to less than accurate results, but the latter is only speculation and is difficult to verify in practice. Obviously, it would be better to use shells that consider warpage if the added costs are reasonable and if this unknown effect is eliminated. In this section, we briefly describe the simple and computationally inexpensive modifications necessary in the Belytschko-Tsay shell to include the warping stiffness. The improved transverse shear treatment is also described which is necessary for the element to pass the Kirchhoff patch test. Readers are directed to the references [Belytschko, Wong, and Chang 1989, 1992] for an in depth theoretical background.

f1s ξ η,( ) g

1s

τss n 1+, τs

s n, ΔtcsCsε·

ss+=

C

c

Qm WmT τp

s Ad dAh

2---–

h2---

=

Qb WbTτp

s Ad zd

Ah

2---–

h2---

=

Qs WsTτs

s Ad zdAh

2---–

h2---

=

Page 65: SimXpert R3.2 Explicit Workspace Guide

65ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

In order to include warpage in the formulation it is convenient to define nodal fiber vectors as shown in Figure 0-11. The geometry is interpolated over the surface of the shell from:

(0-182)

where: and is a parametric coordinate which varies between -1 to +1.

The in plane strain components are given by:

(0-183)

(0-184)

(0-185)

x xm ζp+ xI ζpI+( )NI ξ η,( )= =

ζ ζh2

------= ζ

dxx bxIvxI ζ bxIc vxI bxIp

·xI+( )+=

dyy byIvyI ζ byIc vyI byIp

·yI+( )+=

dxy12---bxIvyI byIvxI ζ bxI

cvyI bxIp

·yI byI

cvxI byIp

·xI+ + +( )+ +=

00

5 10 15 19

4

8

12

16

20

24

2930

Belystchkno-Tsay

Hughes-LiuBelytschko-Wong-Chiang

time (ms)

Displacement-time History

Y D

ispl

acem

ent (

104 )

Twisted Beam Problem

L = 12b = 1.1t = .32twist = 90 degreesE = 29 000 000ν = .22

Page 66: SimXpert R3.2 Explicit Workspace Guide

CQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell66

Figure 0-10 The Twisted Beam Problem Fails with the Belytschko-Tsay Shell Element

Figure 0-11 Nodal Fiber Vectors , and where is the Thickness

The coupling terms are come in through which is defined in terms of the components of the fiber

vectors as:

(0-186)

For a flat geometry the normal vectors are identical and no coupling can occur. Two methods are used

by Belytschko for computing and the reader is referred to his papers for the details. Both methods

have been tested and comparable results were obtained.

The transverse shear strain components are given as

(0-187)

(0-188)

where the nodal rotational components are defined as:

(0-189)

hp2

p3

p1

p1 p2, p3 h

biIc

bxIc

byIc

py2 py4 – py3 py1 – py4 py2 – py1 py3–

px2 px4 – px3 px1 – px4 px2 – px1 px3–=

biIc

γxz N– I ξ η,( )θyI=

γyz N– I ξ η,( )θxI=

θxI enI ex⋅( )θn

Ien

K ex⋅( )θnK

+=

Page 67: SimXpert R3.2 Explicit Workspace Guide

67ElementsCQUADA - DYSHELLFORM = 2, Belytschko-Lin-Tsay Shell

(0-190)

The rotation comes from the nodal projection

(0-191)

where the subscript refers to the normal component of side as seen in Figure 0-12 and is the

length of side .

Figure 0-12 Vector and Edge Definitions for Computing the Transverse Shear Strain Components

θyI enI ey⋅( )θn

Ien

K ey⋅( )θnK

+=

θnI

θnI 1

2--- θnI

I θnJI+( ) 1

LIJ------- υzJ υzJ–( )+=

n I LIJ

IJ

J

K

K

I

eni

eX

enk

LK

ey

y

r

Page 68: SimXpert R3.2 Explicit Workspace Guide

CTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell68

CTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell

The shell element due to Kennedy, Belytschko, and Lin [1986] has been implemented as a computationally efficient triangular element complement to the Belytschko-Lin-Tsay quadrilateral shell element ([Belytschko and Tsay 1981], [Belytschko et al., 1984a]). For a shell element with five through-the-thickness integration points, the element requires 649 mathematical operations (the Belytschko-Lin-Tsay quadrilateral shell element requires 725 mathematical operations) compared to 1417 operations for the Marchertas-Belytschko triangular shell [Marchertas and Belytschko 1974] (referred to as the BCIZ [Bazeley, Cheung, Irons, and Zienkiewicz 1965] triangular shell element).

Triangular shell elements are offered as optional elements primarily for compatibility with local user grid generation and refinement software. Many computer aided design (CAD) and computer aided manufacturing (CAM) packages include finite element mesh generators, and most of these mesh generators use triangular elements in the discretization. Similarly, automatic mesh refinement algorithms are typically based on triangular element discretization. Also, triangular shell element formulations are not subject to zero energy modes inherent in quadrilateral element formulations.

The triangular shell element’s origins are based on the work of Belytschko et al., [Belytschko, Stolarski, and Carpenter 1984b] where the linear performance of the shell was demonstrated. Because the triangular shell element formulations parallels closely the formulation of the Belytschko-Lin-Tsay quadrilateral shell element presented in the previous section, the following discussion is limited to items related specifically to the triangular shell element.

Co-rotational CoordinatesThe mid-surface of the triangular shell element, or reference surface, is defined by the location of the element’s three nodes. An embedded element coordinate system (see Figure 0-13) that deforms with the element is defined in terms of these nodal coordinates. The procedure for constructing the co-rotational coordinate system is simpler than the corresponding procedure for the quadrilateral, because the three nodes of the triangular element are guaranteed coplanar.

Figure 0-13 Local Element Coordinate System for Shell Element

C0

2x

3

1

y

z

e3 e2

e1

C0

Page 69: SimXpert R3.2 Explicit Workspace Guide

69ElementsCTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell

The local x-axis, , is directed from node 1 to 2. The element’s normal axis, , is defined by the vector

cross product of a vector along with a vector constructed from node 1 to node 3. The local y-axis, ,

is defined by a unit vector cross product of with , which are the unit vectors in the directions,

respectively. As in the case of the quadrilateral element, this triad of co-rotational unit vectors defines a transformation between the global and local element coordinate systems (see (0-130) and (0-131)).

Velocity-Strain RelationsAs in the Belytschko-Lin-Tsay quadrilateral shell element, the displacement of any point in the shell is partitioned into a mid-surface displacement (nodal translations) and a displacement associated with rotations of the element’s fibers (nodal rotations). The Kennedy-Belytschko-Lin triangular shell element also uses the Mindlin [Mindlin 1951] theory of plates and shells to partition the velocity of any point in the shell (recall (0-132)):

(0-192)

where is the velocity of the mid-surface, is the angular velocity vector, and is the distance along the fiber direction (thickness) of the shell element. The corresponding co-rotational components of the velocity strain (rate of deformation) were given previously in (0-146) through (0-150).

Standard linear nodal interpolation is used to define the midsurface velocity, angular velocity, and the element’s coordinates (isoparametric representation). These interpolation functions are the area coordinates used in triangular element formulations. Substitution of the nodally interpolated velocity fields into the velocity-strain relations (see Belytschko et al., for details), leads to strain rate-velocity relations of the form

(0-193)

where are the velocity strains (strain rates), the elements of are derivatives of the nodal

interpolation functions, and the are the nodal velocities and angular velocities.

It is convenient to partition the velocity strains and the matrix into membrane and bending contributions. The membrane relations are given by

x z

x y

e3 e1 z

ν vm ze3 θ×–=

νm θ z

d Bv=

d B

ν

B

Page 70: SimXpert R3.2 Explicit Workspace Guide

CTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell70

(0-194)

or

(0-195)

The bending relations are given by

(0-196)

or

(0-197)

The local element velocity strains are then obtained by combining the above two relations:

dx

dy

2dxy

M

1x2y3----------

y3 0 y3 0 0 0

0 x3 x2 – 0 x3 – 0 x2

x3 x2 – y3 – x3 – y3 x2 0

υx1

υy1

υx2

υy2

υx3

υy3

=

dM BMν=

κx

κy

2κxy

1–x2y3

----------

0 y3 – 0 y3 0 0

x3 x2 – 0 x3 0 x2 – 0

y3 x3 x2 – y3 – x3 – 0 x2

θx1

θy1

θx2

θy2

θx3

θy3

=

κM BMθdef=

Page 71: SimXpert R3.2 Explicit Workspace Guide

71ElementsCTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell

(0-198)

The remaining two transverse shear strain rates are given by

(0-199)

or

(0-200)

All of the above velocity-strain relations have been simplified by using one-point quadrature.

In the above relations, the angular velocities are the deformation component of the angular velocity

obtained by subtracting the portion of the angular velocity due to rigid body rotation; i.e.,

(0-201)

The two components of the rigid body angular velocity are given by

dx

dy

2dxy

dx

dy

2dxy

M

z

κx

κy

2κxy

dM zκ–=

2dxz

2dyz

16x2y3

--------------=

y32– y3 2x2 x3+( ) y

32 y3 3x2 x3–( ) 0 x2y3

y3 x2 2x2–( ) x22 x3

2– y32 x2 x3+( )– x3 x3 2x2–( ) 3x2y3– x2 2x3 x2–( )

θx1

θy1

θx2

θy2

θx3

θy3

def

dS BSθdef=

θdef

θ

θdef θ θrig–=

Page 72: SimXpert R3.2 Explicit Workspace Guide

CTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell72

(0-202)

(0-203)

The first of the above two relations is obtained by considering the angular velocity of the local x-axis about the local y-axis. Referring to Figure 0-14, by construction nodes 1 and 2 lie on the local x-axis and

the distance between the nodes is ; i.e., the distance from node 2 to the local coordinate origin at

node 1. Thus, the difference in the nodal velocities divided by the distance between the nodes is an average measure of the rigid body rotation rate about the local y-axis.

Figure 0-14 Element Configurations with Node 3 Aligned with Node 1 (left) and Node 3 Aligned with Node 2 (right)

The second relation is conceptually identical, but is implemented in a slightly different manner due to the arbitrary location of node 3 in the local coordinate system. Consider the two local element configurations shown in Figure 0-14. For the left-most configuration, where node 3 is the local y-axis, the rigid body rotation rate about the local x-axis is given by

θyrig υz1 υz2–

x2

---------------------=

θxrig υz3 υz1–( ) x2 υz2 υz1–( )x3–

x2y3

----------------------------------------------------------------------=

x2 x

z

1 2

3

y

x

z

y

z

3

x21

Page 73: SimXpert R3.2 Explicit Workspace Guide

73ElementsCTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell

(0-204)

and for the rightmost configuration the same rotation rate is given by

(0-205)

Although both of these relations yield the average rigid body rotation rate, the selection of the correct relation depends on the configuration of the element; i.e., on the location of node 3. Since every element in the mesh could have a configuration that is different in general from either of the two configurations shown in Figure 0-14, a more robust relation is needed to determine the average rigid body rotation rate about the local x-axis. In most typical grids, node 3 will be located somewhere between the two configurations shown in Figure 0-14. Thus, a linear interpolation between these two rigid body rotation

rates was devised using the distance as the interpolant:

(0-206)

Substitution of (0-204) and (0-205) into (0-206) and simplifying produces the relations given previously as (0-203).

Stress Resultants and Nodal ForcesAfter suitable constitutive evaluation using the above velocity strains, the resulting local stresses are integrated through the thickness of the shell to obtain local resultant forces and moments. The integration formulae for the resultants are

(0-207)

(0-208)

where the superscript indicates a resultant force or moment and the Greek subscripts emphasize the limited range of the indices for plane stress plasticity.

The above element midplane force and moment resultant are related to the local nodal forces and moments by invoking the principle of virtual power and performing a one-point quadrature. The relations obtained in this manner are

θx left–rig υz3 υz1–

y3

---------------------=

θx right–rig υz3 υz2–

y3

---------------------=

x3

θxrig θx left–

rig 1x3

x2

-----– θx right–

rig x3

x2

----- +=

f αβR σαβ zd=

mαβR zσαβ zd–=

R

Page 74: SimXpert R3.2 Explicit Workspace Guide

CTRIA3 - DYSHELLFORM = 4, C0 Triangular Shell74

(0-209)

(0-210)

where is the area of the element .

The remaining nodal forces, the component of the force , are determined by

successively solving the following equilibration equations

(0-211)

(0-212)

(0-213)

which represent moment equilibrium about the local x-axis, moment equilibrium about the local y-axis, and force equilibrium in the local z-direction, respectively.

fx1

fy1

fx2

fy2

fx3

fy3

ABMT

f xxR

f yyR

f xyR

=

mx1

my1

mx2

my2

mx3

my3

ABMT

mxxR

myyR

mxyR

ABST f xz

R

f yzR

+=

A 2A x2y3=( )

z fz3 fz2 fz1, ,( )

mx1 mx2 mx3 y3 fz3+ + + 0=

my1 my2 my3 x3 fz3– x2 fz2–+ + 0=

fz1 fz2 fz3

+ + 0=

Page 75: SimXpert R3.2 Explicit Workspace Guide

75ElementsCTRIA3 - DYSHELLFORM = 3, Marchertas-Belytschko Triangular Shell (BCIZ)

CTRIA3 - DYSHELLFORM = 3, Marchertas-Belytschko Triangular Shell (BCIZ)The Marchertas-Belytschko [1974] triangular shell element, or the BCIZ triangular shell element, was developed in the same time period as the Belytschko beam element [Belytschko, Schwer, and Klein, 1977], see “CBEAM - Belytschko Beam” on page 34, forming the first generation of co-rotational structural elements developed by Belytschko and co-workers. Although the Marchertas-Belytschko shell

element is relatively expensive (i.e., the triangular shell element with five through-the-thickness integration points requires 649 mathematical operations compared to 1,417 operations for the Marchertas-Belytschko triangular shell), it is maintained in SOL 700 for compatibility with earlier user models. However, as the user community moves to application of the more efficient shell element formulations, the use of the Marchertas-Belytschko triangular shell element will decrease.

As mentioned above, the Marchertas-Belytschko triangular shell has a common co-rotational formulation origin with the Belytschko beam element. The interested reader is referred to the beam element description, see “Co-rotational Technique” on page 34 for details on the co-rotational formulation. In the next subsection a discussion of how the local element coordinate system is identical for the triangular shell and beam elements. The remaining subsections discuss the triangular element’s displacement interpolants, the strain displacement relations, and calculations of the element nodal forces.

Element CoordinatesFigure 6-15a shows the element coordinate system, originating at Node 1, for the Marchertas-Belytschko triangular shell. The element coordinate system is associated with a triad of unit vectors

the components of which form a transformation matrix between the global and local

coordinate systems for vector quantities. The nodal or body coordinate system unit vectors

are defined at each node and are used to define the rotational deformations in the element, see “Co-rotational Technique” on page 34.

The unit normal to the shell element is formed from the vector cross product

(0-214)

where and are unit vectors originating at Node 1 and pointing towards Nodes 2 and 3,

C0

x y z, ,( )

e1 e2 e3, ,( )

b1 b2 b3, ,

e3

e3 l21 l31×=

l21 l31

Page 76: SimXpert R3.2 Explicit Workspace Guide

CTRIA3 - DYSHELLFORM = 3, Marchertas-Belytschko Triangular Shell (BCIZ)76

Page 77: SimXpert R3.2 Explicit Workspace Guide

71Materials

Materials

Page 78: SimXpert R3.2 Explicit Workspace Guide

Materials72

MaterialsIn addition to most materials available in structures workspace, the following material models suitable for explicit applications are also available in MD Explicit. Here, we will highlight the theoretical background of these material models. These are the material models that are most commonly used for typical structural applications. For a more detailed description of all the available materials in MD Explicit, please refer to MD R2 Nastran Quick Reference Guide.

1 Elastic

2 Orthotropic Elastic

3 Kinematic/Isotropic Elastic-Plastic

5 Soil and Crushable/Non-crushable Foam

6 Viscoelastic

7 Blatz-Ko Rubber

9 Null Hydrodynamics

10 Isotropic-Elastic-Plastic-Hydrodynamic

12 Isotropic-Elastic-Plastic

13 Elastic-Plastic with Failure Model

14 Soil and Crushable Foam with Failure Model

15 Johnson/Cook Strain and Temperature Sensitive Plasticity

18 Power Law Isotropic Plasticity

19 Strain Rate Dependent Isotropic Plasticity

20 Rigid

22 Composite Damage Model

24 Piecewise Linear Isotropic Plasticity

26 Honeycomb

27 Compressible Mooney-Rivlin Rubber

28 Resultant Plasticity

29 Forced Limited Resultant Fomulation

30 Shape-Memory Superelastic Material

31 Slightly Compressible Rubber Model

32 Laminated Glass Model

34 Fabric

40 Nonlinear Orthotropic

54-55 Composite Damage Model

Page 79: SimXpert R3.2 Explicit Workspace Guide

73MaterialsMaterials

57 Low Density Urethane Foam

58 Laminated Composite Fabric

59 Composite Failure Model - Plasticity Based

62 Viscous foam

63 Isotropic Crushable Foam

64 Strain Rate Sensitive Power-Law Plasticity

66 Linear Elastic Discrete Beam

67 Nonlinear Elastic Discrete Beam

68 Nonlinear Plastic Discrete Beam

69 SID Damper Discrete Beam

70 Hydraulic Gas Damper Discrete Beam

71 Cable Discrete Beam

72 Concrete Damage

72R Concrete Damage Release III

73 Low Density Viscoelastic Foam

74 Elastic Spring Discrete Beam

76 General Viscoelastic

77 Hyperviscoelastic Rubber

80 Ramberg-Osgood Plasticity

81 Plastic with Damage

83 Fu-Chang’s Foam with Rate Effects

87 Cellular Rubber

89 Plastic Polymer

93 Elastic Six Degrees of Freedom Spring Discrete Beam

94 Inelastic Spring Discrete Beam

95 Inelastic Spring Six Degrees of Freedom Discrete Beam

97 General Joint Discrete Beam

98 Simplified Johnson-Cook

99 Simplified Johnson-Cook Orthotropic Damage

100 Spot weld

112 Finite Elastic Strain Plasticity

114 Layered Linear Plasticity

119 General Nonlinear Six Degrees of Freedom Discrete Beam

121 General Nonlinear One Degree of Freedom Discrete Beam

Page 80: SimXpert R3.2 Explicit Workspace Guide

Materials74

In the table below, a list of the available material models and the applicable element types are given. Some materials include strain rate sensitivity, failure, equations of state, and thermal effects and this

123 Modified Piecewise Linear Plasticity

126 Modified Honeycomb

127 Arruda-Boyce rubber

158 Composite Fabric

181 Simplified Rubber

196 General Spring Descrete Beam

B01 Seatbelt

S01 Spring Elastic (Linear)

S02 Damper Viscous (Linear)

S03 Spring Elastoplastic (Isotropic)

S04 Spring Nonlinear Elastic

S05 Damper Nonlinear Viscous

S06 Spring General Nonlinear

S07 Spring Maxwell (Three parameter Viscoelastic)

S08 Spring Inelastic (Tension or Compression)

S13 Spring Tri-linear Degrading

S14 Spring Squat Shearwall

S15 Spring Muscle

SW1 Spot Weld (Simple Damage-Failure)

SW2 Spot Weld (Resultant-based Failure Criteria)

SW3 Spot Weld (Stress-based Failure)

SW4 Spot Weld (Rate Dependent Stress-based Failure)

SW5 Spot Weld (Additional Failure)

Page 81: SimXpert R3.2 Explicit Workspace Guide

75MaterialsMaterials

is also noted. General applicability of the materials to certain kinds of behavior is suggested in the last column.

Material Title

Gn GeneralCm Composites

Cr CeramicsFl FluidsFm FoamGl Glass

Hy Hydro-dynMt MetalPl Plastic

Rb RubberSl Soil/Cone

1 Elastic Y Y Y Y Gn, Fl

2 Orthotropic Elastic (Anisotropic - solids) Y Y Y Cm, Mt

3 Plastic Kinematic/Isotropic Y Y Y Y Y Y Cm, Mt, Pl

5 Soil and Foam Y Fm, Sl

6 Linear Viscoelastic Y Y Y Y Y Y Y Rb

7 Blatz-Ko Rubber Y Y Rb, Polyurethane

9 Null Material Y Y Y Y Fl, Hy

10 Elastic Plastic Hydro (dynamics) Y Y Y Hy, Mt

12 Isotropic Elastic Plastic Y Y Y Y Mt

13 Isotropic Elastic-Plastic with Failure Y Y Mt

14 Soil and Foam with Failure Y Y Fm, Sl

15 Johnson/Cook Plasticity Model Y Y Y Y Y Y Hy, Mt

18 Power Law Plasticity (Isotropic) Y Y Y Y Y Mt, Pl

19 Strain Rate Dependent Rate Plasticity Y Y Y Y Y Mt, Pl

20 Rigid Y Y Y Y

22 Composite Damage Y Y Y Y Cm

24 Piecewise Linear Isotropic Plasticity Y Y Y Y Y Y Mt, Pl

26 Honeycomb Y Y Y Cm, Fm, Sl

27 Mooney-Rivlin Rubber Y Y Rb

28 Resultant Plasticity Y Y Mt

29 Forced Limited Resultant Formaultion Y

30 Shaped Memory Alloy Y Mt

31 Slightly Compressible Rubber Y Rb

32 Laminated Glass (Composite) Y Y Y Cm, Gl

Ma t

eria

l Nu

mb

er

Bri

cks

Bea

ms

Th

in S

hel

lsT

hic

k S

hel

ls

Str

ain

-Rat

e E

ffec

ts

Fai

lure

Eq

uat

ion

-of-

Sta

te

Th

erm

al E

ffec

ts

Page 82: SimXpert R3.2 Explicit Workspace Guide

Materials76

34 Fabric Y

40 Nonlinear Orthotropic Y Y Y Cm

54 Composite Damage with Chang Failure Y Y Cm

55 Composite Damage with Tsai-Wu Failure Y Y Cm

57 Low Density Urethane Foam Y Y Y Fm

58 Laminated composite Fabric Y

59 Composite Failure - Plasticity Based Y Y Y Cm, Cr

62 Viscous foam (Crash Dummy) Y Y Fm

63 Isotropic Crushable Foam Y Y Fm

64 Rate Sensitive Power-Law Plasticity Y Y Y Y Mt

66 Linear Elastic Discrete Beam Y Y

67 Nonlinear Elastic Discrete Beam Y Y

68 Nonlinear Plastic Discrete Beam Y Y Y

69 SID Damper Discrete Beam Y Y

70 Hydraulic Gas Damper Discrete Beam Y Y

71 Cable Discrete Beam Y

72 Concrete Damage Y Y Y Y Sl

72R Concrete Damage Release III Y Y Y Y Sl

73 Low Density Viscous Foam Y Y Y Fm

74 Elastic Spring Discrete Beam Y

76 General Viscoelastic (Maxwell model) Y Y Rb

77 Hyperelastic and Ogden Rubber Y Rb

79 Hysteretic Soil (Elasto-Perfectly Plastic) Y Y Sl

80 Ramberg-Osgood Y Y Y Y Y Y Y Y

81 Plastic with Damage (Elasto-Plastic) Y Y Y Y Y Y Mt, Pl

83 Fu-Chang’s Foam Y Y Y Fm

87 Cellular Rubber Y Y Rb

Material Title

Gn GeneralCm Composites

Cr CeramicsFl FluidsFm FoamGl Glass

Hy Hydro-dynMt MetalPl Plastic

Rb RubberSl Soil/Cone

Mat

eria

l Nu

mb

er

Bri

cks

Bea

ms

Th

in S

hel

lsT

hic

k S

hel

ls

Str

ain

-Rat

e E

ffec

ts

Fai

lure

Eq

uat

ion

-of-

Sta

te

Th

erm

al E

ffec

ts

Page 83: SimXpert R3.2 Explicit Workspace Guide

77MaterialsMaterials

89 Plastic Polymer Y

93 Elastic Six Degrees of Freedom Spring Discrete Beam

Y

94 Inelastic Spring Discrete Beam Y

95 Inelastic Six Degrees of Freedom Spring Discrete Beam

Y

97 General Joint Discrete Beam Y

98 Simplified Johnson-Cook Y Y Y Y

99 Simplified Johnson-Cook Orthotropic Damage

Y Y Y Y

100 Spot weld Y

112 Finite Elastic Strain Plasticity Y

114 Layered Linear Plasticity Y Y

119 General Nonlinear Six Degrees of Freedom Discrete Beam

Y

121 General Nonlinear One Degree of Freedom Discrete Beam

Y

123 Modified Piecewise Linear Plasticity Y Y

126 Modified Honeycomb Y

127 Arruda-Boyce rubber Y

158 Composite Fabric Y Y Y Y Cm

181 Simplified Rubber Y RB

196 General Spring Discrete Beam Y

B01 Seatbelt

S01 Spring Elastic (Linear) Y

S02 Damper Viscous (Linear) Y Y

S03 Spring Elastoplastic (Isotropic) Y

S04 Spring Nonlinear Elastic Y Y

Material Title

Gn GeneralCm Composites

Cr CeramicsFl FluidsFm FoamGl Glass

Hy Hydro-dynMt MetalPl Plastic

Rb RubberSl Soil/Cone

Mat

eria

l Nu

mb

er

Bri

cks

Bea

ms

Th

in S

hel

lsT

hic

k S

hel

ls

Str

ain

-Rat

e E

ffec

ts

Fai

lure

Eq

uat

ion

-of-

Sta

te

Th

erm

al E

ffec

ts

Page 84: SimXpert R3.2 Explicit Workspace Guide

Materials78

Material Model 1: ElasticIn this elastic material we compute the co-rotational rate of the deviatoric Cauchy stress tensor as

(3-1)

and pressure

(3-2)

where and are the elastic shear and bulk moduli, respectively, and is the relative volume; i.e., the ratio of the current volume to the initial volume.

For standard MD Nastran solution sequence, this would be the same as using MAT1 to define a linear elastic material.

S05 Damper Nonlinear Viscous Y Y

S06 Spring General Nonlinear Y

S07 Spring Maxwell (Three Parameter Viscoelastic)

Y Y

S08 Spring Inelastic (Tension or Compression Y

S13 Spring Tri-linear Degrading

S14 Spring Squat Shearwall

S15 Spring Muscle

SW1 Spot Weld (Simple Damage-Failure) Y

SW2 Spot Weld (Resultant-based Failure Criteria)

Y

SW3 Spot Weld (Stress-based Failure) Y

SW4 Spot Weld (Rate Dependent Stress-based Failure)

Y

SW5 Spot Weld (Additional Failure) Y

Material Title

Gn GeneralCm Composites

Cr CeramicsFl FluidsFm FoamGl Glass

Hy Hydro-dynMt MetalPl Plastic

Rb RubberSl Soil/Cone

Mat

eria

l Nu

mb

er

Bri

cks

Bea

ms

Th

in S

hel

lsT

hic

k S

hel

ls

Str

ain

-Rat

e E

ffec

ts

Fai

lure

Eq

uat

ion

-of-

Sta

te

Th

erm

al E

ffec

ts

sij∇n 1 2⁄+

2Gε'· ijn 1 2⁄+=

pn 1+ K Vn 1+ln=

G K V

Page 85: SimXpert R3.2 Explicit Workspace Guide

79MaterialsMaterials

Material Model 2: Orthotropic Elastic

The material law that relates second Piola-Kirchhoff stress to the Green-St. Venant strain is

(3-3)

where is the transformation matrix [Cook 1974].

(3-4)

, , are the direction cosines

(3-5)

and denotes the material axes. The constitutive matrix is defined in terms of the material axes as

(3-6)

S E

S C E⋅ TtClT E⋅= =

T

T

l12 m1

2 n12 l1m1 m1n1 n1l1

l22 m2

2 n22 l2m2 m2n2 n2l2

l32 m3

2 n32 l3m3 m3n3 n3l3

2l1l2 2m1m2 2n1n2 l1m2 l1m1+( ) m1n2 m2n1+( ) n1l2 n2l1+( )

2l2l3 2m2m3 2n2n3 l2m3 l3m2+( ) m2n3 m3n2+( ) n2l3 n3l2+( )

2l3l1 2m3m1 2n3n1 l3m1 l1m3+( ) m3n1 m1n3+( ) n3l1 n1l3+( )

=

li mi ni

x'i lix1 mix2 nix3+ += for i = 1,2,3

x'i Cl

Cl1–

1E11--------

υ21

E22--------–

υ31

E33--------– 0 0 0

υ12

E11--------–

1E22--------

υ32

E33--------– 0 0 0

υ13

E11--------–

υ23

E22--------–

1E33-------- 0 0 0

0 0 01

G12--------- 0 0

0 0 0 01

G23--------- 0

0 0 0 0 01

G31---------

=

Page 86: SimXpert R3.2 Explicit Workspace Guide

Materials80

where the subscripts denote the material axes; i.e.,

and (3-7)

Since is symmetric

, ect. (3-8)

The vector of Green-St. Venant strain components is

(3-9)

(3-10)

After computing , we use Equation 3-10 to obtain the Cauchy stress. This model will predict realistic

behavior for finite displacement and rotations as long as the strains are small.

For standard MD Nastran solution sequences, this would be the same as using MAT9 to define a linear anisotropic material. For shell elements, you would have used the MAT2 or MAT8 option.

Material Model 3: Elastic Plastic with Kinematic HardeningIsotropic, kinematic, or a combination of isotropic and kinematic hardening may be obtained by varying

a parameter, called between 0 and 1. For equal to 0 and 1, respectively, kinematic and isotropic

hardening are obtained as shown in Figure 3-1 where and are the undeformed and deformed length

of uniaxial tension specimen, respectively. Krieg and Key [1976] formulated this model and the implementation is based on their paper.

In isotropic hardening, the center of the yield surface is fixed but the radius is a function of the plastic strain. In kinematic hardening, the radius of the yield surface is fixed but the center translates in the direction of the plastic strain. Thus the yield condition is

(3-11)

where

(3-12)

(3-13)

υij υx'ix'j= Eii Ex'i

=

Cl

υ12

E11--------

υ21

E22--------=

Et E11 E22 E33 E12 E23 E31,,,,,=

σijρρo-----

∂xi

∂Xk---------

∂xj

∂X

---------Sk=

Sij

β βl0 l

φ 12---ξijξij

σy2

3------– 0= =

ξij Sijαij=

σy σ0 βEpεeffp+=

Page 87: SimXpert R3.2 Explicit Workspace Guide

81MaterialsMaterials

The co-rotational rate of is

(3-14)

Hence,

(3-15)

Figure 3-1 Elastic-plastic Behavior with Isotropic and Kinematic Hardening

Strain rate is accounted for using the Cowper and Symonds [Jones 1983] model which scales the yield stress by a strain rate dependent factor

(3-16)

where and are user-defined input constants and is the strain rate defined as:

αij

αij∇ 1 β–( )2

3---Epε· ij

p=

αijn 1+ αij

n αij∇n 1 2⁄+ αik

n Ωikn 1 2⁄+ αjk

n 1 2⁄+ Ωkin 1 2⁄+++( )Δtn 1 2⁄++=

Kinematic HardeningIsotropic Hardening

β 0=β 1=

ll0---- ln

YieldStress

E

Et

ρy 1ε·

C----

1 p⁄+ σ0 βEpεeff

p+(=

p C ε·

Page 88: SimXpert R3.2 Explicit Workspace Guide

Materials82

(3-17)

The current radius of the yield surface, , is the sum of the initial yield strength, , plus the growth

, where is the plastic hardening modulus

(3-18)

and is the effective plastic strain

(3-19)

The plastic strain rate is the difference between the total and elastic (right superscript) strain rates:

(3-20)

In the implementation of this material model, the deviatoric stresses are updated elastically, as described for model 1, but repeated here for the sake of clarity:

(3-21)

where

is the trial stress tensor,

is the stress tensor from the previous time step,

is the elastic tangent modulus matrix,

is the incremental strain tensor.

and, if the yield function is satisfied, nothing else is done. If, however, the yield function is violated, an increment in plastic strain is computed, the stresses are scaled back to the yield surface, and the yield surface center is updated.

Let represent the trial elastic deviatoric stress state at

ε· ε· ijε·

ij+

σy σ0

βEpεeffp Ep

Ep

EtE

E Et–--------------=

εeffp

εeffp 2

3---ε· ij

p ε· ijp

1 2/

td

0

t

=

ε· ijp ε· ij ε· ij

e–=

σij* σij

n CijklΔεkl+=

σij*

σijn

Cijkl

Δεkl

sij*

n 1+

Page 89: SimXpert R3.2 Explicit Workspace Guide

83MaterialsMaterials

(3-22)

and

(3-23)

Define the yield function,

(3-24)

For plastic hardening then:

(3-25)

Scale back the stress deviators:

(3-26)

and update the center:

(3-27)

Plane Stress Plasticity

The plane stress plasticity options apply to beams, shells, and thick shells. Since the stresses and strain increments are transformed to the lamina coordinate system for the constitutive evaluation, the stress and strain tensors are in the local coordinate system.

The application of the Jaumann rate to update the stress tensor allows for the possibility that the normal

stress, , will not be zero. The first step in updating the stress tensor is to compute a trial plane stress

update assuming that the incremental strains are elastic. In the above, the normal strain increment

is replaced by the elastic strain increment

(3-28)

where and are Lamé’s constants.

sij* σij

* 13---σkk

* σij–=

ξij* sij

* αij–=

φ 32---ξij

* ξij* σy

2– Λ2 σy2–= =

< 0 for elastic or neutral loading> 0 for plastic harding

εeffpn 1+ εeff

pn Λ σy–

3G Ep+--------------------+ εeff

pn Δεeffp+= =

σijn 1+ σij

*3GΔεeff

p

Λ--------------------ξij

*–=

αijn 1+ αij

n 1 β–( )EpΔεeffp

Λ------------------------------------+=

σ33

Δε33

Δε33

σ33 λ Δε11 Δε22+( )+

λ 2μ+----------------------------------------------------–=

λ γ

Page 90: SimXpert R3.2 Explicit Workspace Guide

Materials84

When the trial stress is within the yield surface, the strain increment is elastic and the stress update is completed. Otherwise, for the plastic plane stress case, secant iteration is used to solve Equation (3-26) for the normal strain increment required to produce a zero normal stress:

(3-29)

Here, the superscript indicates the iteration number.

The secant iteration formula for (the superscript is dropped for clarity) is

(3-30)

where the two starting values are obtained from the initial elastic estimate and by assuming a purely plastic increment; i.e.,

(3-31)

These starting values should bound the actual values of the normal strain increment.

The iteration procedure uses the updated normal stain increment to update first the deviatoric stress and then the other quantities needed to compute the next estimate of the normal stress in Equation (3-29). The

iterations proceed until the normal stress is sufficiently small. The convergence criterion requires

convergence of the normal strains:

(3-32)

After convergence, the stress update is completed using the relationships given in Equations (3-26) and (3-27)

For SOL SEQ 106, 129, or 600, this material model is the same as using MATS1, with the hardening rule

(HR) set to either Isotropic or Kinematic. These models do not allow between 0 and 1.

Material Model 5: Soil and Crushable FoamThis model, due to Krieg [1972], provides a simple model for foam and soils whose material properties are not well characterized. We believe the other foam models (such as material models 57, 62, and 63) in SOL 700 are superior in their performance and are recommended over this model which simulates the crushing through the volumetric deformations. If the yield stress is too low, this foam model gives nearly fluid like behavior.

Δε33( )

σ33i σ33

*3GΔεeff

pi ξ33

Λ----------------------------–=

i

Δε33 p

Δε33i 1+ Δε33

i 1–Δε33

i Δε33i 1––

σ33i σ33

i 1––--------------------------------σ33

i 1––=

Δε331 Δε11 Δε22–( )–=

σ33i

Δε33i Δε33

i 1––

Δε33i 1+

----------------------------------- 10 4–<

β

Page 91: SimXpert R3.2 Explicit Workspace Guide

85MaterialsMaterials

A pressure-dependent flow rule governs the deviatoric behavior:

(3-33)

where , , and are user-defined constants. Volumetric yielding is determined by a tabulated

curve of pressure versus volumetric strain. Elastic unloading from this curve is assumed to a tensile cutoff as illustrated in Figure 3-2.

Figure 3-2 Volumetric Strain Versus Pressure Curve for Soil and Crushable Foam Model

Implementation of this model is straightforward. One history variable, the maximum volumetric strain in compression, is stored. If the new compressive volumetric strain exceeds the stored value, loading is

indicated. When the yield condition is violated, the updated trial stresses, , are scaled back using a

simple radial return algorithm:

(3-34)

If the hydrostatic tension exceeds the cutoff value, the pressure is set to the cutoff value and the deviatoric stress tensor is zeroed.

φs12---sijsij a0 a1p a2p2+ +( )–=

a0 a1 a2

Tension Cutoff Value

Tension

VV0------ ln

Pressure

Volumetric Strain(Compression)

The bulk unloading modulus is used if thevolumetric crushing option is on (VCR = 0).

Loading and unloading follows the input curve ifthe volumetric crushing option is off (VCR = 1.0).

sij*

sijn 1+ a0 a1p a2p2+ +

12---sijsij

--------------------------------------

1 2⁄

sij*=

Page 92: SimXpert R3.2 Explicit Workspace Guide

Materials86

Material Model 6: ViscoelasticIn this model, linear viscoelasticity is assumed for the deviatoric stress tensor [Herrmann and Peterson 1968]:

(3-35)

where

(3-36)

is the shear relaxation modulus. A recursion formula is used to compute the new value of the hereditary

integral at time from its value at time . Elastic bulk behavior is assumed:

(3-37)

where pressure is integrated incrementally.

Material Model 7: Continuum RubberThe hyperelastic continuum rubber model was studied by Blatz and Ko [1962]. In this model, the second Piola-Kirchhoff stress is given by

(3-38)

where is the shear modulus, is the relative volume, is Poisson’s ratio, and is the right

Cauchy-Green strain:

(3-39)

after determining , it is transformed into the Cauchy stress tensor, :

(3-40)

where and are the initial and current density, respectively. The default value of is 0.463.

Material 27 and 31 better represent incompressible materials.

sij 2 φ t τ–( )∂ε'ij∂τ

---------- τd

0

t

=

φ t( ) G∞ G0 G∞–( )e βt–+=

tn 1+ tn

p K Vln=

Sij G V 1– Cij V1

1 2υ–---------------–

δij– =

G V υ Cij

Cij

∂xk

∂Xi--------

∂xk

∂Xj--------=

Sij σij

σijρρ0-----

∂xi

∂Xk---------

∂xj

∂Xl--------Skl=

ρ0 ρ υ

Page 93: SimXpert R3.2 Explicit Workspace Guide

87MaterialsMaterials

Material Model 9: Null MaterialFor solid elements equations of state can be called through this model to avoid deviatoric stress calculations. A pressure cutoff may be specified to set a lower bound on the pressure. This model has been very useful when combined with the reactive high explosive model where material strength is often neglected. The null material should not be used to delete solid elements.

A optional viscous stress of the form

(3-41)

is computed for nonzero where is the deviatoric strain rate.

Sometimes it is advantageous to model contact surfaces via shell elements which are not part of the structure, but are necessary to define areas of contact within nodal rigid bodies or between nodal rigid bodies. Beams and shells that use this material type are completely bypassed in the element processing. The Young’s modulus and Poisson’s ratio are used only for setting the contact interface stiffnesses, and it is recommended that reasonable values be input.

Material Model 10: Elastic-Plastic-HydrodynamicFor completeness we give the entire derivation of this constitutive model based on radial return plasticity.

The pressure, ; deviatoric strain rate, ; deviatoric stress rate, ; and volumetric strain rate, ,

are defined in Equation (3-42):

(3-42)

The Jaumann rate of the deviatoric stress, , is given by:

(3-43)

First we update to elastically

(3-44)

σij με′ij=

μ ε′ij

ρ ε'· ij s·ij ε· v

p13---σijδij–=

sij σij pδij+=

sij∇ 2με'· ij 2Gε'· ij= =

ε'· ij ε· ij13---ε· v–=

ε· v ε· ijδij=

sij∇

sij∇ s·ij sipΩpj– sjpΩpi–=

sijn sij

n 1+

sijn 1+* sij

n sipΩpj sjpΩpi 2Gε'· ijdt+ + + sijn Rij 2Gε'· ijdt+ += =

sijRn

2GΔε'ij

Page 94: SimXpert R3.2 Explicit Workspace Guide

Materials88

where the left superscript, *, denotes a trial stress value. The effective trial stress is defined by

(3-45)

and if exceeds yield stress , the von Mises flow rule:

(3-46)

is violated and we scale the trial stresses back to the yield surface; i.e., a radial return

(3-47)

The plastic strain increment can be found by subtracting the deviatoric part of the strain increment that

is elastic, , from the total deviatoric increment, , i.e.,

(3-48)

Recalling that,

(3-49)

and substituting Equation (3-49) into Equation (3-48) we obtain,

(3-50)

Substituting Equation (3-47)

into Equation (3-50) gives,

(3-51)

s* 32--- sij

n 1+ sijn 1+**

1 2⁄

=

s* σy

φ 12---sijsij

σy2

3------ 0≤–=

sijn 1+

σy

s*----- sij

n 1+* m*sijn 1+= =

12G------- sij

n 1+ sijRn

–( ) Δε'ij

Δεijp Δε'ij

12G------- sij

n 1+ sijRn–( )–=

Δε'ijsij

n 1+ sijRn–*

2G---------------------------=

Δεijp sij

n 1+ sijn 1+–*( )

2G-------------------------------------=

sijn 1+ m*sij

n 1+=

Δεijp 1 m–( )

2G------------------ sij

n 1+* 1 m–2Gm-------------sij

n 1+ dλsijn 1+= = =

Page 95: SimXpert R3.2 Explicit Workspace Guide

89MaterialsMaterials

By definition an increment in effective plastic strain is

(3-52)

Squaring both sides of Equation (3-51) leads to:

(3-53)

or from Equations (3-45) and (3-52):

(3-54)

Hence,

(3-55)

where we have substituted for from Equation (3-47)

If isotropic hardening is assumed then:

(3-56)

and from Equation (3-55)

(3-57)

Thus,

and solving for the incremental plastic strain gives

(3-58)

Δεp 23---Δεij

p Δεijp

1 2⁄

=

Δεijp Δεij

p 1 m–2G

------------- 2

sijn 1+* sij

n 1+*=

32---Δεp2 1 m–

2G------------- 22

3---s*2=

Δεp∴ 1 m–3G

-------------s∗s∗ σy–

3G-----------------= =

m

mσy

s∗-----=

σyn 1+ σy

n EpΔεp+=

Δεps∗ σy

n 1+–( )3G

-----------------------------s∗ σy

n– EpΔεp–( )3G

--------------------------------------------= =

3G Ep+( )Δεp s∗ σyn–( )=

Δεps∗ σy

n–( )3G Ep+( )

-------------------------=

Page 96: SimXpert R3.2 Explicit Workspace Guide

Materials90

The algorithm for plastic loading can now be outlined in five simple stress. If the effective trial stress exceeds the yield stress then

1. Solve for the plastic strain increment:

2. Update the plastic strain:

3. Update the yield stress:

4. Compute the scale factor using the yield strength at time :

5. Radial return the deviatoric stresses to the yield surface:

Material Model 12: Isotropic Elastic-PlasticThe von Mises yield condition is given by:

(3-59)

where the second stress invariant, , is defined in terms of the deviatoric stress components as

(3-60)

and the yield stress, , is a function of the effective plastic strain, , and the plastic hardening

modulus, :

(3-61)

Δεps∗ σy

n–( )3G Ep+( )

-------------------------=

εpn 1+ εpn Δεp+=

σyn 1+ σy

n EpΔεp+=

n 1+

mσy

n 1+

s∗-------------=

sijn 1+ m sij

n 1+*=

φ J2

σy2

3------–=

J2

J212---sijsij=

σy εeffp

Ep

σy σ0 Epεeffp+=

Page 97: SimXpert R3.2 Explicit Workspace Guide

91MaterialsMaterials

The effective plastic strain is defined as:

(3-62)

where:

(3-63)

and the plastic tangent modulus is defined in terms of the input tangent modulus, , as:

(3-64)

Pressure is given by the expression

(3-65)

where is the bulk modulus. This is perhaps the most cost effective plasticity model. Only one history

variable, , is stored with this model.

This model is not recommended for shell elements. In the plane stress implementation, a one-step radial return approach is used to scale the Cauchy stress tensor to if the state of stress exceeds the yield surface. This approach to plasticity leads to inaccurate shell thickness updates and stresses after yielding. This is the only model in SOL 700 for plane stress that does not default to an iterative approach.

For MD Nastran SOL SEQ 106, 129, and 600, this material model is similar to using the MATS1 option to define an elastic-plastic material.

Material Model 13: Isotropic Elastic-Plastic with FailureThis highly simplistic failure model is occasionally useful. Material model 12 is called to update the stress tensor. Failure is initially assumed to occur if either

(3-66)

or

(3-67)

εeffp εeff

pd

0

t

=

dεeffp 2

3---dεij

p dεijp=

Et

Ep

EEt

E Et–--------------=

pn 1+ K1

Vn 1+------------- 1– =

K

εeffp

pn 1+ pmin<

εeffp εmax

p>

Page 98: SimXpert R3.2 Explicit Workspace Guide

Materials92

where and are user-defined parameters. Once failure has occurred, pressure may never be

negative and the deviatoric components are set to zero:

(3-68)

for all time. The failed element can only carry loads in compression.

Material Model 14: Soil and Crushable Foam With FailureThis material model provides the same stress update as model 5. However, if pressure ever reaches its cutoff value, failure occurs and pressure can never again go negative. In material model 5, the pressure is limited to its cutoff value in tension.

Material Model 15: Johnson and Cook Plasticity ModelJohnson and Cook express the flow stress as

(3-69)

where , , , , and are user-defined input constants, and:

effective plastic strain rate for

Constants for a variety of materials are provided in Johnson and Cook [1983].

Due to the nonlinearity in the dependence of flow stress on plastic strain, an accurate value of the flow stress requires iteration for the increment in plastic strain. However, by using a Taylor series expansion

with linearization about the current time, we can solve for with sufficient accuracy to avoid iteration.

The strain at fracture is given by

(3-70)

where , , are input constants and is the ratio of pressure divided by effective stress:

pmin εmaxp

sij 0=

σy A Bεpn+( ) 1 C ε·∗ln+( ) 1 T∗m–( )=

A B C n m

εp effective plastic strain=

ε·∗ ε· p

ε· 0

-----= ε· 0 1s 1–=

T∗T Troom–

Tmelt Troom–-------------------------------=

σy

εf D1 D2 D3s∗exp+[ ] 1 D4 ε∗ln+[ ] 1 D5T∗+[ ]=

Di i 1 … 5,,= σ∗

Page 99: SimXpert R3.2 Explicit Workspace Guide

93MaterialsMaterials

(3-71)

Fracture occurs when the damage parameter,

(3-72)

reaches the value 1.

A choice of three spall models is offered to represent material splitting, cracking, and failure under tensile loads. The pressure limit model limits the minimum hydrostatic pressure to the specified value,

. If pressures more tensile than this limit are calculated, the pressure is reset to . This

option is not strictly a spall model since the deviatoric stresses are unaffected by the pressure reaching

the tensile cutoff and the pressure cutoff value remains unchanged throughout the analysis. The

maximum principal stress spall model detects spall if the maximum principal stress, , exceeds the

limiting value . Once spall is detected with this model, the deviatoric stresses are reset to zero and no

hydrostatic tension is permitted. If tensile pressures are calculated, they are reset to 0 in the spalled material. Thus, the spalled material behaves as rubble. The hydrostatic tension spall model detects spall

if the pressure becomes more tensile than the specified limit, . Once spall is detected, the deviatoric

stresses are set to zero and the pressure is required to be compressive. If hydrostatic tension is calculated then the pressure is reset to 0 for that element.

In addition to the above failure criterion, this material model also supports a shell element deletion

criterion based on the maximum stable time step size for the element, . Generally, goes

down as the element becomes more distorted. To assure stability of time integration, the global time step

is the minimum of the values calculated for all elements in the model. Using this option allows

the selective deletion of elements whose time step has fallen below the specified minimum time

step, . Elements which are severely distorted often indicate that material has failed and supports

little load, but these same elements may have very small time steps and therefore control the cost of the analysis. This option allows these highly distorted elements to be deleted from the calculation, and, therefore, the analysis can proceed at a larger time step, and, thus, at a reduced cost. Deleted elements do not carry any load, and are deleted from all applicable slide surface definitions. Clearly, this option must be judiciously used to obtain accurate results at a minimum cost.

Material type 15 is applicable to the high rate deformation of many materials including most metals. Unlike the Steinberg-Guinan model, the Johnson-Cook model remains valid down to lower strain rates and even into the quasistatic regime. Typical applications include explosive metal forming, ballistic penetration, and impact.

This material is similar to the use of the ISOTROPIC option with the Johnson-Cook hardening rule.

σ∗ pσeff--------=

D Δεp

εf---------=

p pmin≥ pmin

pmin

σmax

σp

pmin

Δtmax Δtmax

Δtmax

Δtmax

Δtcrit

Page 100: SimXpert R3.2 Explicit Workspace Guide

Materials94

Material Type 18: Power Law Isotropic Plasticity

Elastoplastic behavior with isotropic hardening is provided by this model. The yield stress, , is a

function of plastic strain and obeys the equation:

(3-73)

where is the elastic strain to yield and is the effective plastic strain (logarithmic).

A parameter, SIGY, in the input governs how the strain to yield is identified. If SIGY is set to zero, the strain to yield if found by solving for the intersection of the linearly elastic loading equation with the strain hardening equation:

(3-74)

which gives the elastic strain at yield as:

(3-75)

If SIGY yield is nonzero and greater than 0.02 then:

(3-76)

Strain rate is accounted for using the Cowper and Symonds model which scales the yield stress with the factor

(3-77)

where is the strain rate. A fully viscoplastic formulation is optional with this model which incorporates the Cowper and Symonds formulation within the yield surface. An additional cost is incurred but the improvement is results can be dramatic.

This material model is a subset of what may be specified through the MATEP option for SOL600.

σy

σy kεn k εyp εp+( )n= =

εyp εp

σ Eε=σ lεn=

εypEk---

1n 1–------------

=

εyp

σy

k-----

1n---

1ε·

C----

1 p/

+

ε·

Page 101: SimXpert R3.2 Explicit Workspace Guide

95MaterialsMaterials

Material Type 19: Elastic Plastic Material Model with Strain Rate Dependent Yield

In this model, a load curve is used to describe the yield strength as a function of effective strain rate

where

(3-78)

and the prime denotes the deviatoric component. The yield stress is defined as

(3-79)

where is the effective plastic strain and is given in terms of Young’s modulus and the tangent

modulus by

(3-80)

Both Young's modulus and the tangent modulus may optionally be made functions of strain rate by specifying a load curve ID giving their values as a function of strain rate. If these load curve ID's are input as 0, then the constant values specified in the input are used.

This model also contains a simple mechanism for modeling material failure. This option is activated by specifying a load curve ID defining the effective stress at failure as a function of strain rate. For solid elements, once the effective stress exceeds the failure stress the element is deemed to have failed and is removed from the solution. For shell elements the entire shell element is deemed to have failed if all integration points through the thickness have an effective stress that exceeds the failure stress. After failure the shell element is removed from the solution.

In addition to the above failure criterion, this material model also supports a shell element deletion

criterion based on the maximum stable time step size for the element, . Generally, goes

down as the element becomes more distorted. To assure stability of time integration, the global time step

is the minimum of the values calculated for all elements in the model. Using this option allows

the selective deletion of elements whose time step has fallen below the specified minimum time

σ0

ε·

ε· 2

3---ε'· ijε'· ij 1 2⁄

=

σy σ0 ε·

( ) Epεp+=

εp Ep

Ep

EEt

E Et–--------------=

Note: All load curves used to define quantities as a function of strain rate must have the same number of points at the same strain rate values. This requirement is used to allow vectorized interpolation to enhance the execution speed of this constitutive model.

Δtmax Δtmax

Δtmax

Δtmax

Page 102: SimXpert R3.2 Explicit Workspace Guide

Materials96

step, . Elements which are severely distorted often indicate that material has failed and supports

little load, but these same elements may have very small time steps and therefore control the cost of the analysis. This option allows these highly distorted elements to be deleted from the calculation, and, therefore, the analysis can proceed at a larger time step, and, thus, at a reduced cost. Deleted elements do not carry any load, and are deleted from all applicable slide surface definitions. Clearly, this option must be judiciously used to obtain accurate results at a minimum cost.

This material model is a subset of what may be specified through the MATEP option for SOL600.

Material Type 20: RigidThe rigid material type 20 provides a convenient way of turning one or more parts comprised of beams, shells, or solid elements into a rigid body. Approximating a deformable body as rigid is a preferred modeling technique in many real world applications. For example, in sheet metal forming problems the tooling can properly and accurately be treated as rigid. In the design of restraint systems the occupant can, for the purposes of early design studies, also be treated as rigid. Elements which are rigid are bypassed in the element processing and no storage is allocated for storing history variables; consequently, the rigid material type is very cost efficient.

Two unique rigid part IDs may not share common nodes unless they are merged together using the rigid body merge option. A rigid body may be made up of disjoint finite element meshes, since this is a common practice in setting up tooling meshes in forming problems.

All elements which reference a given part ID corresponding to the rigid material should be contiguous, but this is not a requirement. If two disjoint groups of elements on opposite sides of a model are modeled as rigid, separate part ID's should be created for each of the contiguous element groups if each group is to move independently. This requirement arises from the fact that SOL 700 internally computes the six rigid body degrees-of-freedom for each rigid body (rigid material or set of merged materials), and if disjoint groups of rigid elements use the same part ID, the disjoint groups will move together as one rigid body.

Inertial properties for rigid materials may be defined in either of two ways. By default, the inertial properties are calculated from the geometry of the constituent elements of the rigid material and the density specified for the part ID. Alternatively, the inertial properties and initial velocities for a rigid body may be directly defined, and this overrides data calculated from the material property definition and nodal initial velocity definitions.

Young's modulus, , and Poisson's ratio, , are used for determining sliding interface parameters if the rigid body interacts in a contact definition. Realistic values for these constants should be defined since unrealistic values may contribute to numerical problem in contact.

Material Model 22: Chang-Chang Composite Failure ModelFive material parameters are used in the three failure criteria based upon Chang and Chang 1987a, 1987b:

Δtcrit

E υ

Page 103: SimXpert R3.2 Explicit Workspace Guide

97MaterialsMaterials

• , longitudinal tensile strength

• , transverse tensile strength

• , shear strength

• , transverse compressive strength

• , nonlinear shear stress parameter.

and are obtained from material strength measurement. is defined by material shear stress-strain

measurements. In plane stress, the strain is given in terms of the stress as

(3-81)

The third equation defines the nonlinear shear stress parameter .

A fiber matrix shearing term augments each damage mode:

(3-82)

which is the ratio of the shear stress to the shear strength.

The matrix cracking failure criteria is determined from

(3-83)

where failure is assumed whenever . If , then the material constants ,

, , and are set to zero.

S1

S2

S12

C2

α

C2 α

ε11

E1------ σ1 υ1σ2–( )=

ε21

E2------ σ2 υ2σ1–( )=

2ε121

G12---------τ12 ατ1

3+=

α

τ

τ122

2G12------------ 3

4---ατ12

4+

S122

2G12------------ 3

4---αS12

4+

----------------------------------=

Fmatrix

σ2

S2------

2τ+=

Fmatrix 1> Fmatrix 1> E2

G12 υ υ2

Page 104: SimXpert R3.2 Explicit Workspace Guide

Materials98

The compression failure criteria is given as

(3-84)

where failure is assumed whenever . If , then the material constants , ,

and are set to zero.

The final failure mode is due to fiber breakage.

(3-85)

Failure is assumed whenever . If , then the constants , , , , and

are set to zero.

Material Model 24: Piecewise Linear Isotropic PlasticityThis plasticity treatment in this model is quite similar to Model 3 but only isotropic hardening occurs. Deviatoric stresses are determined that satisfy the yield function

(3-86)

where

(3-87)

where the hardening function can be specified in tabular form as an option. Otherwise, linear

hardening of the form

(3-88)

is assumed where and are given in Equations (3-16) and (3-17), respectively. The parameter

accounts for strain rate effects. For complete generality a table defining the yield stress versus plastic strain may be defined for various levels of effective strain rate.

In the implementation of this material model, the deviatoric stresses are updated elastically (see material model 1), the yield function is checked, and if it is satisfied the deviatoric stresses are accepted. If it is not, an increment in plastic strain is computed:

Fcomp

σ2

2S12-----------

2 C2

2S12-----------

21–

σ2

C2------ τ+ +=

Fcomp 1> Fcomp 1> E2 υ1

υ2

Ffiber

σ1

S1------

2τ+=

Ffiber 1> Ffiber 1> E1 E2 G12 υ1

υ2

φ 12---sijsij

σy2

3------ 0≤–=

σy β σ0 fh εeffp( )+[ ]=

fh εeffp( )

fh εeffp( ) Ep εeff

p( )=

Ep εeffp β

Page 105: SimXpert R3.2 Explicit Workspace Guide

99MaterialsMaterials

(3-89)

is the shear modulus and is the current plastic hardening modulus. The trial deviatoric stress state

is scaled back:

(3-90)

For shell elements, the above equations apply, but with the addition of an iterative loop to solve for the normal strain increment, such that the stress component normal to the mid surface of the shell element approaches zero.

Three options to account for strain rate effects are possible:

• Strain rate may be accounted for using the Cowper and Symonds model which scales the yield stress with the factor

(3-91)

where is the strain rate.

• For complete generality a load curve, defining , which scales the yield stress may be input instead. In this curve the scale factor versus strain rate is defined.

• If different stress versus strain curves can be provided for various strain rates, the option using the reference to a table definition can be used.

A fully viscoplastic formulation is optional which incorporates the different options above within the yield surface. An additional cost is incurred over the simple scaling but the improvement is results can be dramatic.

If a table ID is specified a curve ID is given for each strain rate. Intermediate values are found by interpolating between curves.

Material Model 26: Crushable FoamThis orthotropic material model does the stress update in the local material system denoted by the

subscripts, , , and . The material model requires the following input parameters:

• , Young’s modulus for the fully compacted material;

Δεeffp

32---sij

* sij*

1 2⁄

σy–

3G Ep+----------------------------------------=

Ep

sij*

sijn 1+

σy

32---sij

* sij*

1 2⁄----------------------------sij

*=

β 1ε·

C----

1 p⁄+=

ε·

β

a b c

E

Page 106: SimXpert R3.2 Explicit Workspace Guide

Materials100

• , Poisson’s ratio for the compacted material;

• , yield stress for fully compacted honeycomb;

• LCA, load curve number for sigma-aa versus either relative volume or volumetric strain (see Figure 3-3);

Figure 3-3 Stress Quantity Versus Volumetric Strain

Note that in Figure 3-3, the “yield stress” at a volumetric strain of zero is nonzero. In the load curve definition, the “time” value is the volumetric strain and the “function” value is the yield stress.

• LCB, load curve number for sigma-bb versus either relative volume or volumetric strain (default: LCB = LCA);

• LCC, the load curve number for sigma-cc versus either relative volume or volumetric strain (default: LCC = LCA);

• LCS, the load curve number for shear stress versus either relative volume or volumetric strain (default LCS = LCA);

• , relative volume at which the honeycomb is fully compacted;

• , elastic modulus in the uncompressed configuration;

• , elastic modulus in the uncompressed configuration;

ν

σy

σi j

εi j–Strain0

Curve extends into negative strain quadrantsince SOL 700 extrapolates using the twoend points. It is important that the extrapolationdoes not extend into the negative stress region.

Unloading is based on the interpolatedYoung’s moduli which must provide anunloading tangent that exceeds theloading tangent.

Unloading andreloading path

Vf

Eaau

Ebbu

Page 107: SimXpert R3.2 Explicit Workspace Guide

101MaterialsMaterials

• , elastic modulus in the uncompressed configuration;

• , elastic shear modulus in the uncompressed configuration;

• , elastic shear modulus in the uncompressed configuration;

• , elastic shear modulus in the uncompressed configuration;

• LCAB, load curve number for sigma-ab versus either relative volume or volumetric strain (default: LCAB = LCS);

• LCBC, load curve number for sigma-bc versus either relative volume or volumetric strain default: LCBC = LCS);

• LCCA, load curve number for sigma-ca versus either relative volume or volumetric strain (default: LCCA = LCS);

• LCSR, optional load curve number for strain rate effects.

The behavior before compaction is orthotropic where the components of the stress tensor are uncoupled; i.e., an a component of strain will generate resistance in the local a direction with no coupling to the local b and c directions. The elastic moduli vary linearly with the relative volume from their initial values to the fully compacted values:

(3-92)

where

(3-93)

and is the elastic shear modulus for the fully compacted honeycomb material

(3-94)

The relative volume is defined as the ratio of the current volume over the initial volume; typically,

at the beginning of a calculation. The relative volume, , is the minimum value reached

during the calculation.

Eccu

Gabu

Gbcu

Gcau

Eaa Eaau β E Eaau–( )+=

Ebb Ebbu β E Ebbu–( )+=

Ecc Eccu β E Eccu–( )+=

Gab Gabu β G Gabu–( )+=

Gbc Gbcu β G Gbcu–( )+=

Gca Gcau β G Gcau–( )+=

β max min1 Vmin–

1 Vf–-------------------- 1, 0,=

G

GE

2 1 ν+( )--------------------=

V

V 1= Vmin

Page 108: SimXpert R3.2 Explicit Workspace Guide

Materials102

The load curves define the magnitude of the average stress as the material changes density (relative volume). Each curve related to this model must have the same number of points and the same abscissa

values. There are two ways to define these curves: as a function of relative volume , or as a function of volumetric strain defined as:

(3-95)

In the former, the first value in the curve should correspond to a value of relative volume slightly less than the fully compacted value. In the latter, the first value in the curve should be less than or equal to zero corresponding to tension and should increase to full compaction.

At the beginning of the stress update we transform each element’s stresses and strain rates into the local element coordinate system. For the uncompacted material, the trial stress components are updated using the elastic interpolated moduli according to:

(3-96)

Then we independently check each component of the updated stresses to ensure that they do not exceed the permissible values determined from the load curves; e.g., if

(3-97)

then

(3-98)

V

εV 1 V–=

Note: When defining the curves, care should be taken that the extrapolated values do not lead to negative yield stresses.

σaan 1+ trial

σaan

EaaΔεaa+=

σbbn 1+ trial

σbbn

EbbΔεbb+=

σccn 1+ trial

σccn

EccΔεcc+=

σabn 1+ trial

σabn

EabΔεab+=

σbcn 1+ trial

σbcn

EbcΔεbc+=

σcan 1+ trial

σcan

EcaΔεca+=

σijn 1trial+ λσij Vmin( )>

σijn 1+ σij Vmin( )

λσijn 1trial+

σijn 1trial+

-----------------------=

Page 109: SimXpert R3.2 Explicit Workspace Guide

103MaterialsMaterials

The parameter is either unity or a value taken from the load curve number, LCSR, that defines as a function of strain rate. Strain rate is defined here as the Euclidean norm of the deviatoric strain rate tensor.

For fully compacted material we assume that the material behavior is elastic-perfectly plastic and updated the stress components according to:

(3-99)

Where the deviatoric strain increment is defined as:

(3-100)

We next check to see if the yield stress for the fully compacted material is exceeded by comparing:

(3-101)

the effective trial stress, to the yield stress . If the effective trial stress exceeds the yield stress, we

simply scale back the stress components to the yield surface:

(3-102)

We can now update the pressure using the elastic bulk modulus, :

(3-103)

and obtain the final value for the Cauchy stress:

(3-104)

After completing the stress update, we transform the stresses back to the global configuration.

λ λ

sijtrial sij

n 2GΔεijdevn 1 2⁄+

+=

Δεijdev Δεij

13---Δεkkδij–=

sefftrial 3

2---sij

trialsijtrial

1 2⁄

=

σy

sijn 1+

σy

sefftrial

-----------sijtrial=

K

pn 1+ pn KΔεkkn 1 2⁄+–=

KE

3 1 2ν–( )-----------------------=

σijn 1+ sij

n 1+ pn 1+ δij–=

Page 110: SimXpert R3.2 Explicit Workspace Guide

Materials104

Material Model 27: Incompressible Mooney-Rivlin RubberThis material model, available for solid elements only, provides an alternative to the Blatz-Ko rubber

model. The strain energy density function is defined as in terms of the input constants , ,, and as:

(3-105)

where

(3-106)

(3-107)

= Poisson’s ratio

= shear modulus of linear elasticity

= strain invariants in terms of the principal stretches:

(3-108)

Recommended values for Poisson’s ratio are between .490 and .495 or higher. Lower values may lead to

instabilities. In the derivation of the constants and incompressibility is assumed.

Material Model 28: Resultant PlasticityThis plasticity model, based on resultants as illustrated in Figure 3-4, is very cost effective but not as

accurate as through-thickness integration. This model is available only with the triangular, Belytschko-Tsay shell, and the Belytschko beam element since these elements, unlike the Hughes-Liu

A B υ

W I1 I2 I2,,( ) A I1 3–( ) B I2 3–( ) C1

I32

---- 1– D I3 1–( )2+ + +=

C .5∗A B+=

DA 5υ 2–( ) B 11υ 5–( )+

2 1 2υ–( )----------------------------------------------------------=

υ

G 2 A B+( )=

I1 I2 I3,,

I1 λ12 λ2

2 λ32

+ +=

I2 λ12λ2

2 λ22λ3

2 λ32λ1

2+ +=

I3 λ12λ2

2λ32

=

C D

C0

Page 111: SimXpert R3.2 Explicit Workspace Guide

105MaterialsMaterials

elements, lend themselves very cleanly to a resultant formulation. The elements are set by the SHELLFORM parameter.

Figure 3-4 Full Section Yield using Resultant Plasticity

In applying this model to shell elements the resultants are updated incrementally using the midplane

strains and curvatures :

(3-109)

(3-110)

where the plane stress constitutive matrix is given in terms of Young’s Modulus and Poisson’s ratio

as:

(3-111)

Defining

(3-112)

(3-113)

(3-114)

the Ilyushin yield function becomes

(3-115)

Membrane σy

σyBending

my σyζ ζdh2---–

h2---

h2

4-----σy= =

ny σy ζdh2---–

h2---

hσy= =

εm κ

Δn ΔtCεm=

Δm Δth3

12------Cκ=

E

ν

m mxx2 mxxmyy– myy

2 3mxy2+ +=

n nxx2 nxxnyy– nyy

2 3nxy2+ +=

m mxx2 mxxmyy– myy

2 3mxy2+ +=

mn mxxnxx12---mxxnyy–

12---nxxmyy– myny 3mxynxy+ +=

f m n,( ) n4 mn

h 3------------- 16m

h2---------- ny

2≤+ + h2σy2= =

Page 112: SimXpert R3.2 Explicit Workspace Guide

Materials106

In our implementation we update the resultants elastically and check to see if the yield condition is violated:

(3-116)

If so, the resultants are scaled by the factor :

(3-117)

We update the yield stress incrementally:

(3-118)

where is the plastic hardening modulus which in incremental plastic strain is approximated by

(3-119)

Kennedy, et. al., report that this model predicts results that may be too stiff; users of this model should proceed cautiously.

In applying this material model to the Belytschko beam, the flow rule changes to

(3-120)

have been updated elastically according to Equations (3-112) through (3-114). The yield condition is checked Equation (3-116), and if it is violated, the resultants are scaled as described above.

This model is frequently applied to beams with nonrectangular cross sections. The accuracy of the results obtained should be viewed with some healthy suspicion. No workhardening is available with this model.

Material Model 29: FORCE LIMITED Resultant FormulationThis material model is available for the Belytschko beam element only. Plastic hinges form at the ends of the beam when the moment reaches the plastic moment. The momentversus- rotation relationship is specified by the user in the form of a load curve and scale factor.

The point pairs of the load curve are (plastic rotation in radians, plastic moment). Both quantities should be positive for all points, with the first point pair being (zero, initial plastic moment). Within this

f m n,( ) ny2>

α

αny

2

f m n,( )-----------------=

σyn 1+ σy

n EpΔεplasticeff+=

Ep

Δεplasticeff

f m n,( ) ny–

h 3G Ep+( )--------------------------------=

f m n,( ) fx2 4my

2

3Iyy----------

4mz2

3Izz---------- ny

2≤+ + A2σy2= =

Page 113: SimXpert R3.2 Explicit Workspace Guide

107MaterialsMaterials

constraint any form of characteristic may be used including flat or falling curves. Different load curves and scale factors may be specified at each node and about each of the local s and t axes.

Figure 3-5 Full Section Yield using Resultant Plasticity

Axial collapse occurs when the compressive axial load reaches the collapse load. The collapse load-versus-collapse deflection is specified in the form of a load curve. The points of the load curve are (true strain, collapse force). Both quantities should be entered as positive for all points, and will be interpreted as compressive i.e., collapse does not occur in tension. The first point should be the pair (zero, initial collapse load).

The collapse load may vary with end moment and with deflection. In this case, several load-deflection curves are defined, each corresponding to a different end moment. Each load curve should have the same number of point pairs and the same deflection values. The end moment is defined as the average of the absolute moments at each end of the beam, and is always positive.

Membrane σy

σyBending

my σyζ ζdh2---–

h2---

h2

4-----σy= =

ny σy ζdh2---–

h2---

hσy= =

Page 114: SimXpert R3.2 Explicit Workspace Guide

Materials108

It is not possible to make the plastic moment vary with axial load.

Figure 3-6 The Force Magnitude Limited Applied End Moment

For an intermediate value of the end moment, MD Nastran SOL 700 interpolates between the curves to determine the allowable force.

A co-rotational technique and moment-curvature relations are used to compute the internal forces. The co-rotational technique will not be treated here as we will focus solely on the internal force update and computing the tangent stiffness. For this, we use the notation:

= Young’s modulus

= Shear modulus

= Cross sectional area

= Effective area in shear

= Reference length of beam

= Current length of beam

= Second moment of inertia about y

= Second moment of inertia about z

= Polar moment of inertia

= ith local base vector in the current configuration

= nodal vector in y direction at node I in the current configuration

= nodal vector in z direction at node I in the current configuration

For

ce

Displacement

M1

M2

M3

M4

M5

M6

M7

M8

E

G

A

As

ln

ln 1+

Iyy

Izz

J

ei

yI

zI

Page 115: SimXpert R3.2 Explicit Workspace Guide

109MaterialsMaterials

We emphasize that the local y and z base vectors in the reference configuration always coincide with the corresponding nodal vectors. The nodal vectors in the current configuration are updated using the Hughes-Winget formula while the base vectors are computed from the current geometry of the element and the current nodal vectors.

Internal Forces

Elastic Update

In the local system for a beam connected by nodes I and J, the axial force is updated as

(3-121)

where

(3-122)

.. (3-123)

The torsional moment is updated as

(3-124)

where

(3-125)

. (3-126)

The bending moments are updated as

(3-127)

(3-128)

where

(3-129)

fael fa

n Kaelδ+=

Kael EA

ln-------=

δ ln 1+ ln–=

mtel mt

n Ktelθt+=

Ktel GJ

ln-------=

θt12---el

T yI yJ zI zJ×+×( )=

myel my

n Ayel θy+=

mzel mz

n Azel θz+=

A*el 1

1 φ*+---------------

EI**

ln----------

4 φ*+ 2 φ*–

2 φ*– 4 φ*+

=

Page 116: SimXpert R3.2 Explicit Workspace Guide

Materials110

(3-130)

(3-131)

(3-132)

In the following, we refer to as the (elastic) moment-rotation matrix.

Plastic Correction

After the elastic update the state of force is checked for yielding as follows. As a preliminary note we emphasize that whenever yielding does not occur the elastic stiffnesses and forces are taken as the new stiffnesses and forces.

The yield moments in direction i at node I as functions of plastic rotations are denoted . This

function is given by the user but also depends on whether a plastic hinge has been created. The theory for plastic hinges is given in the LS-DYNA Keyword User’s Manual [Hallquist 2003] and is not treated here. Whenever the elastic moment exceeds the plastic moment, the plastic rotations are updated as

(3-133)

and the moment is reduced to the yield moment

(3-134)

The corresponding diagonal component in the moment-rotation matrix is reduced as

(3-135)

where is a parameter chosen such that the moment-rotation matrix remains positive definite.

φ*

12EI**

GA*lntn-------------------=

θyT e3

TyI zI× yJ zJ×

=

θzT e2

TyI zI× yJ zJ×

=

A*el

miIY θiI

P( )

θiIP n 1+( ) θiI

P n( ) miIel miI

Y–

max 0.001 Ai II( )el ∂miI

Y

∂θiIP

-----------+,

---------------------------------------------------------------+=

miIn 1+ miI

Y θiIP n 1+( )( ) miI

el( )sgn=

Ai II( )n 1+ Ai II( )

el 1 αAi II( )

el

max 0.001 Ai II( )el ∂miI

Y

∂θiIP

-----------+,

---------------------------------------------------------------–

=

α 1≤

Page 117: SimXpert R3.2 Explicit Workspace Guide

111MaterialsMaterials

The yield moment in torsion is given by and is provided by the user. If the elastic torsional

moment exceeds this value, the plastic torsional rotation is updated as

(3-136)

and the moment is reduced to the yield moment

The torsional stiffness is modified as

(3-137)

where again is chosen so that the stiffness is positive.

Axial collapse is modeled by limiting the axial force by ; i.e., a function of the axial strains

and the magnitude of bending moments. If the axial elastic force exceeds this value it is reduced to yield

(3-138)

and the axial stiffness is given by

(3-139)

We neglect the influence of change in bending moments when computing this parameter.

Damping

Damping is introduced by adding a viscous term to the internal force on the form

mtY θt

P( )

θtP n 1+( ) θt

P n( ) mtel mt

Y–

max 0.0001 Ktel ∂mt

Y

∂θtP

----------+,

-------------------------------------------------------------+=

mtn 1+ mt

Y θtP n 1+( )( ) mt

el( )sgn=

Ktn 1+ Kt

el 1 αKt

el

Ktel ∂mt

Y

∂θtP

----------+

-------------------------–

=

α 1≤

faY ε m,( )

fan 1+ fa

Y εn 1+ mn 1+,( ) fael( )sgn=

Kan 1+ max 0.05Ka

el ∂faY

∂ε--------,

=

Page 118: SimXpert R3.2 Explicit Workspace Guide

Materials112

(3-140)

(3-141)

where is a damping parameter.

Transformation

The internal force vector in the global system is obtained through the transformation

(3-142)

where

(3-143)

(3-144)

fv Dddt-----

δθt

θy

θz

=

D γ

Kael

Ktel

Ayel

Azel

=

γ

fgn 1+ Sft

n 1+=

S

e1– 0 e3 ln 1+⁄– e3 ln 1+⁄– e2 ln 1+⁄ e2 ln 1+⁄

0 e1– e2 0 e3 0

e1 0 e3 ln 1+⁄ e3 ln 1+⁄ e2 ln 1+⁄– e2 ln 1+⁄–

0 e1 0 e2 0 e3

=

fln 1+

fan 1+

mtn 1+

myn 1+

mzn 1+

=

Page 119: SimXpert R3.2 Explicit Workspace Guide

113MaterialsMaterials

Tangent Stiffness

Derivation

The tangent stiffness is derived from taking the variation of the internal force

(3-145)

which can be written

where

. (3-146)

There are two contributions to the tangent stiffness: geometrical and material. The geometrical contribution is given (approximately) by

(3-147)

where

(3-148)

(3-149)

(3-150)

(3-151)

δfgn 1+ δSfl

n 1+ Sδfln 1++=

δfgn 1+ Kgeoδu Kmatδu+=

δu δxIT δωI

T δxJT δωj

T T

=

Kgeo R fln 1+ I⊗( )W

1ln 1+ ln 1+----------------------Tfl

n 1+ L–=

R

R1 0 R3 ln 1+⁄ R3 ln 1+⁄ R2 ln 1+⁄– R2 n 1+( )⁄–

0 R1 R2– 0 R3– 0

R1– 0 R3 ln 1+⁄– R3 ln 1+⁄– R2 ln 1+⁄ R2 ln 1+⁄

0 R1– 0 R2– 0 R3–

=

W R1 ln 1+⁄– e1e1T 2⁄ R1 ln 1+⁄ e1e1

T 2⁄ =

T

0 0 e3– e3– e2 e2

0 0 0 0 0 00 0 e3 e3 e2– e2–

0 0 0 0 0 0

=

L e1T 0 e1

T 0 =

Page 120: SimXpert R3.2 Explicit Workspace Guide

Materials114

and I is the 3 by 3 identity matrix. We use as the outer matrix product and define

. (3-152)

The material contribution can be written as

(3-153)

where

(3-154)

Material Model 30: Shape Memory AlloyThis section presents the mathematical details of the shape memory alloy material in MD Nastran SOL 700.

The description closely follows the one of Auricchio and Taylor [1997] with appropriate modifications for this particular implementation.

Mathematical Description of the Material Model

The Kirchhoff stress in the shape memory alloy can be written

(3-155)

where i is the second order identity tensor and

. (3-156)

Here K and G are bulk and shear modulii, and e are volumetric and shear logarithmic strains and

and are constant material parameters. There is an option to define the bulk and shear modulii as

functions of the martensite fraction according to

(3-157)

Riv ei v×=

Kmat SKST=

K

Kan 1+

Ktn 1+

Ayn 1+

Azn 1+

=

τ

τ pi t+=

p K θ 3αξSεL–(=

t 2G e ξSεLn–( )=

θ αεL

K KA ξS KS KA–( )+=

G GA ξS GS GKA–(+=

Page 121: SimXpert R3.2 Explicit Workspace Guide

115MaterialsMaterials

in case the stiffness of the martensite differs from that of the austenite. Furthermore, the unit vector n is defined as

(3-158)

and a loading function is introduced as

(3-159)

where

. (3-160)

For the evolution of the martensite fraction in the material, the following rule is adopted

. (3-161)

Here , , , and are constant material parameters. The Cauchy stress is finally

obtained as

(3-162)

where J is the Jacobian of the deformation.

Algorithmic Stress Update

For the stress update, we assume that the martensite fraction and the value of the loading function

is known from time and the deformation gradient at time , , is known. We form the left

Cauchy-Green tensor as which is diagonalized to obtain the principal values and directions

and . The volumetric and principal shear logarithmic strains are given by

n e e 10 12–+( )⁄=

F 2G e 3αKθ βξS–+=

β 2G 9α2K+( )εL=

ξS

F RsAS 0>–

0>ξS 1<

ξS 1 ξS–( ) F·

F RfAS–

-------------------–=

F RsSA 0<–

0>ξS 0>

ξS ξSF·

F RfSA–

-------------------=

RsAS Rf

AS RsSA Rf

SA

σ τ J⁄=

ξsn

Fn tn tn 1+ F

B FFT=

Λdiag λi( ) Q

Page 122: SimXpert R3.2 Explicit Workspace Guide

Materials116

where

is the total Jacobian of the deformation. Using Equation (3-159) with , a value of the

loading function can be computed. The discrete counterpart of Equation (3-161) becomes

(3-163)

If none of the two conditions to the left are satisfied, set , , and compute

the stress using Equations (3-155), (3-156), (3-157), (3-162) and . When phase

transformation occurs according to a condition to the left, the corresponding equation to the right is

solved for . If the bulk and shear modulii are constan,t this is an easy task. Otherwise, as

well as depends on this parameter and makes things a bit more tricky. We have that

.

where and are Young’s modulii for martensite and austenite, respectively. The subscript n is

introduced for constant quantities evaluated at time . To simplify the upcoming expressions, these

relations are written

θ J( )log=

ei λi J1 3⁄⁄(log=

J λ1λ2λ3=

ξS ξSn= Ftrial

Ftrial RsAS 0>–

Ftrial Fn 0>–

ξSn 1<

ΔξS 1 ξSn– ΔξS–( )

Ftrial βΔξS– min max Fn RsAS,( ) Rf

AS,( )–

Ftrial βΔξS– RfAS–

-------------------------------------------------------------------------------------------------–=

Ftrial RsSA 0>–

Ftrial Fn 0>–

ξSn 1<

ΔξS ξSn ΔξS+( )

Ftrial βΔξS– min max Fn RsSA,( ) Rf

SA,( )–

Ftrial βΔξS– RfSA–

-------------------------------------------------------------------------------------------------=

ξSn 1+ ξS

n= Fn 1+ Ftrial=

σn 1+ ξS ξSn=

ΔξS Ftrial

β

Ftrial Fntrial 1

ES EA–

En------------------ΔξS+

=

β βn 1ES EA–

En------------------ΔξS+

=

ES EA

tn

Page 123: SimXpert R3.2 Explicit Workspace Guide

117MaterialsMaterials

(3-164)

respectively, where we have for simplicity set

Inserting these expressions into Equation (3-163) results in

(3-165)

and

respectively, where we have for simplicity set

.

The solutions to these equations are approximated with two Newton iterations starting in the point

.. Now set and compute and

according to Equations (3-155), (3-156), (3-157), (3-158), (3-160) and .

Tangent Stiffness Matrix

An algorithmic tangent stiffness matrix relating a change in true strain to a corresponding change in Kirchhoff stress is derived in the following. Taking the variation of Equation (3-156) results in

. (3-166)

The variation of the unit vector in Equation (3-157) can be written

Ftrial Fntrial ΔFtrialΔξS+=

β βn ΔβΔξS+=

f ΔξS( ) Δβ 1 ξSn–( )ΔξS

2 RfAS FAS

n– βn ΔFtrial–( ) 1 ξS

n–( )+( )ΔξS+ +=

1 ξSn–( ) FAS

nFn

trial–( ) 0=

f ΔξS( ) ΔβξSnΔξS

2 FSAn

RfSA– βn ΔFtrial–( )ξS

n+( )ΔξS+ +=

ξSn FSA

nFn

trial–( ) 0=

FASn

min max Fn RsAS,( ) Rf

AS,( )=

FSAn

min max Fn RfSA,( ) Rs

SA,( )=

ΔξS 0= ξSn 1+ min 1 max 0 ξS

n ΔξS+,( ),( )= σn 1+ Fn 1+

ξS ξSn 1+=

δp K δθ 3αδξSεL–( ) δK θ 3αξSεL–( )+=

δt 2G δe δξSεLn– ξSεLδn–( ) 2δG e ξSεLn–( )+=

δn1

e 10 12–+-------------------------- I n n⊗–( )δe=

Page 124: SimXpert R3.2 Explicit Workspace Guide

Materials118

where I is the fourth order identity tensor. For the variation of martensite fraction, we introduce the

indicator parameters and that should give information of the probability of phase

transformation occurring in the next stress update. Set initially and change them according to

using the quantities computed in the previous stress update. For the variation of the martensite fraction we take variations of Equations(3-165) and (3-166) with

which results in

where

.

As can be seen, we use the value of obtained in the previous stress update since this is easier to implement and will probably give a good indication of the current value of this parameter.

The variation of the material parameters K and G results in

and, finally, using the identities

HAS HSA

HAS HSA 0= =

Ftrial RsAS 0>–

Ftrial Fn 0>–

ξSn ΔξS 1≤+

HAS 1=

Ftrial RsSA 0>–

Ftrial Fn 0>–

ξSn ΔξS 0≥+

HSA 1=

δFntrial 2Gn:δe 3αKδθ+=

δξS γ 2Gn:δe 3αKδθ+( )=

γ1 ξS

n–( )HAS

RfAS FAS

nβ( n ΔFn

trial ) 1 ξSn–( )–+–

-------------------------------------------------------------------------------------ξS

nHSA

FSAn

RfSA– βn ΔFn

trial–( )ξSn+

-----------------------------------------------------------------------+=

γ

δK KS KA–( )δξS=

δG GS GA–( )δξ=

Page 125: SimXpert R3.2 Explicit Workspace Guide

119MaterialsMaterials

+

results in

where is the fourth order deviatoric identity tensor. In general this tangent is not symmetric because of the terms on the second line in the expression above. We simply use a symmetrization of the tangent stiffness above in the implementation. Furthermore, we transform the tangent to a tangent closer related to the one that should be used in the MD Nastran SOL 700 implementation,

Material Model 31: Slightly Compressible Rubber ModelThis model implements a modified form of the hyperelastic constitutive law first described in [Kenchington 1988].

The strain energy functional, , is defined in terms of the input constants as:

(3-167)

where the strain invariants can be expressed in terms of the deformation gradient matrix, , and the

Green-St. Venant strain tensor, :

n:δe n:δε=

δθ i:δε=

δτ iδp δt+=

δτ 2G 1ξSεL

e 10 12–+--------------------------–

Idev K 1 9α2KγεL– 3αγ KS KA–( ) θ 3αξSεL–( )+( )i i⊗+

=

2γG KS KA–( ) θ 3αξSεL–( )i n 6γαK GS GA–( ) e ξSεL–( )n i +⊗+⊗

2GξSεL

e 1 10 12––+----------------------------------- 2GγεL– 2γ GS GA–( ) e ξDεL–( )+

n n 6KGαγεL i n n i⊗+⊗( ) }δε–⊗

Idev

1– 2G 1ξSεL

e 10 12–+--------------------------–

Idev K 1 9α2KγεL– 3αγ KS KA–( ) θ 3αξSεL–( )+( )i i +⊗+

KS KA– ) θ 3αξSεL–( ) 3γαK GS GA–( ) e ξSεL–( ) 6KGαγεL–+ ) i n n i⊗+⊗( ) +

2GξSεL

e 10 12–+-------------------------- 2GγεL– 2γ GS GA–( ) e ξSεL–( )+ n n⊗

δε

U

C100I1 C200I12 C300I1

3 C400I14 C110I1I2 C210I1

2I2 C010I2 C020I22 j+ + + + + + + +=

Fij

Eij

Page 126: SimXpert R3.2 Explicit Workspace Guide

Materials120

. (3-168)

The derivative of with respect to a component of strain gives the corresponding component of stress

(3-169)

where, , is the second Piola-Kirchhoff stress tensor which is transformed into the Cauchy

stress tensor:

(3-170)

where and are the initial and current density, respectively.

Material Model 32: Laminated Glass ModelThis model is available for modeling safety glass. Safety glass is a layered material of glass bonded to a polymer material which can undergo large strains.

The glass layers are modeled by isotropic hardening plasticity with failure based on exceeding a specified level of plastic strain. Glass is quite brittle and cannot withstand large strains before failing. Plastic strain was chosen for failure since is increases monotonically and, therefore, is insensitive to spurious numberical noise in the solution.

The material to which the glass is bonded is assumed to stretch plastically without failure.

The user defined integration rule option must be used with this material. The user defined rule specifies the thickness of the layers making up the safety glass. Each integration point is flagged with a zero if the layer is glass and with a one if the layer is polymer.

An iterative plane stress plasticity algorithm is used to enforce the plane stress condition.

Material Model 34: FabricThe fabric model is a variation on the Layered Orthotropic Composite material model (Material 22) and is valid for only 3 and 4 node membrane elements. This material model is strongly recommended for modeling airbags and seatbelts. In addition to being a constitutive model, this model also invokes a special membrane element formulation that is better suited to the large deformations experienced by fabrics. For thin fabrics, buckling (wrinkling) can occur with the associated inability of the structure to support compressive stresses; a material parameter flag is included for this option. A linear elastic liner

J Fij=I1 Eii=

I212---δpq

ijEpiEq=

U

Sij∂U∂Eij---------=

Sij

σijρρo-----

∂xi

∂Xk---------

∂xj

∂Xl--------Skl=

ρo ρ

Page 127: SimXpert R3.2 Explicit Workspace Guide

121MaterialsMaterials

is also included which can be used to reduce the tendency for these material/elements to be crushed when the no-compression option is invoked.

If the airbag material is to be approximated as an isotropic elastic material, then only one Young’s modulus and Poisson’s ratio should be defined. The elastic approximation is very efficient because the local transformations to the material coordinate system may be skipped. If orthotropic constants are defined, it is very important to consider the orientation of the local material system and use great care in setting up the finite element mesh.

If the reference configuration of the airbag is taken as the folded configuration, the geometrical accuracy of the deployed bag will be affected by both the stretching and the compression of elements during the folding process. Such element distortions are very difficult to avoid in a folded bag. By reading in a reference configuration, such as the final unstretched configuration of a deployed bag, any distortions in the initial geometry of the folded bag will have no effect on the final geometry of the inflated bag. This is because the stresses depend only on the deformation gradient matrix:

(3-171)

where the choice of may coincide with the folded or unfold configurations. It is this unfolded

configuration which may be specified here. When the reference geometry is used, then the no-compression option should be active. With the reference geometry, it is possible to shrink the airbag and then perform the inflation. Although the elements in the shrunken bag are very small, the time step can be based on the reference geometry so a very reasonable time step size is obtained. The reference geometry based time step size is optional in the input.

The parameters fabric leakage coefficient, FLC, fabric area coefficient, FAC, and effective leakage area, ELA, for the fabric in contact with the structure are optional for the Wang-Nefske and hybrid inflation models. It is possible for the airbag to be constructed of multiple fabrics having different values of porosity and permeability. The gas leakage through the airbag fabric then requires an accurate determination of the areas by part ID available for leakage. The leakage area may change over time due to stretching of the airbag fabric or blockage when the outer surface of the bag is in contact with the structure. MD Nastran SOL 700 can check the interaction of the bag with the structure and split the areas into regions that are blocked and unblocked depending on whether the regions are in contact or not, respectively. Typically, the parameters, FLC and FAC, must be determined experimentally and their variation with time and pressure are optional inputs that allow for maximum modeling flexibility.

Material Models 54 and 55: Enhanced Composite Damage ModelThese models are very close in their formulations. Material 54 uses the Chang matrix failure criterion (as Material 22), and Material 55 uses the Tsai-Wu criterion for matrix failure.

Arbitrary orthothropic materials, e.g., unidirectional layers in composite shell structures can be defined. Optionally, various types of failure can be specified following either the suggestions of [Chang and Chang, 1984] or [Tsai and Wu, 1981]. In addition special measures are taken for failure under

Fij

∂xi

∂Xj--------=

Xj

Page 128: SimXpert R3.2 Explicit Workspace Guide

Materials122

compression. See [Matzenmiller and Schweizerhof, 1990]. This model is only valid for thin shell elements.

The Chang/Chang criteria is given as follows:

for the tensile fiber mode,

then , (3-172)

for the compressive fiber mode,

then , (3-173)

for the tensile matrix mode,

then , (3-174)

and for the compressive matrix mode,

then (3-175)

In the Tsai/Wu criteria the tensile and compressive fiber modes are treated as in the Chang/Chang criteria. The failure criterion for the tensile and compressive matrix mode is given as:

(3-176)

For , we get the original criterion of Hashin [1980] in the tensile fiber mode.

For , we get the maximum stress criterion which is found to compare better to experiments.

Failure can occur in any of four different ways:

σaa 0> ef2

σaa

Xt--------

σab

Sc-------- 1–+= > 0 failed

< 0 elastic

Ea Eb Gab νba νab= = = = =

σaa 0> ec2

σaa

Xc--------

21–= > 0 failed

< 0 elastic

Ea νba νab 0= = =

σbb 0> em2

σbb

Yt--------

2 σab

Sc--------

21–+= > 0 failed

< 0 elastic

Eb νba 0. Gab→= = =

σbb 0< ed2

σbb

2Sc--------

2 Yc

2St-------

21–

σbb

Yc--------

σab

Sc--------

21–+ += > 0 failed

< 0 elastic

Eb νba νab 0. Gab→= = = =

Xc 2Yc= for 50% fiber volume

emd2

σbb2

YcYt----------

σab

Sc--------

2 Yc Yt–( )σbb

YcYt------------------------------ 1–+ += > 0 failed

< 0 elastic

β 1=

β 0=

Page 129: SimXpert R3.2 Explicit Workspace Guide

123MaterialsMaterials

1. If DFAILT is zero, failure occurs if the Chang/Chang failure criterion is satisfied in the tensile fiber mode.

2. If DFAILT is greater than zero, failure occurs if the tensile fiber strain is greater than DFAILT or less than DFAILC.

3. If EFS is greater than zero, failure occurs if the effective strain is greater than EFS.

4. If TFAIL is greater than zero, failure occurs according to the element time step as described in the definition of TFAIL above.

When failure has occurred in all the composite layers (through-thickness integration points), the element is deleted. Elements which share nodes with the deleted element become “crashfront” elements and can have their strengths reduced by using the SOFT parameter with TFAIL greater than zero.

Information about the status in each layer (integration point) and element can be plotted using additional integration point variables. The number of additional integration point variables for shells written to the database is input by the PARAM, DYNEIPS definition as variable NEIPS. For Models 54 and 55 these additional variables are tabulated below (i = shell integration point):

History Variable Description Valued3plot

Component

1. ef(i) tensile fiber mode 81

2. ec(i) compressive fiber mode 1 - elastic 82

3. em(i) tensile matrix mode 0 - failed 83

4. ed(i) compressive matrix mode 84

5. efail max[ef(ip)] 85

6. dam damage parameter -1 - element intact

10-8 - element in crashfront+1 - element failed

86

Page 130: SimXpert R3.2 Explicit Workspace Guide

Materials124

These variables can be plotted in MD Patran as element components 81, 82, ..., 80+ NEIPS. The following components, defined by the sum of failure indicators over all through-thickness integration points, are stored as element component 7 instead of the effective plastic strain:

Material Model 57: Low Density Urethane FoamThe urethane foam model is available to model highly compressible foams such as those used in seat cushions and as padding on the Side Impact Dummy (SID). The compressive behavior is illustrated in Figure 3-7 where hysteresis on unloading is shown. This behavior under uniaxial loading is assumed not to significantly couple in the transverse directions. In tension the material behaves in a linear fashion until tearing occurs. Although our implementation may be somewhat unusual, it was first motivated by Shkolnikov [1991] and a paper by Storakers [1986]. The recent additions necessary to model hysteretic

Description Integration Point

1

2

3

1nip-------- ef i( )

i 1=

nip

1nip-------- ec i( )

i 1=

nip

1nip-------- cm i( )

i 1=

nip

Page 131: SimXpert R3.2 Explicit Workspace Guide

125MaterialsMaterials

unloading and rate effects are due to Chang, et. al., [1994]. These latter additions have greatly expanded the usefulness of this model.

Figure 3-7 Behavior of the Low-density Urethane Foam Model

The model uses tabulated input data for the loading curve where the nominal stresses are defined as a

function of the elongations, , which are defined in terms of the principal stretches, , as:

(3-177)

The stretch ratios are found by solving for the eigenvalues of the left stretch tensor, , which is

obtained via a polar decomposition of the deformation gradient matrix, :

(3-178)

The update of follows the numerically stable approach of Taylor and Flanagan [1989]. After solving

for the principal stretches, the elongations are computed and, if the elongations are compressive, the

corresponding values of the nominal stresses, , are interpolated. If the elongations are tensile, the

nominal stresses are given by

(3-179)

The Cauchy stresses in the principal system become

(3-180)

The stresses are then transformed back into the global system for the nodal force calculations.

Typical unloading curves determined by the hysteric unloading factor. With the shape factor equal to unity.

Unloading

Strain

σ

Strain

Typical unloading for a large shapefactor; e.g., 5.-8 and a small hystericfactor; e.g., .010.

σ

Curves

εi λi

εi λi 1–=

Vij

Fij

Fij RikUkj VikRkj= =

Vij

τi

τi Eεi=

σi

τi

λiλk----------=

Page 132: SimXpert R3.2 Explicit Workspace Guide

Materials126

When hysteretic unloading is used, the reloading will follow the unloading curve if the decay constant,

, is set to zero. If is nonzero the decay to the original loading curve is governed by the expression:

(3-181)

The bulk viscosity, which generates a rate dependent pressure, may cause an unexpected volumetric response and, consequently, it is optional with this model.

Rate effects are accounted for through linear viscoelasticity by a convolution integral of the form

(3-182)

where is the relaxation function. The stress tensor, , augments the stresses determined

from the foam, ; consequently, the final stress, , is taken as the summation of the two

contributions:

(3-183)

Since we wish to include only simple rate effects, the relaxation function is represented by one term from the Prony series:

(3-184)

given by,

(3-185)

This model is effectively a Maxwell fluid which consists of a damper and spring in series. We

characterize this in the input by a Young's modulus, , and decay constant, . The formulation is

performed in the local system of principal stretches where only the principal values of stress are computed and triaxial coupling is avoided. Consequently, the one-dimensional nature of this foam material is unaffected by this addition of rate effects. The addition of rate effects necessitates twelve additional history variables per integration point. The cost and memory overhead of this model comes primarily from the need to “remember” the local system of principal stretches.

Material Type 58: Laminated Composite FabricParameters to control failure of an element layer are: ERODS, the maximum effective strain; i.e., maximum 1 = 100 % straining. The layer in the element is completely removed after the maximum

β β

1 e βt––

σij gijkl t τ–( )∂εkl

∂τ---------

0

t=

gijkl t τ–( ) σijr

σijf σij

σij σijf σij

r+=

g t( ) α0 αme βt–

m 1=

N

+=

g t( ) Ede β1t–=

Ed β1

Page 133: SimXpert R3.2 Explicit Workspace Guide

127MaterialsMaterials

effective strain (compression/tension including shear) is reached. The stress limits are factors used to limit the stress in the softening part to a given value,

, (3-186)

thus, the damage value is slightly modified such that elastoplastic like behavior is achieved with the

threshold stress. As a factor for a number between 0.0 and 1.0 is possible. With a factor of 1.0, the stress remains at a maximum value identical to the strength, which is similar to ideal elastoplastic

behavior. For tensile failure a small value for is often reasonable; however, for compression

is preferred. This is also valid for the corresponding shear value. If is smaller than 1.0, then localization can be observed depending on the total behavior of the lay-up. If the

user is intentionally using , it is generally recommended to avoid a drop to zero and set the value to something in between 0.05 and 0.10.

Then elastoplastic behavior is achieved in the limit which often leads to less numerical problems.

Defaults for .

The crashfront-algorithm is started if and only if a value for TSIZE (time step size, with element elimination after the actual time step becomes smaller than TSIZE) is input

The damage parameters can be written to the postprocessing database for each integration point as the first three additional element variables and can be visualized.

Material models with FS=1 or FS=-1 are favorable for complete laminates and fabrics, as all directions are treated in a similar fashion.

For material model FS=1, an interaction between normal stresses and shear stresses is assumed for the evolution of damage in the a- and b-directions. For the shear damage is always the maximum value of the damage from the criterion in a- or b- direction is taken.

For material model FS=-1, it is assumed that the damage evolution is independent of any of the other stresses. A coupling is present only via the elastic material parameters and the complete structure.

In tensile and compression directions and in a- as well as in b- direction, different failure surfaces can be assumed. The damage values, however, increase only when the loading direction changes.

Special Control of Shear Behavior of Fabrics

For fabric materials a nonlinear stress strain curve for the shear part of failure surface FS=-1 can be assumed as given below. This is not possible for other values of FS. The curve, shown in Figure 19.58.1, is defined by three points:

a. a) the origin (0,0) is assumed,

b. the limit of the first slightly nonlinear part (must be input), stress (TAU1) and strain (GAMMA1), see below.

c. the shear strength at failure and shear strain at failure.

σmin SLIMxx strength⋅=

SLIMxx

SLIMTx

SLIMCx 1.0= SLIMxx

SLIMxx 1.0<

SLIMxx 1.0E-8=

Page 134: SimXpert R3.2 Explicit Workspace Guide

Materials128

In addition, a stress limiter can be used to keep the stress constant via the SLIMS parameter. This value must be less than or equal to 1.0 and positive, which leads to an elastoplastic behavior for the shear part. The default is 1.0E-08, assuming almost brittle failure once the strength limit SC is reached.

Figure 3-8 Stress-strain Diagram for Shear

Material Type 62: Viscous FoamThis model was written to represent the energy absorbing foam found on certain crash dummies, i.e., the ‘Confor Foam’ covering the ribs of the Eurosid dummy.

The model consists of a nonlinear elastic stiffness in parallel with a viscous damper. A schematic is shown in Figure 3-9. The elastic stiffness is intended to limit total crush while the viscous damper absorbs

energy. The stiffness prevents timestep problems.

Figure 3-9 Schematic of Material Model 62

SLIMS*SC

GMSGAMMA1

TAU1

SC

τ

γ

E2

E1

V2 E2

Page 135: SimXpert R3.2 Explicit Workspace Guide

129MaterialsMaterials

Both and are nonlinear with crush as follows:

(3-187)

where is the relative volume defined by the ratio of the current to initial volume. Typical values are

(units of )

Material Type 63: Crushable FoamThe intent of this model is model crushable foams in side impact and other applications where cyclic behavior is unimportant.

This isotropic foam model crushes one-dimensionally with a Poisson’s ratio that is essentially zero. The stress versus strain behavior is depicted in Figure 3-10 where an example of unloading from point a to the tension cutoff stress at b then unloading to point c and finally reloading to point d is shown. At point the reloading will continue along the loading curve. It is important to use nonzero values for the tension cutoff to prevent the disintegration of the material under small tensile loads. For high values of tension cutoff the behavior of the material will be similar in tension and compression.

In the implementation we assume that Young’s modulus is constant and update the stress assuming elastic behavior.

(3-188)

The magnitudes of the principal values, , are then checked to see if the yield stress,

, is exceeded and if so they are scaled back to the yield surface:

if then (3-189)

E1 V2

E1t E1 V n1–( )=

V2t V2 abs 1 V–( )( )n=

V

N mm s,,

E1 0.0036=n1 4.0=V2 0.0015=E2 100.0=n2 0.2=ν 0.05=

σijtrial σij

n Eε· ijn 1 2⁄+ Δtn 1 2⁄++=

σitrial i, 1 3,=

σy

σy σitrial< σi

n 1+ σy

σitrial

σitrial

---------------=

Page 136: SimXpert R3.2 Explicit Workspace Guide

Materials130

After the principal values are scaled, the stress tensor is transformed back into the global system. As seen

in Figure 3-10, the yield stress is a function of the natural logarithm of the relative volume, ; i.e., the volumetric strain.

Figure 3-10 Yield Stress Versus Volumetric Strain Curve for the Crushable Foam

Material Model 64: Strain Rate Sensitive Power-Law PlasticityThis material model follows a constitutive relationship of the form:

(3-190)

where is the yield stress, is the effective plastic strain, is the effective plastic strain rate, and the

constants, , , and can be expressed as functions of effective plastic strain or can be constant with respect to the plastic strain. The case of no strain hardening can be obtained by setting the exponent of the plastic strain equal to a very small positive value; i.e., 0.0001.

This model can be combined with the superplastic forming input to control the magnitude of the pressure in the pressure boundary conditions in order to limit the effective plastic strain rate so that it does not exceed a maximum value at any integration point within the model.

A fully viscoplastic formulation is optional. An additional cost is incurred but the improvement is results can be dramatic.

Material Model 65: Modified Zerilli/ArmstrongThe Armstrong-Zerilli Material Model expresses the flow stress as follows.

V

σi j

d

a

E

bc

Volumetric Strain Vln–

σ kεmε· n=

σ ε ε·

k m n

Page 137: SimXpert R3.2 Explicit Workspace Guide

131MaterialsMaterials

For fcc metals,

(3-191)

effective plastic strain

effective plastic strain rate where , 1e-3, le-6 for time units

of seconds, milliseconds, and microseconds, respectively.

For bcc metals,

(3-192)

where

(3-193)

The relationship between heat capacity (specific heat) and temperature may be characterized by a cubic polynomial equation as follows:

(3-194)

A fully viscoplastic formulation is optional. An additional cost is incurred but the improvement in results can be dramatic.

Material Model 67: Nonlinear Stiffness/Viscous 3-D Discrete BeamThe formulation of the discrete beam (Type 6) assumes that the beam is of zero ngth and requires no orientation node. A small distance between the nodes joined by the beam is permitted. The local coordinate system which determines (r, s, t) is given by the coordinate ID in the cross-sectional input where the global system is the default. The local coordinate system axes rotate with the average of the rotations of the two nodes that define the beam.

For null load curve IDs, no forces are computed. The force resultants are found from load curves (see Figure 3-11) that are defined in terms of the force resultant versus the relative displacement in the local coordinate system for the discrete beam. The resultant forces and moments are determined by a table

σ C1 C2 εp( )1 2⁄ e C3– C4 ε· *( )ln+( )τ[ ] C3+{ } μ T( )μ 293( )----------------- +=

εp =

ε· * ε·

ε· 0

-----= ε· 0 1=

σ C1 C2e C3– c4lm ε· *( )+( )τ C5 εp( )n C6+[ ] μ T( )μ 293( )----------------- + +=

μ T( )μ 293( )----------------- B1 B2T B3T2+ +=

Cp G1 G2T G3T2 G4T3+ + +=

Page 138: SimXpert R3.2 Explicit Workspace Guide

Materials132

lookup, if the origin of the load curve is at [0,0], as shown in Figure 3-11b, and the tension and compression responses are symmetric.

Figure 3-11 Resultant Forces and Moments Determined by Table Lookup

Material Model 68: Nonlinear Plastic/Linear Viscous 3-D Discrete Beam The folmulation of the discrete beam (Type 6) assumes that the beam is of zero length and requires no orientation node. A small distance between the nodes joined by the beam is permitted. The local coordinate system, which determines (r, s, t) is given by the coordinate ID in the cross-sectional input where the global system is the default. The local coordinate system axes rotate with the average of the rotations of the two nodes that define the beam. Each force resultant in the local system can have a limiting value defined as a function of plastic displacement by using a load curve (see Figure 3-12). For the degrees of freedom where elastic behavior is desired, the load curve ID is simply set to zero.

Figure 3-12 Resultant Forces and Moments Limited by the Yield Definition

DISPLACEMENT

RESULTANT

RESULTANT

DISPLACEMENT(a) (b)

RESULTANT

PLASTIC DISPLACEMENT

Page 139: SimXpert R3.2 Explicit Workspace Guide

133MaterialsMaterials

Catastrophic failure, based on force resultants, occurs if the following inequality is satisfied:

(3-195)

Likewise, catastrohic failure based on displacement resultants occurs if:

(3-196)

After failure, the discrete element is deleted. If failure is included, either one or both of the criteria may be used.

Material Model 69: Side Impact Dummy Damper (SID Damper)The side impact dummy uses a damper that is not adequately treated by nonlinear force versus relative velocity curves, since the force characteristics are also dependent on the displacement of the piston. As the damper moves, the fluid flows through the open orifices to provide the necessary damping resistance. While moving as shown in Figure 3-13, the piston gradually blocks off and effectively closes the orifices. The number of orifices and the size of their openings control the damper resistance and performance. The damping force is computed from the equation.

(3-197)

where is a user defined constant or a tabulated function of the absolute value of the relative velocity,

is the piston's relative velocity, is the discharge coefficient, is the piston area, is the total

Fr

Frfail

---------- 2 Fs

Fsfail

---------- 2 Ft

Ftfail

---------- 2 Mr

Mrfail

------------ 2 Ms

Msfail

------------ 2 Mt

Mtfail

------------ 2

1 0≥–+ + + + +

ur

urfail

---------- 2 us

usfail

---------- 2 ut

utfail

---------- 2 θr

θrfail

---------- 2 θs

θsfail

---------- 2 θt

θtfail

---------- 2

1 0≥–+ + + + +

F SF KApVp

Cl

A0t

------ C2 Vp ρfluid

Ap

CA0t

---------- 2

1–+

f s s0+( )– Vpg s s0+( ) }+

=

K

Vp C Ap A0t

Page 140: SimXpert R3.2 Explicit Workspace Guide

Materials134

open areas of orifices at time , is the fluid density, is the coefficient for the linear term, and

is the coefficient for the quadratic term.

Figure 3-13 Mathematical Model for Side Impact Dummy Damper

In the implementation, the orifices are assumed to be circular with partial covering by the orifice controller. As the piston closes, the closure of the orifice is gradual. This gradual closure is taken into

account to insure a smooth response. If the piston stroke is exceeded, the stiffness value, , limits further movement; i.e., if the damper bottoms out in tension or compression, the damper forces are calculated by

replacing the damper by a bottoming out spring and damper, and , respectively. The piston stroke must exceed the initial length of the beam element. The time step calculation is based in part on the stiffness value of the bottoming out spring. A typical force versus displacement curve at constant relative

t ρfluid C1

C2

k

k c

Page 141: SimXpert R3.2 Explicit Workspace Guide

135MaterialsMaterials

velocity with only the linear velocity term active is shown in Figure 3-14. The factor, , which scales the force defaults to 1.0 and is analogous to the adjusting ring on the damper.

Figure 3-14 Force Versus Displacement

Material Model 70: Hydraulic/Gas DamperThis special purpose element represents a combined hydraulic and gas-filled damper which has a variable orifice coefficient. A schematic of the damper is shown in Figure 3-15. Dampers of this type are sometimes used on buffers at the end of railroad tracks and as aircraft undercarriage shock absorbers. This material can be used only as a discrete beam element.

As the damper is compressed two actions contribute to the force that develops. First, the gas is adiabatically compressed into a smaller volume. Secondly, oil is forced through an orifice. A profiled pin may occupy some of the cross-sectional area of the orifice; thus, the orifice area available for the oil varies with the stroke. The force is assumed proportional to the square of the velocity and inversely proportional to the available area. The equation for this element is:

(3-198)

SF

FORCE

Displacement

Force increases as orficeis gradually covered

Last orficecloses

Linear loading afterofifices close

F SCLF KhVa0----- 2

P0

C0

C0 S–---------------

nPa– Ap⋅+

⋅=

Page 142: SimXpert R3.2 Explicit Workspace Guide

Materials136

where is the element deflection and is the relative velocity across the element.

Figure 3-15 Schematic of Hydraulic/Gas Damper

Material Model 71: Cable

This material can be used only as a discrete beam element. The force, , generated by the cable is nonzero only if the cable is in tension. The force is given by:

(3-199)

where is the change in length

(3-200)

and the stiffness is defined as:

(3-201)

The area and offset are defined on either the cross section or element cards in the SOL 700 input. For a slack cable the offset should be input as a negative length. For an initial tensile force the offset should be positive. If a load curve is specified, the Young’s modulus will be ignored and the load curve will be used instead. The points on the load curve are defined as engineering stress versus engineering strain; i.e., the change in length over the initial length. The unloading behavior follows the loading.

Material Model 73: Low Density Viscoelastic FoamThis viscoelastic foam model is available to model highly compressible viscous foams. The hyperelastic formulation of this model follows that of material 57.

Rate effects are accounted for through linear viscoelasticity by a convolution integral of the form

S V

F

F K max ΔL 0.,( )⋅=

ΔL

ΔL current length initial length offset–( )–=

KE area⋅

initial length offset–( )-------------------------------------------------------------=

Page 143: SimXpert R3.2 Explicit Workspace Guide

137MaterialsMaterials

(3-202)

where is the relaxation function. The stress tensor, , augments the stresses

determined from the foam, ; consequently, the final stress, , is taken as the summation of the

two contributions:

(3-203)

Since we wish to include only simple rate effects, the relaxation function is represented by up to six terms of the Prony series:

(3-204)

This model is effectively a Maxwell fluid which consists of a dampers and springs in series. The formulation is performed in the local system of principal stretches where only the principal values of stress are computed and triaxial coupling is avoided. Consequently, the one-dimensional nature of this foam material is unaffected by this addition of rate effects. The addition of rate effects necessitates 42 additional history variables per integration point. The cost and memory overhead of this model comes primarily from the need to “remember” the local system of principal stretches and the evaluation of the viscous stress components

Material Model 74: Elastic Spring for the Discrete BeamThis model permits elastic springs with damping to be combined and represented with a discrete beam element type 6. Linear stiffness and damping coefficients can be defined and, for nonlinear behavior, a force versus deflection and force versus rate curves can be used. Displacement based failure and an initial force are optional

If the linear spring stiffness is used, the force, , is given by:

where is the stiffness constant, and is the viscous damping coefficient.

If the load curve ID for . is specified, nonlinear behavior is activated. For this case the force is given by:

σijr gijkl t τ–( )

∂εkl

∂τ--------- τd

0

t=

gijkl t τ–( ) σijr

σijf σij

σij σijf σij

r+=

g t( ) α0 αme βt–

m 1=

N

+=

F

F F0 FΔL DΔL+ +=

K D

f ΔL( )

Page 144: SimXpert R3.2 Explicit Workspace Guide

Materials138

(3-206)

where and are damping coefficients for nonlinear behavior, is a factor to scale time

units, and . is an optional load curve defining a scale factor versus deflection for load curve ID,

.

In these equations, is the change in length

.

Failure can occur in either compression or tension based on displacement values of CDF and TDF, respectively. After failure no forces are carried. Compressive failure does not apply if the spring is initially zero length.

The cross sectional area is defined on the beam property card for the discrete beam elements. The square root of this area is used as the contact thickness offset if these elements are included in the contact treatment.

Material Model 76: General ViscoelasticRate effects are taken into account through linear viscoelasticity by a convolution integral of the form:

(3-207)

where is the relaxation function.

If we wish to include only simple rate effects for the deviatoric stresses, the relaxation function is represented by six terms from the Prony series:

(3-208)

F F0 Kf ΔL( ) 1 C1 ΔL· C2 ΔL·( ) max 1.ΔL·

DLE------------,

lnsgn⋅+⋅++=

+DΔL· g ΔL( )h ΔL·( )+

C1 C2 DLE

g ΔL( )h ΔL dt⁄( )

ΔL

ΔL currentlength initiallength–=

σij gijkl t τ–( )∂εkl

∂τ--------- τd

0

t=

gijkl t τ–( )

g t( ) Gme βmt–

m 1=

N

=

Page 145: SimXpert R3.2 Explicit Workspace Guide

139MaterialsMaterials

We characterize this in the input by shear modulii, , and decay constants, . An arbitrary number of

terms, up to 6, may be used when applying the viscoelastic model.

Figure 3-16 Relaxation Curve

For volumetric relaxation, the relaxation function is also represented by the Prony series in terms of bulk modulii:

(3-209)

Material Model 77: Hyperviscoelastic RubberRubber is generally considered to be fully incompressible since the bulk modulus greatly exceeds the shear modulus in magnitude. To model the rubber as an unconstrained material a hydrostatic work term,

Gi βi

Note: This curve defines stress versus time where time is defined on a logarithmic scale. For best results, the points defined in the load curve should be equally spaced on the logarithmic scale. Furthermore, the load curve should be smooth and defined in the positive quadrant. If nonphysical values are determined by least squares fit, SOL 700 will terminate with an error message after the initialization phase is completed. If the ramp time for loading is included, then the relaxation which occurs during the loading phase is taken into account. This effect may or may not be important.

k t( ) Kmeβkm

t–

m 1=

N

=

Page 146: SimXpert R3.2 Explicit Workspace Guide

Materials140

, is included in the strain energy functional which is function of the relative volume, ,

[Ogden, 1984]:

(3-210)

In order to prevent volumetric work from contributing to the hydrostatic work the first and second invariants are modified as shown. This procedure is described in more detail by Sussman and Bathe [1987]. For the Ogden model the energy equation is given as:

(3-211)

where the asterisk indicates that the volumetric effects have be eliminated from the principal

stretches, . See Ogden [1984] for more details.

Rate effects are taken into account through linear viscoelasticity by a convolution integral of the form:

(3-212)

or in terms of the second Piola-Kirchhoff stress, , and Green's strain tensor, ,

(3-213)

where and are the relaxation functions for the different stress measures. This

stress is added to the stress tensor determined from the strain energy functional.

If we wish to include only simple rate effects, the relaxation function is represented by six terms from the Prony series:

(3-214)

given by,

WH J( ) J( )

W J1 J2 J,,( ) Cpq J1 3–( )p J2 3–( )q WH J( )+

p q, 0=

n

=

J1 I1I31 2⁄–=

J2 I2I31 2⁄–=

W∗μj

αj----- λi

*α1 1–( ) 12---K J 1–( )2+

j 1=

n

i 1=

3

=

*( )λj

*

σij gijkl t τ–( )∂εkl

∂τ--------- τd

0

t

=

Sij Eij

Sij Gijkl t τ–( )∂Ekl

∂τ---------- τd

0

t

gijkl t τ–( ) Gijkl t τ–( )

g t( ) α0 αme βt–

m 1=

N

+=

Page 147: SimXpert R3.2 Explicit Workspace Guide

141MaterialsMaterials

(3-215)

This model is effectively a Maxwell fluid which consists of a dampers and springs in series. We

characterize this in the input by shear moduli, , and decay constants, . The viscoelastic behavior is

optional and an arbitrary number of terms may be used.

The Mooney-Rivlin rubber model is obtained by specifying . In spite of the differences in formulations with Model 27, we find that the results obtained with this model are nearly identical with those of Model 27 as long as large values of Poisson’s ratio are used.

When viscoelastic terms are not included, this model is similar to the use of the Ogden model in solution 600, defined on the MATHE option.

Material Model 79: Hysteretic SoilThis model is a nested surface model with five superposed “layers” of elasto-perfectly plastic material, each with its own elastic modulii and yield values. Nested surface models give hysteretic behavior, as the different “layers” yield at different stresses.

The constants ( , , ) govern the pressure sensitivity of the yield stress. Only the ratios between

these values are important - the absolute stress values are taken from the stressstrain curve.

The stress strain pairs ( , ) define a shear stress versus shear strain curve. The first point on the curve is assumed by default to be (0,0) and does not need to be entered. The slope of the

curve must decrease with increasing . Not all five points need be to be defined. This curve applies at

the reference pressure; at other pressures, the curve variesaccording to , , and as in the soil

and crushable foam model, Material 5.

The elastic moduli G and K are pressure sensitive.

where and are the input values, is the current pressure, the cut-off or referencepressure

(must be zero or negative). If attempts to fall below (i.e., more tensile) the shear stresses are set to

zero and the pressure is set to . Thus, the material has no stiffness orstrength in tension. The pressure

in compression is calculated as follows:

g t( ) Gieβit–

j 1=

n

=

Gi βi

n 2+

a0 a1 a2

γ1 τ1,( ) … γ5 τ5,( )

γa0 a1 a2

G G0 p p0–( )b=

K K0 p p0–( )b=

G0 K0 p po

p po

po

Page 148: SimXpert R3.2 Explicit Workspace Guide

Materials142

where is the relative volume; i.e., the ratio between the original and current volume.

Material Model 80: Ramberg-Osgood PlasticityThe Ramberg-Osgood equation is an empirical constitutive relation to represent the one-dimensional elastic-plastic behavior of many materials, including soils. This model allows a simple rate independent representation of the hysteretic energy dissipation observed in soils subjected to cyclic shear deformation. For monotonic loading, the stress-strain relationship is given by:

(3-216)

where is the shear strain and is the shear stress. The model approaches perfect plasticity as the stress

exponent . These equations must be augmented to correctly model unloading and reloading

material behavior. The first load reversal is detected by . After the first reversal, the stress-strain relationship is modified to

(3-217)

where and represent the values of strain and stress at the point of load reversal. Subsequent load

reversals are detected by .

The Ramberg-Osgood equations are inherently one-dimensional and are assumed to apply to shear components. To generalize this theory to the multidimensional case, it is assumed that each component of the deviatoric stress and deviatoric tensorial strain is independently related by the one-dimensional stress-strain equations. A projection is used to map the result back into deviatoric stress space if required.

The volumetric behavior is elastic, and, therefore, the pressure is found by

(3-218)

where is the volumetric strain.

p K0 V( )ln–[ ]1

1 b–------------

=

V

γγy---- τ

τy---- α τ

τy----

r+= if γ 0≥

γγy---- τ

τy---- α τ

τy----

r–= if γ 0<

γ τr ∞→

γγ· 0<

γ γ0–( )2γy

------------------τ τ0–( )2τy

------------------ α τ τ0–( )2τy

------------------r

+= if γ 0≥

γ γ0–( )2γy

------------------τ τ0–( )2τy

------------------ α τ τ0–( )2τy

------------------r

–= if γ 0<

γ0 τ0

( )0 0γ γ γ− <

p

p Kεv=

εv

Page 149: SimXpert R3.2 Explicit Workspace Guide

143MaterialsMaterials

Material Model 81 and 82: Plasticity with Damage and Orthotropic OptionWith this model an elasto-viscoplastic material with an arbitrary stress versus strain curve and arbitrary strain rate dependency can be defined. Damage is considered before rupture occurs. Also, failure based on a plastic strain or a minimum time step size can be defined.

An option in the keyword input, ORTHO, is available, which invokes an orthotropic damage model. This option, which is implemented only for shell elements with multiple integration points through thickness, is an extension to include orthotropic damage as a means of treating failure in aluminum panels. Directional damage begins after a defined failure strain is reached in tension and continues to evolve until a tensile rupture strain is reached in either one of the two orthogonal directions.

The stress versus strain behavior may be treated by a bilinear stress strain curve by defining the tangent modulus, ETAN. Alternately, a curve similar to that shown in Figure 3-17 is expected to be defined by (EPS1,ES1) - (EPS8,ES8); however, an effective stress versus effective plastic strain curve (LCSS) may be input instead if eight points are insufficient. The cost is roughly the same for either approach. The most general approach is to use the table definition (LCSS) discussed below.

Two options to account for strain rate effects are possible. Strain rate may be accounted for using the Cowper and Symonds model which scales the yield stress with the factor,

(3-219)

where is the strain rate, . If the viscoplastic option is active, VP=1.0, and if SIGY is > 0

then the dynamic yield stress is computed from the sum of the static stress, , which is typically

given by a load curve ID, and the initial yield stress, SIGY, multiplied by the Cowper-Symonds rate term as follows:

(3-220)

where the plastic strain rate is used. If SIGY=0, the following equation is used instead where the static

stress, , must be defined by a load curve:

(3-221)

This latter equation is always used if the viscoplastic option is off.

For complete generality a load curve (LCSR) to scale the yield stress may be input instead. In this curve the scale factor versus strain rate is defined.

1ε·

C----

1 p⁄+

ε· ε· εijε·

ij=

σys εeff

p( )

σy εeffp ε· eff

p,( ) σys εeff

p( ) SIGYε· eff

p

C--------

1 p⁄⋅+=

σys εeff

p( )

σy εeffp ε· eff

p,( ) σys 1

ε· effp

C--------

1 p⁄+=

Page 150: SimXpert R3.2 Explicit Workspace Guide

Materials144

The constitutive properties for the damaged material are obtained from the undamaged material

properties. The amount of damage evolved is represented by the constant, , which varies from zero if no damage has occurred to unity for complete rupture. For uniaxial loading, the nominal stress in the damaged material is given by:

(3-222)

where is the applied load and A is the surface area. The true stress is given by:

(3-223)

where is the void area. The damage variable can then be defined:

(3-224)

In this model damage is defined in terms of plastic strain after the failure strain is exceeded:

if (3-225)

After exceeding the failure strain softening begins and continues until the rupture strain is reached.

By default, deletion of the element occurs when all integration points in the shell have failed.

ω

σnominalPA---=

P

σtrueP

A Aloss–---------------------=

Aloss

ωAloss

A-----------= 0 ω 1≤ ≤

ωεeff

p εfailurep–

εrapturep εfailure

p–-----------------------------------------= εfailure

p εeffp εrupture

p≤ ≤

Page 151: SimXpert R3.2 Explicit Workspace Guide

145MaterialsMaterials

Note in Figure 3-18 that the origin of the curve is at (0,0). It is permissible to input the failure strain, , as zero for this option. The nonlinear damage curve is useful for controlling the softening behavior after the failure strain is reached.

Figure 3-17 Stress Strain Behavior When Damage is Included.

Figure 3-18 A Nonlinear Damage Curve (Optional)

fs

0Failure Begins

Rupture

Damage increases linearly withplastic strain after failure

Nominal stressafter failure

Yield stress versuseffective plastic strainfor undamaged material

σyield

ω 0=ω 1= εeff

p

1

Dam

age

Failureεeff

p fs–

Page 152: SimXpert R3.2 Explicit Workspace Guide

Materials146

Material Model 83: Fu-Chang’s Foam With Rate EffectsThis model allows rate effects to be modeled in low and medium density foams, see Figure 3-19. Hysteretic unloading behavior in this model is a function of the rate sensitivity with the most rate sensitive foams providing the largest hysteresis and visa versa. The unified constitutive equations for foam materials by Fu-Chang [1995] provide the basis for this model. This implementation incorporates the coding in the reference in modified form to ensure reasonable computational efficiency. The mathematical description given below is excerpted from the reference.

The strain is divided into two parts: a linear part and a non-linear part of the strain

(3-226)

and the strain rate become

(3-227)

is an expression for the past history of . A postulated constitutive equation may be written as:

(3-228)

where is the state variable and is a functional of all values of in and

(3-229)

where is the history parameter:

(3-230)

It is assumed that the material remembers only its immediate past, i.e., a neighborhood about .

Therefore, an expansion of in a Taylor series about yields:

(3-231)

Hence, the postulated constitutive equation becomes:

(3-232)

E t( ) EL t( ) EN t( )+=

E· t( ) E· L t( ) E· N t( )+=

E· N EN

σ t( ) EtN τ( ) S t( ),[ ] τd

τ = 0

=

S t( )τ = 0

τ Tτ : 0 τ ∞≤ ≤

EtN τ( ) EN t τ–( )=

τ

EtN τ = ∞( ) the virgin material⇔

τ 0=

EtN τ( ) τ 0=

EtN τ( ) EN 0( )

∂EtN

∂t---------- 0( )dt+=

σ t( ) σ∗ EN t( ) E· N t( ) S t( ),,( )=

Page 153: SimXpert R3.2 Explicit Workspace Guide

147MaterialsMaterials

where we have replaced by , and is a function of its arguments.

For a special case,

(3-233)

we may write

(3-234)

which states that the nonlinear strain rate is the function of stress and a state variable which represents the history of loading. Therefore, the proposed kinetic equation for foam materials is:

(3-235)

where and are material constants, and is the overall state variable. If either or

then the nonlinear strain rate vanishes.

(3-236)

(3-237)

(3-238)

(3-239)

where and are material constants and:

(3-240)

∂EtN

∂t---------- E· N σ∗

σ t( ) σ∗ E· N t( ) S t( ),( )=

E· tN f S t( ) s t( ),( )=

E· N σσ

--------D0 c0tr σS( )

σ 2( )---------------- 2n0

–exp=

D0 c0, n0 S D0 0=

c0 ∞→

S· ij c1 aijR c2Sij–( )P c3Wn1 W· N( )n2Iij+[ ]R=

R 1 c4E· N

c5----------- 1–

n3

+=

P tr σE· N( )=

W tr σ Ed( )=

c1 c2 c3 c4 c5 n1 n2 n3, , , , , , , , aij

σ σijσij( )1 2/=

E· E· ijE·

ij( )1 2/=

EN· E· ijNE· ij

N( )1 2/=

Page 154: SimXpert R3.2 Explicit Workspace Guide

Materials148

In the implementation by Fu Chang the model was simplified such that the input constants and the

state variables are scalars.

Figure 3-19 Rate Effects in Fu Chang's Foam Model

Material Model 87: Cellular RubberThis material model provides a cellular rubber model combined with linear viscoelasticity as outlined by Christensen [1980].

Rubber is generally considered to be fully incompressible since the bulk modulus greatly exceeds the shear modulus in magnitude. To model the rubber as an unconstrained material a hydrostatic work term,

, is included in the strain energy functional which is function of the relative volume, ,

[Ogden, 1984]

(3-241)

In order to prevent volumetric work from contributing to the hydrostatic work the first and second invariants are modified as shown. This procedure is described in more detail by Sussman and Bathe [1987].

aij

Sij

WH J( ) J

W J1 J2 J,,( ) Cpq J1 3–( )p J2 3–( )q WH+

p q, 0=

n

=

J1 I1I31 3⁄–

=

J2 I2I32 3⁄–

=

Page 155: SimXpert R3.2 Explicit Workspace Guide

149MaterialsMaterials

The effects of confined air pressure in its overall response characteristics are included by augmenting the stress state within the element by the air pressure.

(3-242)

where is the bulk skeletal stress and is the air pressure computed from the equation:

(3-243)

where is the initial foam pressure usually taken as the atmospheric pressure and defines the

volumetric strain

(3-244)

where is the relative volume of the voids and is the initial volumetric strain which is typically zero.

The rubber skeletal material is assumed to be incompressible.

Rate effects are taken into account through linear viscoelasticity by a convolution integral of the form:

(3-245)

or in terms of the second Piola-Kirchhoff stress, , and Green's strain tensor, ,

(3-246)

where and are the relaxation functions for the different stress measures. This

stress is added to the stress tensor determined from the strain energy functional.

Since we wish to include only simple rate effects, the relaxation function is represented by one term from the Prony series:

(3-247)

given by

. (3-248)

σij σijsk δijσair–=

σijsk σair

σairp0γ

1 γ φ–+--------------------–=

p0 γ

γ V 1– γ0+=

V γ0

σij gijkl t τ–( )∂εkl

∂τ--------- td

0

t

=

Sij Eij

Sij Gijkl t τ–( )∂Ekl

∂τ---------- td

0

t

=

gijkl t τ–( ) Gijkl t τ–( )

g t( ) a0 αm e βt–+

m 1=

N

+=

g t( ) Ede β1t–=

Page 156: SimXpert R3.2 Explicit Workspace Guide

Materials150

This model is effectively a Maxwell fluid which consists of a damper and spring in series. We

characterize this in the input by a shear modulus, , and decay constant, .

The Mooney-Rivlin rubber model is obtained by specifying . In spite of the differences in formulations with Model 27, we find that the results obtained with this model are nearly identical with those of 27 as long as large values of Poisson’s ratio are used. By setting the initial air pressure to zero, an open cell, cellular rubber can be simulated as shown in Figure 3-20.

Figure 3-20 Cellular Rubber with Entrapped Air

Material Model 89: Plasticity PolymerUnlike other MD Nastran SOL 700 material models, both the input stress-strain curve and the strain to failure are defined as total true strain, not plastic strain. The input can be defined from uniaxial tensile tests; nominal stress and nominal strain from the tests must be converted to true stress and true strain. The elastic component of strain must not be subtracted out.

The stress-strain curve is permitted to have sections steeper (i.e. stiffer) than the elastic modulus. When these are encountered the elastic modulus is increased to prevent spurious energy generation.

Material Model 94: Inelastic Spring Discrete BeamThe yield force is taken from the load curve:

(3-249)

where is the plastic deflection. A trial force is computed as:

G β1

n 1=

FY Fy ΔLplastic( )=

Lplastic

Page 157: SimXpert R3.2 Explicit Workspace Guide

151MaterialsMaterials

(3-250)

and is checked against the yield force to determine :

(3-251)

The final force, which includes rate effects and damping, is given by:

(3-252)

where , are damping coefficients, is a factor to scale time units.

Unless the origin of the curve starts at (0,0), the negative part of the curve is used when the spring force

is negative where the negative of the plastic displacement is used to interpolate, . The positive part

of the curve is used whenever the force is positive. In these equations, is the change in length

Material Model 97: General Joint Discrete BeamFor explicit calculations, the additional stiffness due to this joint may require additional mass and inertia for stability. Mass and rotary inertia for this beam element is based on the defined mass density, the volume, and the mass moment of inertia defined in the beam property input.

The penalty stiffness applies to explicit calculations. For implicit calculations, constraint equations are generated and imposed on the system equations; therefore, these constants, RPST and RPSR, are not used.

Material Model 98: Simplified Johnson CookJohnson and Cook express the flow stress as

where

A, B, C and n are input constants

FT Fn K ΔL· Δt⋅⋅+=

F

F FY

FT

= if FT FY>if FT FY≤

Fn 1+ F 1 C1 ΔL· C2 ΔL·( ) max 1.ΔL·

DLE------------,

lnsgn⋅+⋅+ DΔL· g ΔL( )h ΔL·( )+ +⋅=

C1 C2 DLE

Fy

ΔL

ΔL current length initial length–=

σy A Bεpn+( ) 1 c ε· *ln+( )=

Page 158: SimXpert R3.2 Explicit Workspace Guide

Materials152

The maximum stress is limited by sigmax and sigsat by:

Failure occurs when the effective plastic strain exceeds psfail.

If the viscoplastic option is active, VP=1.0, the SIGMAX and SIGSAT parameters are ignored since these parameters make convergence of the viscoplastic strain iteration loopdifficult to achieve. The viscoplastic option replaces the plastic strain in the forgoing equationsby the viscoplastic strain and the strain rate by the viscoplastic strain rate. Numerical noise issubstantially reduced by the viscoplastic formulation.

Material Model 100: Spot WeldThis material model applies to beam element type 9 for spot welds. These beam elements may be placed between any two deformable shell surfaces, see Figure 3-21, and tied with type 7 constraint contact which eliminates the need to have adjacent nodes at spot weld locations. Beam spot welds may be placed between rigid bodies and rigid/deformable bodies by making the node on one end of the spot weld a rigid body node which can be an extra node for the rigid body. In the same way, rigid bodies may also be tied together with this spot weld option.

Figure 3-21 Deformable Spotwelds

It is advisable to include all spot welds which can be arbitrarily placed within the structure, which provide the slave nodes, and spot welded materials, which define the master segments, within a single type 7 tied interface. As a constraint method, multiple type 7 interfaces are treated independently which can lead to significant problems if such interfaces share common nodal points. The offset option, “o 7”, should not be used with spot welds.

ellective plastic strain

effective strain rate for

εp

ε· *ε·

ε· 0

-----= ε· 0 1s 1–=

σy min min A Bεpnsigmax,+[ ] 1 c ε· *ln+( ) sigsat,{ }=

Page 159: SimXpert R3.2 Explicit Workspace Guide

153MaterialsMaterials

The weld material is modeled with isotropic hardening plasticity coupled to two failure models. The first model specifies a failure strain which fails each integration point in the spot weld independently. The second model fails the entire weld if the resultants are outside of the failure surface defined by:

(3-253)

where the numerators in the equation are the resultants calculated in the local coordinates of the cross section, and the denominators are the values specified in the input. If the user defined parameter, NF, which the number of force vectors stored for filtering, is nonzero the resultants are filtered before failure is checked. The default value is set to zero which is generally recommended unless oscillatory resultant forces are observed in the time history databases. Even though these welds should not oscillate significantly, this option was added for consistency with the other spot weld options. NF affects the storage since it is necessary to store the resultant forces as history variables.

If the failure strain is set to zero, the failure strain model is not used. In a similar manner, when the value of a resultant at failure is set to zero, the corresponding term in the failure surface is ignored. For example,

if only is nonzero, the failure surface is reduced to . None, either, or both of the

failure models may be active depending on the specified input values.

The inertias of the spot welds are scaled during the first time step so that their stable time step size is Δt. A strong compressive load on the spot weld at a later time may reduce the length of the spot weld so that

stable time step size drops below . If the value of is zero, mass scaling is not performed, and the spot welds will probably limit the time step size. Under most circumstances, the inertias of the spot welds are small enough that scaling them will have a negligible effect on the structural response and the use of this option is encouraged.

Spotweld force history data is written into the SWFORC ASCII file. In this database the resultant moments are not available, but they are in the binary time history database.

The constitutive properties for the damaged material are obtained from the undamaged material

properties. The amount of damage evolved is represented by the constant, , which varies from zero if no damage has occurred to unity for complete rupture. For uniaxial loading, the nominal stress in the damaged material is given by

(3-254)

where is the applied load and is the surface area. The true stress is given by:

(3-255)

Nrr

NrrF

----------

2 Nrs

NrsF

----------

2 Nrt

NrtF

---------

2 Mrr

MrrF

-----------

2 Mss

MssF

-----------

21

Trr

TrrF

---------

2–+ + + + 0=

NrrFNrr NrrF

=

Δt Δt

ω

σnominalPA---=

P A

σtrueP

A Aloss–---------------------=

Page 160: SimXpert R3.2 Explicit Workspace Guide

Materials154

where is the void area. The damage variable can then be defined:

(3-256)

In this model damage is defined in terms of plastic strain after the failure strain is exceeded:

(3-257)

After exceeding the failure strain softening begins and continues until the rupture strain is reached.

Material Model 119: General Nonlinear Six Degrees of Freedom Discrete BeamCatastrophic failure, which is based on displacement resultants, occurs if either of the following inequalities are satisfied:

(3-258)

Aloss

ωAloss

A-----------= 0 ω 1≤ ≤

ω εeff

p εfailurep

εrupturep εfailure

p–

---------------------------------------- if εfailurep εeff

p εrupturep≤ ≤=

ur

urtfail

----------- 2 us

ustfail

----------- 2 ut

uttfail

----------- 2 θt

θrtfail

----------- 2 θs

θstfail

----------- 2 θt

θttfail

----------- 2

1. 0≥–+ + + + +

ur

urcfail

------------ 2 us

uscfail

------------ 2 ut

utcfail

------------ 2 θt

θrcfail

------------ 2 θs

θscfail

------------ 2 θt

θtcfail

------------ 2

1. 0≥–+ + + + +

Page 161: SimXpert R3.2 Explicit Workspace Guide

155MaterialsMaterials

After failure the discrete element is deleted. If failure is included either the tension failure or the compression failure or both may be used.

Figure 3-22 Load and Unloading Behavior

Material Model 126: Modified HoneycombFor efficiency it is strongly recommended that the load curve ID’s: LCA, LCB, LCC, LCS, LCAB, LCBC, and LCCA, contain exactly the same number of points with corresponding strain values on the abscissa. If this recommendation is followed the cost of the table lookup is insignificant. Conversely, the cost increases significantly if the abscissa strain values are not consistent between load curves.

The behavior before compaction is orthotropic where the components of the stress tensor are uncoupled; i.e., a component of strain will generate resistance in the local α-direction with no coupling to the local b and c directions. The elastic modulii vary from their initial values to the fully coaaumpacted values linearly with the relative volume:

(3-259)

Unload = 0 Unload = 1

Unload = 2 Unload = 3

RESULTANT

RESULTANT

RESULTANT

RESULTANT

DISPLACEMENT

DISPLACEMENT DISPLACEMENT

DISPLACEMENT

Unloading Curve

Unloading Curve

Loading-unloading Curve

Unloading Curve

OFFSET x UminUmin

Eaa Eaau βaa E Eaau–( )+=Ebb Ebbu βbb E Ebbu–( )+=Ecc Eccu βcc E Eccu–( )+=

Gab Gabu β G Gabu–( )+=Gbc Gbcu β G Gbcu–( )+=Gca Gcau β G Gcau–( )+=

Page 162: SimXpert R3.2 Explicit Workspace Guide

Materials156

where

(3-260)

and is the elastic shear modulus for the fully compacted honeycomb material

(3-261)

The relative volume, , is defined as the ratio of the current volume over the initial volume, and

typically, at the beginning of a calculation.

The load curves define the magnitude of the stress as the material undergoes deformation. The first value in the curve should be less than or equal to zero corresponding to tension and increase to full compaction. Care should be taken when defining the curves so the extrapolated values do not lead to negative yield stresses.

At the beginning of the stress update we transform each element’s stresses and strain rates into the local element coordinate system. For the uncompacted material, the trial stress components are updated using the elastic interpolated modulii according to:

(3-262)

We then independently check each component of the updated stresses to ensure that they do not exceed the permissible values determined from the load curves, e.g., if

(3-263)

then

(3-264)

The components of are defined by load curves. The parameter is either unity or a value taken

from the load curve number, LCSR, that defines as a function of strain-rate. Strain-rate is defined here as the Euclidean norm of the deviatoric strain-rate tensor.

For fully compacted material we assume that the material behavior is elastic-perfectly plastic and updated the stress components according to:

B max min1 v–1 vf–------------- 1, 0, =

G

GE

2 1 υ+( )---------------------=

νV 1=

σaan 1trial+ σaa

n EaaΔεaa+=

σbbn 1trial+ σbb

n EbbΔεbb+=

σccn 1trial+ σcc

n EccΔεcc+=

σabn 1trial+ σab

n 2GabΔεab+=

σbcn 1trial+ σbc

n 2GbcΔεbc+=

σcan 1trial+ σca

n 2GcaΔεca+=

σijn 1trial+ λσij εij( )>

σijn 1+ σij εij( )

λσijn 1 trial+

σin 1trial+

-----------------------=

σij εij( ) λ

λ

Page 163: SimXpert R3.2 Explicit Workspace Guide

157MaterialsMaterials

(3-265)

where the deviatoric strain increment is defined as

(3-266)

We now check to see if the yield stress for the fully compacted material is exceeded by comparing

(3-267)

the effective trial stress to the yield stress, . If the effective trial stress exceeds the yield stress, we

simply scale back the stress components to the yield surface

(3-268)

We can now update the pressure using the elastic bulk modulus,

(3-269)

and obtain the final value for the Cauchy stress

(3-270)

After completing the stress update we transform the stresses back to the global configuration.

sijtrial sij

n 2GΔεijdevn 1+ 2⁄

+=

Δεijdev Δεij

13---Δεkkδij–=

sefftrial 3

2---sij

trialsijtrial

1 2⁄

=

σy

sijn 1+

σy

sefftrial

-----------sijtrial=

K

pn 1+ pn KΔεkkn 1 2⁄+–=

KE

3 1 2υ–( )------------------------=

σijn 1+ sij

n 1+ pn 1+ δij–=

Page 164: SimXpert R3.2 Explicit Workspace Guide

Materials158

In Figure 3-23, note that the "yield stress" at a strain of zero is nonzero. In the load curve definition, the "time" value is the directional strain and the "function" value is the yield stress.

Figure 3-23 Stress Quantity Versus Strain

Material Model 127: Arruda-Boyce Hyperviscoelastic RubberThis material model, described in the paper by Arruda and Boyce [1993], provides a rubber model that is optionally combined with linear viscoelasticity. Rubber is generally considered to be fully incompressible since the bulk modulus greatly exceeds the shear modulus in magnitude; therefore, to

model the rubber as an unconstrained material, a hydrostatic work term, , is included in the strain

energy functional which is function of the relative volume, :

(3-271)

The hydrostatic work term is expressed in terms of the bulk modulus, , and , as:

(3-272)

Curve extends into negative strain quadrant since SOL 700 will extrapolate using the two end points. It is important that the extrapolation does not extend into the negative stress region.

Unloading is based on the interpolated Young’s moduli which must provide an unloading tangent that exceeds the loading tangent.

WH J( )

J

W J1 J2 J, ,( ) nkθ 12--- J1 3–( ) 1

20N---------- J1

2 9–( ) 111050N2------------------ J1

3 –(+ +

nkθ 197000N---------------- 3

J14 81–( ) 519

673750N4------------------------ J1

5 243–( )+ WH J( )+ +

=

J1 I1J 1 3⁄–=J2 I2J=

K J

WH J( ) K2---- H 1–( )2=

Page 165: SimXpert R3.2 Explicit Workspace Guide

159MaterialsMaterials

Rate effects are taken into account through linear viscoelasticity by a convolution integral of the form:

(3-273)

or in terms of the second Piola-Kirchhoff stress, , and Green's strain tensor, ,

(3-274)

where and are the relaxation functions for the different stress measures. This

stress is added to the stress tensor determined from the strain energy functional.

If we wish to include only simple rate effects, the relaxation function is represented by six terms from the Prony series:

(3-275)

given by,

(3-276)

This model is effectively a Maxwell fluid which consists of a dampers and springs in series. We

characterize this in the input by shear moduli, , and decay constants, . The viscoelastic behavior is

optional and an arbitrary number of terms may be used.

When viscoelastic terms are not included, this model is similar to the use of the Arruda Boyce model in solution 600, defined in the MATHE option. When viscoelasticity is included, the formulation of these two models are different.

Material Model 158: Rate Sensitive Composite FabricSee material type 58, Laminated Composite Fabric, for the treatment of the composite material. Rate effects are taken into account through a Maxwell model using linear viscoelasticity by a convolution integral of the form:

(3-277)

σij gijkl t τ–( )∂εkl

∂τ--------- τd

0

t

=

Sij ijE

Sij Gijkl t τ–( )∂Ekl

∂τ---------- τd

0

t

=

gijkl t τ–( ) Gijkl t τ–( )

g t( ) α0 αme βt–

m 1=

N

+=

g t( ) Gieβit–

i 1=

N

=

Gi βi

σij gijkl t τ–( )∂εkl

∂τ--------- τd

0

t=

Page 166: SimXpert R3.2 Explicit Workspace Guide

Materials160

where is the relaxation function for different stress measures. This stress is added to the stress

tensor determined from the strain energy functional. Since we wish to include only simple rate effects, the relaxation function is represented by six terms from the Prony series:

We characterize this in the input by the shear moduli, , and the decay constants, . An arbitrary

number of terms, not exceeding 6, may be used when applying the viscoelastic model. The composite failure is not directly affected by the presence of the viscous stress tensor.

Material Model 181: Simplified Rubber FoamMaterial type 181 in SOL 700is a simplified “quasi”-hyperelastic rubber model defined by a single uniaxial load curve or by a family of curves at discrete strain rates. The term “quasi” is used because there is really no strain energy function for determining the stresses used in this model. However, for deriving the tangent stiffness matrix we use the formulas as if a strain energy function were present. In addition, a frequency independent damping stress is added to model the energy dissipation commonly observed in rubbers.

Hyperelasticity Using the Principal Stretch Ratios

A hyperelastic constitutive law is determined by a strain energy function that here is expressed in terms

of the principal stretches; i.e., ) , . To obtain the Cauchy stress , as well as the

constitutive tensor of interest, , they are first calculated in the principal basis after which they are

transformed back to the “base frame”, or standard basis. The complete set of formulas is given by Crisfield [1997] and is for the sake of completeness recapitulated here.

The principal Kirchhoff stress components are given by

(3-278)

that are transformed to the standard basis using the standard formula

(3-279)

The are the components of the orthogonal tensor containing the eigenvectors of the principal basis.

The Cauchy stress is then given by

(3-280)

gijklt τ–

g t( ) Gme βmt–

m 1=

N

=

Gi βi

W W λ1 λ2 λ3,,( )= σij

CijklTC

τijE λi

∂W∂λi--------= no sum( )

τij qikqjlτklE=

qij

σij J 1– τij=

Page 167: SimXpert R3.2 Explicit Workspace Guide

161MaterialsMaterials

where is the relative volume change.

The constitutive tensor that relates the rate of deformation to the Truesdell (convected) rate of Kirchhoff stress can in the principal basis be expressed as

(3-281)

These components are transformed to the standard basis according to

(3-282)

and finally the constitutive tensor relating the rate of deformation to the Truesdell rate of Cauchy stress is obtained through

(3-283)

Stress and Tangent Stiffness

The principal Kirchhoff stress is in material model 181 given by

(3-284)

where is a load curve determined from uniaxial data (possible at different strain rates). Furthermore,

is the bulk modulus and is the relative volume change of the material. This stress cannot be deduced

from a strain energy function unless for some constitutive parameter . A consequence of this is that when using the formulas in the previous section the resulting tangent stiffness matrix is not necessarily symmetric. We remedy this by symmetrizing the formulas according to

J λ1λ2λ3=

CiijjTKE λj

∂iiE

∂λj-------- 2τii

Eδij–=

CijijTKE

λj2τii

E λi2τjj

E–

λ12 λj

2–------------------------------=

CijijTKE

λi

2----

∂τiiE

∂λi---------

∂τiiE

∂λj---------–

=

i j λi λj≠( ) (no sum),≠

i j λi,≠ λj=

CijklTKE qipqjgqkrqlsCpqrs

TKE=

CijklTC J 1– Cijkl

TK=

τiE f λi( ) K J 1–( ) 1

3--- f λk( )

k 1=

3

–+=

f

K J

f λ( ) E λln= E

Page 168: SimXpert R3.2 Explicit Workspace Guide

Materials162

(3-285)

Two Remarks

The function introduced in the previous section depends not only on the stretches but for some choices of input also on the strain rate. Strain rate effects complicate things for an implicit analyst and here one also has to take into account whether the material is in tension/compression or in a loading/unloading stage. We believe that it is of little importance to take into account the strain rate effects when deriving the tangent stiffness matrix and therefore this influence has been disregarded.

For the fully integrated brick element, we have used the approach in material model 77 to account for the constant pressure when deriving the tangent stiffness matrix. Experiments have shown that this is crucial to obtain a decent implicit performance for nearly incompressible materials.

Modeling of the Frequency Independent Damping

An elastic-plastic stress is added to model the frequency independent damping properties of rubber.

This stress is deviatoric and determined by the shear modulus and the yield stress . This part of

the stress is updated incrementally as

(3-286)

where . is the strain increment. The trial stress is then radially scaled (if necessary) to the yield surface according to

where is the effective von Mises stress for the trial stress

The elastic tangent stiffness contribution is given by

(3-287)

and if yield has occurred in the last time step the elastic-plastic tangent is used

λj

∂τiiE

∂λj---------

symn

12--- λj

∂τiiE

∂λj--------- λi

∂τjjE

∂λi---------+

KJ

23---λif' λi( )

16--- λif

· λi( ) λjf' λj( )+( )–

+= =if i j=

otherwise

f

σd

G σY

σdn 1+ σd

n 2GIdevΔε+=

Δε

σdn 1+ σd

n 1+ min 1σY

σeff--------,

=

σeff σdn 1+

Cd 2GIdev=

Page 169: SimXpert R3.2 Explicit Workspace Guide

163MaterialsMaterials

ΔL· )

(3-288)

Here is the deviatoric fourth order identity tensor.

Material Model 196: General Spring Discrete BeamIf TYPE=0, elastic behavior is obtained. In this case, if the linear spring stiffness is used, the force, F, is given by:

(3-289)

but if the load curve ID is specified, the force is then given by:

In these equations, .L is the change in length

If TYPE=1, inelastic behavior is obtained. In this case, the yield force is taken from the load curve:

(3-290)

where is the plastic deflection. A trial force is computed as:

(3-291)

and is checked against the yield force to determine :

(3-292)

The final force, which includes rate effects and damping, is given by:

Cd 2GIdev 3G

σY2

-------σd σd⊗–=

Idev

F F0 KΔL DΔL·+ +=

F F0 Kf ΔL( ) 1 C1 ΔL· C2 ΔL·( )sgn max 1.ΔL·

DLE------------,

ln⋅+⋅+ DΔL· g ΔL( )h(+ + +=

ΔL current length initial length–=

FY Fy ΔLplastic( )=

Lplastic

FT Fn KΔL· Δt+=

F

F FY

FT

= if FT FY>if FT FY≤

Fn 1+ F 1 C1 ΔL· C2 ΔL·( ) max 1.ΔL·

DLE------------,

lnsgn⋅+⋅+ DΔL· g ΔL( )h ΔL·( )+ +⋅=

Page 170: SimXpert R3.2 Explicit Workspace Guide

Materials164

Unless the origin of the curve starts at (0,0), the negative part of the curve is used when the spring force

is negative where the negative of the plastic displacement is used to interpolate, . The positive part of

the curve is used whenever the force is positive.

The cross-sectional area is defined on the section card for the discrete beam elements. See *SECTION_BEAM. The square root of this area is used as the contract thickness offset if these elements are included in the contact treatment.

Fy

Page 171: SimXpert R3.2 Explicit Workspace Guide

157Boundary Conditions

Boundary Conditions

Page 172: SimXpert R3.2 Explicit Workspace Guide

Boundary Conditions158

Boundary ConditionsThe motion of part or all of a model can be prescribed by Boundary and Initial conditions.

Single-Point ConstraintsA single-point constraint is used to prescribe the motion of a translational or rotational degree of freedom. The constraint is effective throughout the analysis and is used to specify boundary conditions or planes of symmetry.

A single-point constraint is defined by an SPCn entry. The SPC entry defines the constraints on one grid point, while the SPC1 defines the constraints to be applied to a set of grid points. Several sets of SPC entries can be defined in the Bulk Data Section, but only those selected in the Case Control Section using the SPC = n command are incorporated in the analysis.

Single-point constraints can also be defined using the GRIDt entry. These constraints are present for the entire analysis and do not need to be selected in Case Control. This is valid only for SPC and SPC1.

Since Sol 700 is an explicit code, there is no matrix decomposition. Therefore, the problems of singular matrices that occur with some implicit codes do not exist. All, or part of the Lagrangian mesh can be entirely unconstrained and can undergo rigid body motion. SOL 700 correctly calculates the motion of the mesh. Similarly, the redundant degrees of freedom, such as the in-plane rotation of shell elements, do not need to be constrained since they do not affect the solution. The only constraints that are needed are those representing the boundary conditions of the model and those necessary for any planes of symmetry.

The following SPC types are supported in MD Nastran SOL 700.

• SPC

• SPC1

• SPCADD

• SPCD (at present, only velocity is available)

• SPCD2

Multi-Point ConstraintsMPCs are special element types which define a rigorous behavior between several specified nodes. The following MPC types which are supported for MD Nastran SOL 700:

• MPC

• RBAR

• RBE2

• RBE2A

• RBE2D

• RBE2F

Page 173: SimXpert R3.2 Explicit Workspace Guide

159Boundary ConditionsBoundary Conditions

• RBE3

• RBE3D

• RBJOINT

• REJSTIFF

• RCONN

Specifying Explicit MPCsMPC’s may be created between a dependent degree of freedom and one or more independent degrees of freedom. The dependent term consists of a node ID and a degree of freedom; an independent term consists of a coefficient, a node ID, and a degree of freedom. An unlimited number of independent terms can be specified, but only one dependent term can be specified. The constant term is not allowed in MD Nastran.

References:“MPC” in the MD Nastran Quick Reference Guide.

Contact in SOL 700The contact methodology and definition as implemented in MD Nastran Explicit Nonlinear are discussed here. The detailed theory anf algorithm behind the imlementation of contact in SOL 700 is discussed in the next chapter: Contact

The simulation of many physical problems requires the ability to model the contact phenomena. This includes impact simulations, drop testing, component crush, crash, and manufacturing processes among others. The analysis of contact behavior is complex because of the requirement to accurately track the motion of multiple geometric bodies, and the motion due to the interaction of these bodies after contact occurs. This includes representing the friction between surfaces if required. The numerical objective is to detect the motion of the bodies, apply a constraint to avoid penetration, and apply appropriate boundary conditions to simulate the frictional behavior and heat transfer. Several procedures have been developed to treat these problems including the use of Perturbed or Augmented Lagrangian methods, penalty methods, and direct constraints. Furthermore, contact simulation has often required the use of special contact or gap elements. MD Nastran Explicit Nonlinear allows contact analysis to be performed automatically without the use of special contact elements. A robust numerical procedure to simulate these complex physical problems has been implemented in MD Nastran Explicit Nonlinear.

Contact problems can be classified as one of the following types of contact.

• Deformable-Deformable contact between two and three-dimensional deformable bodies.

MPC Types Description

MPC Defines a multipoint constraint equation.

Page 174: SimXpert R3.2 Explicit Workspace Guide

Boundary Conditions160

• Rigid - Deformable contact between a deformable body and a rigid body, for two- or three-dimensional cases.

Contact problems involve a variety of different geometric and kinematic situations. Some contact problems involve small relative sliding between the contacting surfaces, while others involve large sliding or penetration followed by perforation and failure. Some contact problems involve contact over large areas, while others involve contact between discrete points. The general Contact Body approach in SOL 600 is also adopted by MD Nastran Explicit Nonlinear (SOL 700) to model contact and can be used to handle most contact problem definitions.

Contact BodiesThere are two types of contact bodies in MD Nastran Explicit Nonlinear – deformable and rigid. Deformable bodies are simply a collection of finite elements as shown below.

Figure 4-1 Deformable Body

This body has three key aspects to it:

1. The elements which make up the body.

2. The nodes on the external surfaces which might contact another body or itself. These nodes are treated as potential contact nodes.

3. The edges (2-D) or faces (3-D) which describe the outer surface which a node on another body (or the same body) might contact. These edges/faces are treated as potential contact segments.

Note that a body can be multiply connected (have holes in itself). It is also possible for a body to have a self contact where the entire surface folds on to itself. A contact may include 1-D elements such as beams and rods, 2-D elements such as shells and membranes, and 3-D elements such as solids.

Each element should be in, at most, one body. The elements in a body are defined using the BCBODY option. It is not necessary to identify the grid points on the exterior surfaces as this is done automatically. The algorithm used is based on the fact that grid points on the boundary are on element edges or faces that belong to only one element. Each node on the exterior surface is treated as a potential slave grid point.

The second type of a contact body is called Rigid bodies. Rigid bodies are composed of (2-D) or (3-D) meshes and their most significant aspect is that they do not distort. Deformable bodies can contact rigid bodies and contact between rigid bodies is also allowed.

Page 175: SimXpert R3.2 Explicit Workspace Guide

161Boundary ConditionsBoundary Conditions

Rigid WallsA rigid wall is a plane through which specified slave grid points cannot penetrate. The rigid wall provides a convenient way of defining rigid targets in impact analyses.

Any number of rigid walls can be specified using WALL entries. The orientation of each wall is defined by the coordinates of a point on the wall and a vector that is perpendicular to the wall and points towards the model.

At each time step, a check is made to determine whether the slave grid points have penetrated the wall. These slave points are defined using a Case Control SET entry, and there can be any number of them. Since a check is made for every slave point at each time step, you should specify only those points as slave points that are expected to contact the wall in order to ensure the most efficient solution.

If a slave point is found to have penetrated the wall, it is moved back towards the wall so that its momentum is conserved. If the slave point subsequently moves away from the wall, it is allowed to do so.

Slave points cannot have any other constraint. They can, however, be part of other contact.

Contact DetectionDuring the incremental procedure, each potential contact node is first checked to see whether it is near a contact segment. The contact segments are either edges of other 2- D deformable bodies, faces of 3-D deformable bodies, or segments from rigid bodies. By default, each node could contact any other segment including segments on the body that it belongs to. This allows a body to contact itself. To simplify the computation, it is possible to use the BCTABLE entry to indicate that a particular body will or will not contact another body. This is often used to indicate that a body will not contact itself. During the iteration process, the motion of the node is checked to see whether it has penetrated a surface by determining whether it has crossed a segment.

For more detailed discussion on the Contact, refer to Chapter 5 of this guide and see Chapter 12 in the SOL 600 User’s Guide.

Page 176: SimXpert R3.2 Explicit Workspace Guide

Lagrangian Loading162

Lagrangian LoadingThis section covers the different ways that the analysis model can be loaded. The facilities available are:

• Concentrated Loads and Moments

• Pressure Loads

• Initial Conditions

Concentrated Loads and Moments

Concentrated loads and moments can be applied to any grid point using the DAREA, FORCE, FORCE2, entries in combination with a TLOADn entry.

The types of concentrated load that can be applied are discussed in the following section.

FORCE, FORCE2, or DAREA – Fixed-Direction Concentrated LoadsThe FORCE, FORCE2, and DAREA entries define fixed direction loads. In other words, the direction of the force is constant throughout the analysis and does not change as the structure moves.

FORCE, FORCE2, and DAREA entries have the same effect but define the loading in different ways. With the DAREA entry, you specify the grid point, the direction in the basic coordinate system in which the load acts, and the scale factor. With the FORCE entry, a concentrated force remains in the same direction for the entire problem. For FORCE2, the direction of the force follows the deformation and you define the grid point and the components of a vector giving the loading direction and the scale factor. In this case, the magnitude of the vector also acts as a scale factor, so the force in direction i is given by

.

On a rigid body, the concentrated load or enforced motion is specified by defining the load at the rigid body center of gravity. To do so, set the TYPE field of the TLOAD1 or TLOAD2 entries to 13 and 12, respectively. The G field in the FORCE entry references the property number of the rigid body.

Pi ANi=

Page 177: SimXpert R3.2 Explicit Workspace Guide

163Boundary ConditionsLagrangian Loading

Pressure Loads

Pressure loads are applied to the faces of solid elements and to shell elements. Pressure loads are defined using the PLOAD or PLOAD4 entry in combination with a TLOADn entry.

TLOAD2 also references a set of PLOAD and/or PLOAD4 entries. Each entry selects the face of the element to be loaded by its grid points and defines the scale factor to be applied to the curve of pressure

versus time. The actual pressure acting on the element is given as follows:

where is the scale factor.

The direction of positive pressure is calculated according to the right-hand rule using the sequence of grid points on the PLOAD entry. For PLOAD4 entries, the pressure is inwards for solid elements and in the direction of the element normal vector for shell elements.

The RFORCE entry defines enforced motion due to a centrifugal acceleration field. This motion affects all structural elements present in the problem. The GRAV defines an enforced motion due to a gravitational acceleration field. This motion affects all Lagrangian elements.

Grid points with enforced motion cannot be:

• Attached to a rigid body.

• A slave point for a rigid wall.

To specify the motion of a rigid body, the enforced motion of the rigid-body center of gravity must be defined. To do so, set the TYPE field of the TLOAD1 and TLOAD2 entries to 12. The G field on the DAREA, FORCE entry references the property number of the rigid body.

Initial Conditions

The initial velocity of grid points can be defined using TIC, TIC3, and TICD entries. This allows the initial state of the model to be set prior to running the analysis. It is important to recognize the difference

pel

pel t( ) Ap t( )=

A

G3

G2

G4

G1

G3

G2

G1

Page 178: SimXpert R3.2 Explicit Workspace Guide

Lagrangian Loading164

between initial velocities and enforced velocities. Enforced velocities specify the motion of grid points throughout the transient analysis. Initial velocities, on the other hand, specify the velocity of grid points at the beginning of the analysis. Thereafter, the velocities are determined by the calculation.

Where TIC and TIC3 set only the initial grid-point velocity, the TICD entry can be used to set the initial value of any valid grid point variable. It can also refer to a local coordinate system by including the CID1 and/or CID2 entry in the list.

Page 179: SimXpert R3.2 Explicit Workspace Guide

165Boundary ConditionsBoundary and Loading Conditions - Theoretical Background

Boundary and Loading Conditions - Theoretical Background

Pressure Boundary Conditions

Consider pressure loadings on boundary in (4-1). To carry out the surface integration indicated by

the integral:

(4-1)

a Gaussian quadrature rule is used. To locate any point of the surface under consideration, a position

vector, , is defined:

(4-2)

where:

(4-3)

and , , and are unit vectors in the , , and directions (see 4-2).

Nodal quantities are interpolated over the four-node linear surface by the functions:

(4-4)

so that the differential surface area may be written in terms of the curvilinear coordinates as:

where is the surface Jacobian defined by:

(4-5)

∂b1

Ntt sd∂b1

γ

r f1 ξ η,( )i1 f2 ξ η,( )i2 f3 ξ η,( )i3+ +=

fi ξ η,( ) φjxij

j 1=

4

=

i1 i2 i3 x1 x2 x3

φi14--- 1 ξξi+( ) 1 ηηi+( )=

ds

ds J dξdη=

J

J∂r∂ξ------ ∂r

∂η------× EG F2–( )1 2⁄= =

Page 180: SimXpert R3.2 Explicit Workspace Guide

Boundary and Loading Conditions - Theoretical Background166

in which:

(4-6)

A unit normal vector to the surface segment is given by:

(4-7)

and the global components of the traction vector can now be written:

(4-8)

where is the applied pressure at the jth node.

Figure 4-2 Parametric Representation of a Surface Segment

E∂r∂ξ------ ∂r

∂ξ------⋅=

F∂r∂ξ------ ∂r

∂η------⋅=

G∂r∂η------ ∂r

∂η------⋅=

n

n J 1– ∂r∂ξ------ ∂r

∂η------×

=

ti ni φjpj

j 1=

4

=

pj

x3

x2

x1

i3

i2

i1

rξ,η1

23

η

Page 181: SimXpert R3.2 Explicit Workspace Guide

167Boundary ConditionsBoundary and Loading Conditions - Theoretical Background

The surface integral for a segment is evaluated as:

(4-9)

One such integral is computed for each surface segment on which a pressure loading acts. Note that the Jacobians cancel when (4-7) and (4-6) are put into (4-9). Equation 4-9 is evaluated with one-point integration analogous to that employed in the volume integrals. The area of an element side is

approximated by where .

Kinematic Boundary ConditionsIn this subsection, the kinematic constraints are briefly reviewed. SOL 700 tracks reaction forces for each type of kinematic constraint and provides this information as output if requested. For the prescribed boundary conditions, the input energy is integrated and included in the external work.

Displacement ConstraintsTranslational and rotational boundary constraints are imposed either globally or locally by setting the constrained acceleration components to zero. If nodal single point constraints are employed, the

constraints are imposed in a local system. The user defines the local system by specifying a vector in

the direction of the local x-axis, , and a local in-plane vector . After normalizing , the local ,

, and axes are given by:

(4-10)

(4-11)

(4-12)

A transformation matrix is constructed to transform the acceleration components to the local system:

(4-13)

Ntt J1–

1

ξd( ) ηd1–

1

4 J J J 0 0,( )=

ul

xl vl ul xl

yl zl

xl

ul

ul---------=

zl

xl vl×xl vl×

-------------------=

yl zl xl×=

q

q

xlt

ylt

zlt

=

Page 182: SimXpert R3.2 Explicit Workspace Guide

Boundary and Loading Conditions - Theoretical Background168

and the nodal translational and rotational acceleration vectors and , for node I are transformed to

the local system:

(4-14)

(4-15)

and the constrained components are zeroed. The modified vectors are then transformed back to the global system:

(4-16)

(4-17)

Prescribed Displacements, Velocities, and AccelerationsPrescribed displacements, velocities, and accelerations are treated in a nearly identical way to displacement constraints. After imposing the zero displacement constraints, the prescribed values are

imposed as velocities at time, . The acceleration versus time curve is integrated or the displacement versus time curve is differentiated to generate the velocity versus time curve. The prescribed nodal components are then set.

Body Force LoadsBody force loads are used in many applications. For example, in structural analysis the base accelerations can be applied in the simulation of earthquake loadings, the gun firing of projectiles, and gravitational loads. The latter is often used with dynamic relaxation to initialize the internal forces before proceeding with the transient response calculation. In aircraft engine design the body forces are generated by the application of an angular velocity of the spinning structure.

For base accelerations and gravity, we can fix the base and apply the loading as part of the body force loads element by element according to (4-18).

(4-18)

where is the base acceleration and is the element (lumped) mass matrix.

aI ω· I

aIlqaI=

ω· Ilqω· I=

aI qtaIl

=

ω· I qtω· Il

=

tn 1 2⁄+

febody ρNtNabase υdvm meabase= =

abase me

Page 183: SimXpert R3.2 Explicit Workspace Guide

169Contact

Contact

Page 184: SimXpert R3.2 Explicit Workspace Guide

Contact170

ContactThis section will summarize those parts of the contact methods applicable to SOL 700, and will describe the theory of the algorithms used.

To activate contact in SOL 700, the Case Control entry BCONTACT must be given. There are three methods available to define contact:

1. All elements in the model in one contact definition, using default settings

Case Control: BCONTACT=ALL

This will result in automatic contact detection between all elements in the model. For SOL 700, it is advisable to use this method.

2. User defined Contact Bodies, using default or non-default settings

Case Control: BCONTACT = n

Bulk Data: BCBODY, BSURF, or BCBOX or BCPROP or BCMATL, and BCTABLE

It is possible to define contact bodies (BCBODY), and specify which contact bodies need to be checked for contact (BCTABLE). This method using BCBODY definitions provides extreme flexibility and is compatible with the Implicit Nonlinear solution (SOL 600).

A contact body is defined by the Bulk Data entry BCBODY, which references a set of elements (BSURF), a set of elements inside a box (BCBOX), or certain property IDs (BCPROP) or with certain material IDs (BCMATL).

Often used definitions related to contact methods are:

Single Surface Contact: This refers to any contact definition where no master is defined.

Master Slave Contact: This refers to any contact definition where a master is defined.

SOL 600 Contact Capabilities not yet supported by SOL 700

• 2-D contact, since SOL 700 only applies to 3-D (DIM on BCBODY)

• A rigid BCBODY defined by patches or geometric entities

- Rigid BCBODY as a symmetry plane- Motion/Load controlled rigid BCBODY

(See note below on rigid body modeling in SOL 700)

(BEHAV=RIGID

(ISTYP(CONTROL

on BCBODY)

on BCBODY)on BCBODY)

• Body smoothing (IDSPL on BCBODY)

• User-defined distance below which a node is considered touching

(ERROR on BCTABLE)

• Separation Force (FNTOL on BCTABLE)

• Interference closure (CINTERF on BCTABLE)

Page 185: SimXpert R3.2 Explicit Workspace Guide

171ContactContact

Notes on Rigid Body Modeling in SOL 700:Currently, only BEHAV = DEFORM is supported in SOL 700 on the BCBODY option. Rigid body modeling is possible, however, by defining a rigid material (MATD020).

• Elements belonging to a MATD020 are properly treated in the contact calculations, and it is allowed to include them in a BCBODY with BEHAV = DEFORM. The contact calculations will operate as if the material is rigid. The penalty based contact forces applied on the nodes are accumulated for the whole rigid body and applied as an external force and moment to the center-of-gravity of the rigid body.

• Rigid body motion is allowed and properly simulated by SOL 700.

• Initial velocities and boundary conditions acting on the nodes will be applied to the rigid body.

• Rigid body must be assigned in “Masters” field in BCTABLE.

With these capabilities, a faceted rigid body, similar to a BCBODY with BEHAV=RIGID can be easily modeled. The BEHAV=RIGID logic will be implemented in the next release of SOL 700.

SOL 600 Contact Limitations that do not apply to SOL 700To allow switching between SOL 700 and SOL 600, it is advisable to work within these limits.

In SOL 600, each node and element should be in at most one contact body. When using the penalty method of SOL700 (the default), this limitation does not apply. Forces as calculated by each contact are simply accumulated and applied as an external force vector.

In SOL 600, only 1000 contact bodies are allowed. This limit does not apply to SOL 700.

In SOL 600, it is important to properly define the order in which contact bodies are defined for deformable-to-deformable contact. The order of contact body definition has no influence on the results in SOL 700.

• Glue options (IGLUE & JGLUE

on BCTABLE)

• Contact heat transfer (HEATC on BCTABLE)

• Searching order (ISEARCH on BCTABLE)

• Initial node movement for stress-free contact (SOL 700 contact offers similar capability by means of the IGNORE option on the BCTABLE)

(ICOORD on BCTABLE)

• Option to identify relevant nodes (BCHANGE entry)

• Initial approach, release, motion until contact (BCMOVE entry)

Page 186: SimXpert R3.2 Explicit Workspace Guide

Penalty Methods172

Penalty MethodsThe treatment of sliding and impact along interfaces is an important capability in SOL 700.

Internally, the interfaces are defined in three dimensions by listing in arbitrary order all triangular and quadrilateral segments that comprise each side of the interface. One side of the interface is designated as the slave side, and the other is designated as the master side. Nodes lying in those surfaces are referred to as slave and master nodes, respectively. When slave nodes penetrate the master, normal interface springs are placed between the penetrated nodes and the master surface. See Slave Search in this chapter for details on the contact force calculations.

Figure 5-1 Reference and Deformed Configuration

∂b2

∂B1

∂b1

∂B2

B01

B02

b1 b

2

Page 187: SimXpert R3.2 Explicit Workspace Guide

173ContactPreliminaries

PreliminariesConsider the time-dependent motion of two bodies occupying regions and in their undeformed configuration at time zero. Assume that the intersection

(5-1)

is satisfied. Let and denote the boundaries of and , respectively. At some later time,

these bodies occupy regions and bounded by and as shown in Figure 5-1. Because the deformed configurations cannot penetrate,

(5-2)

As long as , the equations of motion remain uncoupled. In the foregoing and

following equations, the right superscript denotes the body to which the quantity refers.

Before a detailed description of the theory is given, some additional statements should be made

concerning the terminology. The surfaces and of the discretized bodies and become the master and slave surfaces respectively. Choice of the master and slave surfaces is arbitrary when the symmetric penalty treatment is employed. Otherwise, the more coarsely meshed surface should be

chosen as the master surface, nodal points that define are called master nodes and nodes that define

are called slave nodes. When , the constraints are imposed to prevent

penetration. Right superscripts are implied whenever a variable refers to either the master surface ,

or slave surface, ; consequently, these superscripts are dropped in the development which follows.

B1 B2

B1 B2∩ φ=

∂B1 ∂B2 B1

B2

b1 b2 ∂b1 ∂b2

b1 ∂b1–( ) b2∩ φ=

∂b1 ∂b2∩ φ=

α 1 2,=( )

∂b1 ∂b2 b1 b2

∂b1

∂b2 ∂b1 ∂b2∩( ) φ≠

∂b1

∂b2

Page 188: SimXpert R3.2 Explicit Workspace Guide

Slave Search174

Slave SearchThe slave search is common to all interface algorithms implemented in SOL 700. This search finds for each slave node its nearest point on the master surface. Lines drawn from a slave node to its nearest point will be perpendicular to the master surface, unless the point lies along the intersection of two master segments, where a segment is defined to be a 3- or 4-node element of a surface.

Consider a slave node, , sliding on a piecewise smooth master surface and assume that a search of the

master surface has located the master node, , lying nearest to . Figure 5-2 depicts a portion of a

master surface with nodes and labeled. If and do not coincide, can usually be shown

to lie in a segment via the following tests:

(5-3)

where vector and are along edges of and point outward from . Vector s is the projection

of the vector beginning at , ending at , and denoted by , onto the plane being examined (see

Figure 5-3).

(5-4)

ns

ms ns

ms ns ms ns ns

ss

ci s×( ) ci ci 1+×( ) 0>⋅ci s×( ) s ci 1+×( ) 0>⋅

ci ci 1+ s1 ms

ms ns g

s g g m⋅( )m–=

Page 189: SimXpert R3.2 Explicit Workspace Guide

175ContactSlave Search

Figure 5-2 Four Master Segments can Harbor Slave Node given that is the Nearest Master Node

Figure 5-3 Projection of onto master segment

where for segment

(5-5)

Since the sliding constraints keep close but not necessarily on the master surface and since may

lie near or even on the intersection of two master segments, the inequalities of Equation (5-3) may be inconclusive; i.e., they may fail to be satisfied or more than one may give positive results. When this

occurs is assumed to lie along the intersection which yields the maximum value for the quantity

(5-6)

When the contact surface is made up of badly shaped elements, the segment apparently identified as containing the slave node actually may not, as shown in Figure 5-4.

Assume that a master segment has been located for slave node and that is not identified as lying

on the intersection of two master segments. Then the identification of the contact point, defined as the

point on the master segment which is nearest to , becomes nontrivial. Each master surface segment

, is given the parametric representation:

(5-7)

ns ms

g s1

s1

mci ci 1+×ci ci 1+×------------------------=

ns ns

ns

g ci⋅ci

----------- i 1 2 3 4 …, , , ,=

ns ns

ns

s1

r f1 ξ η,( )i1 f2 ξ η,( )i2 f3 ξ η,( )i3+ +=

Page 190: SimXpert R3.2 Explicit Workspace Guide

Slave Search176

where

(5-8)

When the nearest node fails to contain the segment that harbors the slave node, segments numbered 1-8 are searched in the order shown in Figure 5-4.

Figure 5-4 Search Order for Segments

Note that is at least once continuously differentiable and that

(5-9)

Thus, represents a master segment that has a unique normal whose direction depends continuously on

the points of .

Let be a position vector drawn to slave node and assume that the master surface segment has

been identified with . The contact point coordinates on must satisfy

(5-10)

(5-11)

The physical problem is illustrated in Figure 5-5, which shows lying above the master surface.

Equations (5-10) and (5-11) are readily solved for and . One way to accomplish this is to solve

fi ξ η,( ) φjxij

j 1=

4

12

3

4

5

6 7

8

r1

∂r∂ξ------ ∂r

∂η------× 0≠

rs1

t ns s1

sn ξc ηc,( ) s1

∂r∂ξ------ ξc ηc,( ) t r ξc ηc,( )–[ ]⋅ 0=

∂r∂η------ ξc ηc,( ) t r ξc ηc,( )–[ ]⋅ 0=

ns

ξc ηc

Page 191: SimXpert R3.2 Explicit Workspace Guide

177ContactSlave Search

Equation (5-10) for in terms of , and substitute the results into (5-11). This yields a cubic equation

in .

Figure 5-5 Location of Contact Point when lies above Master Segment

The equations are solved numerically. When two nodes of a bilinear quadrilateral are collapsed into a single node for a triangle, the Jacobian of the minimization problem is singular at the collapsed node. Fortunately, there is an analytical solution for triangular segments since three points define a plane. Newton-Raphson iteration is a natural choice for solving these simple nonlinear equations. The method diverges with distorted elements unless the initial guess is accurate. An expanded search procedure as discussed in Improvements to the Contact Searching section is used.

Three iterations with a least-squares projection are used to generate an initial guess:

(5-12)

followed by the Newton-Raphson iterations which are limited to ten iterations, but which usually converges in four or less.

ξc ηc

ηc

x3

x2

x1

t

r1

23

4

ns

η

ξ

∂r∂η------

∂r∂ξ------

ns

ξ0 0 η0, 0,= =

r,ξ

r,η

r,ξr,η[ ] ΔξΔη

r,ξ

r,η

r ξi,ηi( ) t–{ },=

ξi 1+ ξi 1+ Δξ, ηi 1++ ηi Δη+= =

Page 192: SimXpert R3.2 Explicit Workspace Guide

Slave Search178

(5-13)

In concave regions, a slave node may have isoparametric coordinates that lie outside of the range for all of the master segments, yet still have penetrated the surface. A simple strategy is used for handling this case, but it can fail. The contact segment for each node is saved every time step.

If the slave node contact point defined in terms of the isoparametric coordinates of the segment, is just outside of the segment, and the node penetrated the isoparametric surface, and no other segment associated with the nearest neighbor satisfies the inequality test, then the contact point is assumed to occur on the edge of the segment.

In effect, the definition of the master segments is extended so that they overlap by a small amount. In the hydrocode literature, this approach is similar to the slide line extensions used in two dimensions. This simple procedure works well for most cases, but it can fail in situations involving sharp concave corners.

H[ ]ΔξΔη

r ξ,

r η,

r ξi ηi,( ) –{–=

H[ ]r χ,

r η,

r ξ, r η,[ ]0 r r,⋅

r r ξη,⋅ 0+

ξi 1+ ξi Δξ+=ηi 1+ ηi Δη+=

1 +1,–[ ]

Page 193: SimXpert R3.2 Explicit Workspace Guide

179ContactContact Force Calculation

Contact Force CalculationEach slave node is checked for penetration through the master surface. If the slave node does not penetrate, nothing is done. If it does penetrate, an interface force is applied between the slave node and its contact point. The magnitude of this force is proportional to the amount of penetration. This may be thought of as the addition of an interface spring.

Penetration of the slave node through the master segment which contains its contact point is indicated

if

(5-14)

where

(5-15)

is normal to the master segment at the contact point. The amount of penetration is equal to the value of l.

If slave node has penetrated through master segment , we add an interface force vector :

if l < (5-16)

to the degrees of freedom corresponding to and

if (5-17)

to the four nodes that comprise master segment . By default, SOFT=1 on the

BCTABLE entry, and the stiffness factor is given in terms of the nodal masses and the global timestep,

as

(5-18)

With SOFT=1, it is mostly not needed to scale the contact stiffness, even if materials with very different stiffness properties come into contact.

When SOFT=0 on the BCTABLE entry, the stiffness factor for master segment is given in terms of

the bulk modulus , the volume , and the face area of the element that contains as

(5-19)

for brick elements and

ns

l ni t r ξc ηc,( )–[ ] 0<( )=

ni ni ξc ηc,( )=

ns si fs

fs lki– ni= l 0<

ns

fmi φ2 ξc ηc,( )fs= l 0<

i 1 2 3 4, , ,=( ) si

ki

dt

ki fsi

mslavemmaster

mslave mmaster+--------------------------------------- 1

dt2

-------⋅ ⋅=

ki si

Ki Vi Ai si

ki

fsiKiAi2

Vi-----------------=

Page 194: SimXpert R3.2 Explicit Workspace Guide

Contact Force Calculation180

(5-20)

for shell elements. When too much penetration is observed, the contact stiffness can be increased by the

interface stiffness scale factor, . This scale factor is 0.1 by default, and can be defined by FACT on the

BCTABLE entry. Larger values may cause instabilities unless the time step size is scaled back in the time step calculation.

ki

fsiKiAi

max shell diagonal( )-------------------------------------------------=

fsi

Page 195: SimXpert R3.2 Explicit Workspace Guide

181ContactImprovements to the Contact Searching

Improvements to the Contact SearchingA number of recent changes have been made in the surface-to-surface contact including contact searching, accounting for thickness, and contact damping.

Sometimes problems with the closest master node contact searching were found. The nearest node algorithm described above can break down since the nearest node is not always anywhere near the segment that harbors the slave node as is assumed in Figure 5-4 (see Figure 5-6). Such distorted elements are commonly used in rigid bodies in order to define the geometry accurately.

Figure 5-6 Failure to find the Contact Segment can be caused by Poor Aspect Ratios in the Finite Element Mesh

To circumvent the problem caused by bad aspect ratios, an expanded searching procedure is used in which we attempt to locate the nearest segment rather than the nearest nodal point.

Figure 5-7 Expanded Search

Nodes 2 and 4 share segments with node 3. Therefore, the two nearest nodes are 1 and 5. The nearest contact segment is not considered since its nodes are not members of the nearest node set.

The nearest contact segment to a given node, , is defined to be the first segment encountered when

moving in a direction normal to the surface away from . A major deficiency with the nearest node search is depicted in Figure 5-7 where the nearest nodes are not even members of the nearest contact

slave node

closest nodal point

1 2 3 4 5

Normal vectorat node 3

kk

Page 196: SimXpert R3.2 Explicit Workspace Guide

Improvements to the Contact Searching182

segment. Obviously, this would not be a problem for a more uniform mesh. To overcome this problem we have adopted segment based searching in both surface to surface and single surface contact.

Page 197: SimXpert R3.2 Explicit Workspace Guide

183ContactBucket Sorting

Bucket SortingBucket sorting is now used extensively in the SOL 700 contact algorithms.

The reasons for eliminating slave node tracking by incremental searching is illustrated in Figure 5-8 where surfaces are shown which cause the incremental searches to fail. With bucket sorting incremental searches may still be used but for reliability they are used after contact is achieved. As contact is lost, the bucket sorting for the affected nodal points must resume.

In a direct search of a set of nodes to determine the nearest node, the number of distance comparisons

required is . Since this comparison needs to be made for each node, the total number of

comparisons is , with each of these comparisons requiring a distance calculation

(5-21)

that uses eight mathematical operations. The cumulative effect of these mathematical operations for

compares can dominate the solution cost at less than 100 elements.

The idea behind a bucket sort is to perform some grouping of the nodes so that the sort operation need only calculate the distance of the nodes in the nearest groups. With this partitioning the nearest node will either reside in the same bucket or in one of the two adjoining buckets. The number of distance calculations is now given by

(5-22)

where is the number of buckets. The total number of distance comparisons for the entire one-dimensional surface is

(5-23)

Thus, if the number of buckets is greater than 3, then the bucket sort will require fewer distance comparisons than a direct sort. It is easy to show that the corresponding number of distance comparisons for two-dimensional and three-dimensional bucket sorts are given by

for 2-D (5-24)

for 3-D (5-25)

where and are the number of partitions along the additional dimension.

N

N 1–N N 1–( )

12 xi xj–( )2 yi yj–( )2 zi zj–( )2+ +=

N N 1–( )

3Nα

------- 1–

α

N3Nα

------- 1–

N9Nαb------- 1–

N27Nαbc---------- 1–

b c

Page 198: SimXpert R3.2 Explicit Workspace Guide

Bucket Sorting184

Incremental searching may fail on surfaces that are not simply connected. The contact algorithm in SOL 700 avoids incremental searching for nodal points that are not in contact and all these cases are considered (see Figure 5-8).

Figure 5-8 Examples of Models where Incremental Searching may Fail

The cost of the grouping operations, needed to form the buckets, is nearly linear with the number of nodes

. For typical SOL 700 applications, the bucket sort is 100 to 1000 times faster than the corresponding direct sort. However, the sort is still an expensive part of the contact algorithm, so that, to further minimize this cost, the sort is performed every ten or fifteen cycles and the nearest three nodes are stored. This can be specified by BSORT on the BCTABLE entry. Typically, three to five percent of the calculational costs will be absorbed in the bucket sorting when most surface segments are included in the contact definition.

tied interfacenot yet supported

N

Page 199: SimXpert R3.2 Explicit Workspace Guide

185ContactBucket Sorting in Single Surface Contact

Bucket Sorting in Single Surface ContactWe set the number of buckets in the x, y, and z coordinate directions to NX, NY, and NZ, respectively.

The product of the number of buckets in each direction always approaches NSN or 5000 whichever is smaller,

(5-26)

where the coordinate pairs , , and span the entire contact

surface. In this procedure, we loop over the segments rather than the nodal points. For each segment we

use a nested DO LOOP to loop through a subset of buckets from to , to

, and to where:

(5-27)

and , , are the bucket pointers for the kth node. Figure 5-9 shows a segment passing through a volume that has been partitioned into buckets. The orthogonal distance of each slave node contained in the box from the segment is determined. The box is subdivided into sixty buckets.

Figure 5-9 The Orthogonal Distance of each Slave Node

NX NY NZ MIN NSN 5000,( )≤⋅⋅

xmin xmax,( ) ymin ymax,( ) zmin zmax,( )

IMIN IMAX JMIN

JMAX KMIN KMAX

IMIN MIN PXI PX2 PX3 PX4,,,( )=IMAX MAX PX1 PX2 PX3 PX4,,,( )=JMIN MAX PY1 PY2 PY3 PY4,,,( )=JMAX MAX PY1 PY2 PY3 PY4,,,( )=KMIN MAX PZ1 PZ2 PZ3 PZ4,,,( )=kMAX MAX PZ1 PZ2 PZ3 PZ4,,,( )=

PXk PYk PZk

z

x

y

Nodes in buckets shown are checkedfor contact with the segment

Page 200: SimXpert R3.2 Explicit Workspace Guide

Bucket Sorting in Single Surface Contact186

We check the orthogonal distance of all nodes in the bucket subset from the segment. As each segment is processed, the minimum distance to a segment is determined for every node in the surface and the two nearest segments are stored. Therefore the required storage allocation is still deterministic. This would not be the case if we stored for each segment a list of nodes that could possibly contact the segment.

We have now determined for each node, , in the contact surface the two nearest segments for contact. Having located these segments we permanently store the node on these segments which is nearest to node

. When checking for interpenetrating nodes we check the segments surrounding the node including the nearest segment since during the steps between bucket searches it is likely that the nearest segment may change. It is possible to bypass nodes that are already in contact and save some computer time; however, if multiple contacts per node are admissible then bypassing the search may lead to unacceptable errors.

k

k

Page 201: SimXpert R3.2 Explicit Workspace Guide

187ContactAccounting For the Shell Thickness

Accounting For the Shell ThicknessShell thickness effects are important when shell elements are used to model sheet metal. Unless thickness is considered in the contact, the effect of thinning on frictional interface stresses due to membrane stretching will be difficult to treat. In the treatment of thickness we project both the slave and master surfaces based on the mid-surface normal projection vectors as shown in Figure 5-10. The surfaces, therefore, must be offset by an amount equal to 1/2 their total thickness (Figure 5-11). This allows the program to check the node numbering of the segments automatically to ensure that the shells are properly oriented.

Figure 5-10 Contact Surface Based Upon Midsurface Normal Projection Vectors

Figure 5-11 The Slave and Master Surfacess

Thickness changes in the contact are accounted for “if and only if” the shell thickness change option is flagged on the PARAM* DYCONTHKCHG. Each cycle, as the shell elements are processed, the nodal thicknesses are stored for use in the contact algorithms. The interface stiffness may change with thickness depending on the input options used.

To account for the nodal thickness, the maximum shell thickness of any shell connected to the node is taken as the nodal thickness and is updated every cycle. The projection of the node is done normal to the contact surface:

Length of projection vector is 1/2 the shell thickness

Projected Contact Surface

Page 202: SimXpert R3.2 Explicit Workspace Guide

Initial Contact Penetrations188

Initial Contact PenetrationsThe need to offset contact surfaces to account for the thickness of the shell elements contributes to initial contact penetrations. These penetrations can lead to severe numerical problems when execution begins so they should be corrected if SOL 700 is to run successfully. Often an early growth of negative contact energy is one sign that initial penetrations exist. Currently, warning messages are printed to the D3HSP file to report penetrations of nodes through contact segments and the modifications to the geometry made by SOL 700 to eliminate the penetrations. Sometimes such corrections simply move the problem elsewhere since it is very possible that the physical location of the shell mid-surface and possibly the shell thickness are incorrect. In the single surface contact algorithms any nodes still penetrating on the second time step are removed from the contact with a warning message.

In some geometry's, penetrations cannot be detected since the contact node penetrates completely through the surface at the beginning of the calculation. Such penetrations are frequently due to the use of coarse meshes. This is illustrated in Figure 5-12. Another case contributing to initial penetrations occurs when the edge of a shell element is on the surface of a solid material as seen in Figure 5-13. Currently, shell edges are rounded with a radius equal to one-half the shell thickness.

Figure 5-12 Undetected Penetration

Figure 5-13 Undetected Penetration due to rounding the Edge of the Shell Element

To avoid problems with initial penetrations, the following recommendations should be considered:

• Adequately offset adjacent surfaces to account for part thickness during the mesh generation phase.

• Use consistently refined meshes on adjacent parts which have significant curvatures.

• Be very careful when defining thickness on shell and beam section definitions - especially for rigid bodies.

Detected Penetration Undetected Penetration

shell

brick

Inner penetration ifedge is too close

Page 203: SimXpert R3.2 Explicit Workspace Guide

189ContactInitial Contact Penetrations

• Scale back part thickness if necessary. Scaling a 1.5mm thickness to .75mm should not cause problems but scaling to .075mm might. Alternatively, define a smaller contact thickness by part ID. Warning: if the part is too thin contact failure will probably occur

• Use spot welds instead of merged nodes to allow the shell mid surfaces to be offset.

Page 204: SimXpert R3.2 Explicit Workspace Guide

Contact Energy Calculation190

Contact Energy CalculationContact energy, , is incrementally updated from time to time for each contact

interface as:

Where is the number of slave nodes, is the number of master nodes, is the

interface force between the ith slave node and the contact segment is the interface force

between the ith master node and the contact segment, is the incremental distance the ith

slave node has moved during the current time step, and is the incremental distance the ith

master node has moved during the current time step. In the absence of friction the slave and master side

energies should be close in magnitude but opposite in sign. The sum, , should equal the stored

energy. Large negative contact energy is usually caused by undetected penetrations. Contact energies are reported in the GLSTAT file. In the presence of friction and damping discussed below the interface energy can take on a substantial positive value especially if there is, in the case of friction, substantial sliding.

Econtact n n 1+

Econtactn 1+ Econtact

n ΔFislave Δdisti

slave ΔFimaster Δdisti

master×i 1=

nmn

+×i 1=

nsn

n

12---+

+=

nsn nmn ΔFislave

ΔFimaster

Δdistislave

Δdistimaster

Econtact

Page 205: SimXpert R3.2 Explicit Workspace Guide

191ContactFriction

FrictionFriction in SOL 700 is based on a Coulomb formulation. Let be the trial force, the normal force,

k the interface stiffness, the coefficient of friction, and the frictional force at time n. The frictional algorithm, outlined below, uses the equivalent of an elastic plastic spring. The steps are as follows:

1. Compute the yield force, :

(5-28)

2. Compute the incremental movement of the slave node

(5-29)

3. Update the interface force to a trial value:

(5-30)

4. Check the yield condition:

if (5-31)

5. Scale the trial force if it is too large:

if (5-32)

An exponential interpolation function smooths the transition between the static, , and dynamic, ,

coefficients of friction where is the relative velocity between the slave node and the master segment:

(5-33)

where

(5-34)

is the time step size, and is a decay constant.

Typical values of friction, see Table 5-1, can be found in Marks Engineering Handbook.

Table 5-1 Typical Values of Coulomb Friction [Marks]

MATERIALS STATIC SLIDING

Hard steel on hard steel 0.78 (dry) .08 (greasy), .42 (dry)

Mild steel on mild steel 0.74 (dry) .10 (greasy), .57 (dry)

f * fn

μ f n

Fy

Fy μ fn=

Δe rn 1+ ξcn 1+ ηc

n 1+,( ) rn 1+ ξcn ηc

n,( )–=

f∗ fn kΔe–=

fn 1+ f∗= f∗ Fy≤

fn 1+Fyf∗

f∗----------= f∗ Fy>

μs μd

ν

μ μd μs μd–( )e c ν–+=

ν ΔeΔT--------------=

Δt C

Page 206: SimXpert R3.2 Explicit Workspace Guide

Friction192

Aluminum on mild steel 0.61 (dry) .47 (dry)

Aluminum on aluminum 1.05 (dry) 1.4 (dry)

Tires on pavement (40psi) 0.90 (dry) .69(wet), .85(dry)

Table 5-1 Typical Values of Coulomb Friction [Marks]

MATERIALS STATIC SLIDING

Page 207: SimXpert R3.2 Explicit Workspace Guide

193Airbag and Occupant Safety

Airbag and Occupant Safety

Page 208: SimXpert R3.2 Explicit Workspace Guide

Airbag and Occupant Safety194

Airbag and Occupant SafetyThe MD Nastran r2 release, SOL 700 includes a Fluid Structure Interaction (FSI) capability that is based on the advanced Finite Volume (Eulerian) and General Coupling Technology available in MSC.Dytran. The FSI capability in the MD Nastran r2 release, however, is only limited to airbag and occupant safety simulation.

The objective of fluid-structure interaction using the coupling algorithm is to enable the material modeled in Eulerian and Lagrangian meshes to interact. Initially, the two solvers are entirely separate. Lagrangian elements that lie within an Eulerian mesh do not affect the flow of the Eulerian material and no forces are transferred from the Eulerian material back to the Lagrangian structure. The coupling algorithm computes the interaction between the two sets of elements. It thus enables complex fluid-structure interaction problems to be analyzed.

The first task in coupling the Eulerian and Lagrangian sections of a model is to create a surface on the Lagrangian structure. This surface is used to transfer the forces between the two solver domains. The surface acts as a boundary to the flow of material in the Eulerian mesh. At the same time, the stresses in the Eulerian elements cause forces to act on the coupling surface, distorting the Lagrangian elements.

The method used for airbag simulation is full gas dynamics and is based on General Coupling with adaptive Euler. SOL 700 computes the fluid flow and Coupling based on MSC.Dytran solver while the Contact and Fabric models are co-simulated by LS-DYNA. Unlike other techniques such as the ALE (Arbitrary Lagrange Euler) where the Eulerian mesh is fixed in space or GBAG method where the gas flow is modeled by applying a pre-determined pressure profile to inflate the bag, in the General Coupling technique, the Eulerian mesh will “adapt” itself to the Lagrangian fabric model as the airbag is inflated. In other words, when the airbag is initially at the folded stage, there is a small Eulerian domain encapsulating the Lagrangian mesh. When the airbag is inflated, the Eulerian mesh expands as the gas jet flows through the airbag compartments and adapts itself to follow the airbag fabric. This technique is unique in MD Nastran r2 and is considered the most accurate method to predict the complex airbag behavior such as Out-of-Position (OOP) simulation, as required by FMVSS 208, where the occupant is already leaning forward when the airbag is inflated. In addition, CFD deployment of multi-compartmented airbags can easily be modeled with this technique by using multiple, fully automatic, adaptive Euler domains. The following capabilities are available:

• Analyze multiple compartments with the CFD approach.

• Simulate flow from one CFD domain into another CFD domain.

• The individual CFD domains are dynamic and adaptive. The user does not need to mesh the CFD domains, nor does he have to worry about the size, since the CFD domains will automatically follow the deploying airbag compartments.

• Flow through both small and large holes is accurately calculated.

Page 209: SimXpert R3.2 Explicit Workspace Guide

195Airbag and Occupant SafetyAirbag and Occupant Safety

• Inflator models

Figure 6-1 Multi-compartment Side Curtain Airbag

(a) Shape of Side Curtain airbag at Start of Simulation

(b) Euler Meshes for all Six Regions

(c) Shape of Bag after 20 milliseconds

Page 210: SimXpert R3.2 Explicit Workspace Guide

Airbag Definition196

Airbag DefinitionThe airbags are defined by using the AIRBAG entry in SOL 700. Airbags can be automatically inflated by defining a gas flow rate in Eulerian domain using full gas dynamics method. A second method, the conventional uniform pressure method, is also available but it is not as accurate as the full gas dynamics.

All related airbag input definitions such as inflator and porosity models, environmental parameters, are grouped in enties that can be directly input in the AIRBAG entry. Every entity has certain parameters associated with it that has to be input immediately following the name of the entity. The order of which entity is entered first in the AIRBAG card is immaterial as long as the associated parameters are defined right after the name of the entity. The following entity groups are available:

“CFD” Entries for this entity describe the properties of the Eulerian domain. Only one "CFD" section can be defined. If this section is not defined, the uniform pressure method is used.

“ENVIRONM” Entries for this entity describe the properties of the environmental conditions for the airbag. Only one “ENVIRONM” section can be defined. If not defined, the values for “INITIAL” will be used.

“INITIAL” Entries for this entity describe the properties of the environmental conditions for the airbag. Only one “INITIAL” section can be defined and is required.

“INFLATOR” Entries for this entity describe the properties of an inflator that is attached to the airbag. More than one inflator may be defined.

“CGINFLTR” Entries for this entity describe the properties of a cold gas inflator that is attached to the airbag. More than one inflator may be defined.

“SMALHOLE” Entries for this entity describe the properties of a small hole in the airbag. More than one SMALHOLE may be defined. A small hole should be used when the size of the hole is of the same order as the size of the elements of the Euler mesh.

“LARGHOLE” Entries for this entity describe the properties of a large hole in the airbag. More than one LARGHOLE may be defined. A large hole should be used when the size of the hole is of the larger than the size of the elements of the Euler mesh.

“PERMEAB” Entries for this entity describe the properties of the permeability of the airbag fabric. More than one PERMEAB may be defined.

“CONVECT” Entries for this entity describe the properties of the loss of energy of the gas in the airbag by means of convection through the airbag surface. More than one CONVECT may be defined.

Page 211: SimXpert R3.2 Explicit Workspace Guide

197Airbag and Occupant SafetyAirbag Definition

There are other entries in SOL 700 to define airbag properties. These are:

Please see MD Nastran r2 QRG for more details.

Inflator Models in Airbags

There are several methods available to define an inflator in airbag analyses. The most general inflator

definitions are:

Figure 6-2 Airbag and Occupant Safety using SOL 700

“RADIATE” Entries for this entity describe the properties of the loss of energy of the gas in the airbag by means of radiation through the airbag surface. More than one RADIATE may be defined. When this option is used, the Stephan-Boltzmann constant must be defined by PARAM, SBOLTZ.

“GAS” Entries for this entity describe the properties of gases. More than 1 GAS may be defined and the gases defined in one AIRBAG entry can be referenced by other AIRBAG entries.

PARAM, UGASC defines a value for the universal gas constant.

PARAM, SBOLTZ defines a value for the Stephan-Boltzmann constant

PARAM, DYDEFAUL controls the default setting of the simulation

INFLFRC defines the hybrid inflator gas fraction

EOSGAM Gamma Law Gas Equation of State

GRIA grid point in airbag reference geometry

INFLATR1 Standard inflator defined by mass flow rate and static temperature of a single inflowing gas.

INFLHYB1 Hybrid inflator defined by mass flow rate and static temperature of multiple inflowing gasses.

Page 212: SimXpert R3.2 Explicit Workspace Guide

Airbag Definition198

For both the uniform pressure model and the full gas dynamics (CFD) method, the inflator location and area are defined by means of a subsurface created by a BSURF, BCPROP, BCMATL, or BCSEG parameters. These parameters are referenced by BFID field on the INFLATOR entity. It can only reference shell elements that belong to the airbag surface, as defined by BFID. The characteristics of the inflator are specified on an INFLATOR entity on AIRBAG card. This entry references tables for the mass flow rate and the temperature of the inflowing gas.

A model can be defined containing both (CFD) and uniform pressure model for the airbag. These two options can be defined with identical inflator characteristics. When the CFD entity and its associated parameters are omitted from the AIRBAG card, the uniform pressure method will be used. In case the CFD entity is present, the airbag will use the Euler method from the start of the simulation. In case the value of SWITCH is nonzero, the airbag will switch from an Eulerian representation to a Uniform Pressure formulation.

Constant Volume Tank TestsConstant volume tank tests are used to characterize inflators. The inflator is ignited within the tank and, as the propellant burns, gas is generated. The inflator temperature is assumed to be constant. From experimental measurements of the time history of the tank pressure it is straightforward to derive the

mass flow rate, .

From energy conservation, where and are defined to be the temperature of the inflator and tank,

respectively, we obtain:

For a perfect gas under constant volume, , hence,

and, finally, we obtain the desired mass flow rate:

Porosity in AirbagsPorosity is defined as the flow of gas through the airbag surface. There are two ways to model this:

1. Holes: The airbag surface contains a discrete hole.2. Permeability: The airbag surface is made from material that is not completely sealed.

Ti Tt

cpm· Ti cvm· Tt cvm· T· t+=

V· 0=

p· V m· RTt mRT· t+=

m·cvp· V

cpRTt--------------=

Page 213: SimXpert R3.2 Explicit Workspace Guide

199Airbag and Occupant SafetyAirbag Definition

The same porosity models are available for both the uniform pressure airbag model as the Eulerian coupled (CFD) airbag model. The porous flow can be either to and from the environment or into and from another uniform pressure model.

Holes

Flow through holes as defined on the SMALHOLE entries is based on the theory of one-dimensional gas flow through a small orifice. LARGHOLE entries define flow through a hole with the velocity method.

The velocity method can only be active for Eulerian airbags. When the SMALHOLE is used on the AIRBAG card, the theory of one-dimensional gas flow through a small orifice is applied.

Velocity Method

The transport of mass through the porous area is based on the velocity of the gas in the Eulerian elements,relative to the moving of coupling surface (airbag fabric).

The volume of the Eulerian materian transported through the faces of the coupling surface that intersect an Eulerian element is equal to

where

The transport mass through the porous area is equal to the density of the gas times the transported volume.

= transported volume during one time step ( for the outflow; for the inflow).

= time step.

= porosity coefficient.

= velocity vector of the gas in the Eulerian mesh

= area of the face of the coupling surface that intersects the Eulerian element is equal to the area of the face that lies inside the Eulerian element.

SXint

v

Face of the couplingsurface that intersectsthe Eulerian element

Coupling Surface

Eulerian Element

Vtrans d– t α v A⋅( )⋅ ⋅=

Vtrans Vtrans 0> Vtrans 0<

dt

αv

A A

Page 214: SimXpert R3.2 Explicit Workspace Guide

Airbag Definition200

Pressure Method

The transport of mass through the porous area is based on the pressure difference between the gas in the Eulerian element and the outside pressure. The outside pressure is the pressure as specified on the ENVIRONM section in the AIRBAG entry.

The volume of the Eulerian material transported through the faces of the coupling surface that intersect an Eulerian element is equal to:

where

The pressure at the face is approximated by the one-dimensional isentropic expansion of the gas to the critical pressure or the environmental pressure ascending to

= transported volume during one ture step ( for outflow; for inflow).

= time step.

= porosite coefficient.

= velocity vector of the gas in the Eulerian mesh.

= area of the face of the coupling surface that intersects the Eularian element is equal to the area of the face that lies inside the Eulerian element.

= = pressure of the gas in the Eulerian element.

= density of the gas in the Eulerian element.

= adiabatic exponent = .

= pressure of the face.

SXint

v

Face of the couplingsurface that intersectsthe Eulerian element

Coupling Surface

Eulerian Element

Vtrans dt α A A⋅( ) 2pργγ 1–------------

pexh

p---------

2 γ/ pexh

p---------

γ 1+γ

-----------–⋅ ⋅ ⋅=

Vtrans Vtrans 0> Vtrans 0<dt

αv

A A

p

ργ Cp Cv⁄pexh

Page 215: SimXpert R3.2 Explicit Workspace Guide

201Airbag and Occupant SafetyAirbag Definition

where is the critical pressure:

In case the outside pressure is greater than the pressure of the gas, inflow through the coupling surface occurs. This porosity model can only be used for ideal gases; i. e., materials modeled with the gamma law equation of state (EOSGAM).

Permeability

Permeability is defined as the velocity of gas through a surface area depending on the pressure differenceover that area.

On the PERMEAB entity in AIRBAG card, permeability can be specified by either a coefficient or a pressure dependent table:

1. Coefficient: Massflow = coeff * pressure_difference

2. Table

The velocity of the gas flow can never exceed the sonic speed:

ppenv pc>

penv pc<

=

pc

pcp2

γ 1+-----------

rr 1–-----------

Coeff

press_diff

coeffδ massflow)( )δ pressdiff( )

---------------------------------=

Gas Velocity

press_diff

Pressure Dependent Table

Gas Velocity

Page 216: SimXpert R3.2 Explicit Workspace Guide

Airbag Definition202

where is the gas constant of in- or outflowing gas and is the critical temperature.

The critical temperature can be calculated as follows:

where is the temperature of outflowing gas.

Initial Metric Method for AirbagsIf the reference configuration of the airbag is taken as the folded configuration, the geometrical accuracy of the deployed bag will be affected by both the stretching and the compression of elements during the folding process. Such element distortions are very difficult to avoid in a folded bag. By reading in a reference configuration such as the final unstretched configuration of a deployed bag, any distortions in the initial geometry of the folded bag will have no effect on the final geometry of the inflated bag. This is because the stresses depend only on the deformation gradient matrix:

where the choice of may coincide with the folded or unfold configurations. It is this unfolded

configuration which may be specified here.

Note that a reference geometry which is smaller than the initial airbag geometry will not induce initial tensile stresses.

If a liner is included and the LNRC parameter set to 1 in MATD034, compression is disabled in the liner until the reference geometry is reached; i.e., the fabric element becomes tensile.

Heat Transfer in AirbagsFor airbags with high temperature, energy is exchanged with the environment. There are two ways to define heat transfer in airbags, convection (CONVECT) and radiation (RADIATE).

The heat-transfer rates due to convection and radiation are defined by:

1. Convection:

Vmax Vsonic– γRTcrit–

γ Tcrit

Tcrit

Tgas--------- 2

γ 1+( )----------------–

Tgas

Fij

∂xi

∂Xj--------=

Xj

qconv h t( )A T Tenv–( )–

Page 217: SimXpert R3.2 Explicit Workspace Guide

203Airbag and Occupant SafetyAirbag Definition

where is the time-dependent heat transfer coefficient, is the (sub)surface area for heat transfer, is the temperature inside the airbag, and is the environment temperature.

2. Radiation:

where is the gas emissivity, is the (sub)surface area for heat transfer, is the temperature inside the airbag, and is the environment temperature.

h t( ) AT Tenv

qrad eAs TA TenvA–[ ]=

e A TTenv

Page 218: SimXpert R3.2 Explicit Workspace Guide

Seatbelts204

SeatbeltsBelt elements are single degree of freedom elements connecting two nodes. When the strain in an element is positive (i.e. the current length is greater then the unstretched length), a tension force is calculated from the material characteristics and is applied along the current axis of the element to oppose further stretching. The unstretched length of the belt is taken as the initial distance between the two nodes defining the position of the element plus the initial slack length.

Seatbelt shell elements must be used with caution. The seatbelt shells distribute the loading on the surface of the dummy more realistically than the two node belt elements. For the seatbelt shells to work with sliprings and retractors it is necessary to use a logically regular mesh of quadrilateral elements.

Figure 6-3 Seatbelt Shell Elements Definition

The ordering of the nodes and elements are important for seatbelt shells.

Slipring

Retractor

Top View:

RE3

RE4

RE2

RN5 SN5

SN4RN4

RN3

RN2

RN1RE1

SN3

SN2

SN1

SRE14 SRE24

SRE13 SRE23

SRE12 SRE22

SRE11 SRE21

Page 219: SimXpert R3.2 Explicit Workspace Guide

205Airbag and Occupant SafetySeatbelts

SEATBELT_PRETENSIONERPretensioners allow modeling of five types of active devices which tighten the belt during the initial stages of a crash. Types 1 and 5 represent a pyrotechnic device which spins the spool of a retractor, causing the belt to be reeled in. The user defines a pull-in versus time curve which applies once the pretensioner activates. Types 2 and 3 represent preloaded springs or torsion bars which move the buckle when released. The pretensioner is associated with any type of spring element including rotational. Note that when the preloaded spring, locking spring, and any restraints on the motion of the associated nodes are defined in the normal way; the action of the pretensioner is merely to cancel the force in one spring until (or after) it fires. With the second type, the force in the spring element is canceled out until the pretensioner is activated. In this case, the spring in question is normally a stiff, linear spring which acts as a locking mechanism, preventing motion of the seat belt buckle relative to the vehicle. A preloaded spring is defined in parallel with the locking spring. This type avoids the problem of the buckle being free to ‘drift’ before the pretensioner is activated. Type 4, a force type, is described below.

To activate the pretensioner, the following sequence of events must occur:

1. Any one of up to four sensors must be triggered.2. Then a user-defined time delay occurs.3. Then the pretensioner acts.

Type 1 pretensioner is intended to simulate a pyrotechnic retractor. Each retractor has a loading (and optional unloading) curve that describes the force on the belt element as a function of the amount of belt that has been pulled out of the retractor since the retractor locked. The type 1 pretensioner acts as a shift of this retractor load curve. An example will make this clear. Suppose at a particular time that 5mm of belt material has left the retractor. The retractor responds with a force corresponding to 5mm pull-out on it's loading curve. But suppose this retractor has a type 1 pretensioner defined, and, at this instant of time, the pretensioner specifies a pull-in of 20mm. The retractor then responds with a force that corresponds to (5mm + 20mm) on it's loading curve. This results in a much larger force. The effect can be that belt material will be pulled in, but there is no guarantee. The benefit of this implementation is that the force vs. pull-in load curve for the retractor is followed and no unrealistic forces are generated. Still, it may be difficult to produce realistic models using this option, so two new types of pretensioners have been added. These are available in MD Nastran r2 and later versions.

Types 2 and 3 are simple triggers for activating or deactivating springs, which then pull on the buckle. No changes have been made to these, and they are not discussed here.

The type 4 pretensioner takes a force vs. time curve (see Figure 6-4). Each time step, the retractor computes the desired force without regard to the pretensioner. If the resulting force is less than that specified by the pretensioner load curve, then the pretensioner value is used instead. As time goes on, the pretensioner load curve should drop below the forces generated by the retractor, and the pretensioner is then essentially inactive. This provides for good control of the actual forces, so no unrealistic values are generated. The actual direction and amount of belt movement is unspecified, and depends on the

Page 220: SimXpert R3.2 Explicit Workspace Guide

Seatbelts206

other forces being exerted on the belt. This is suitable when the force the pretensioner exerts over time is known.

Figure 6-4 Force versus Time Pretensioner. At the intersection, the retractor locks.

The type 5 pretensioner is essentially the same as the old type 1 pretensioner, but with the addition of a force limiting value. The pull-in is given as a function of time, and the belt is drawn into the retractor exactly as desired. However, if at any point the forces generated in the belt exceed the pretensioner force limit, then the pretensioner is deactivated and the retractor takes over. In order to prevent a large discontinuity in the force at this point, the loading curve for the retractor is shifted (in the abscissa) by the amount required to put the current (pull-out, force) on the load curve. For example, suppose the current force is 1000, and the current pull-out is -10 (10mm of belt has been pulled in by the pretensioner). If the retractor would normally generate a force of 1000 after 25mm of belt had been pulled OUT, then the load curve is shifted to the left by 3, and remains that way for the duration of the calculation. So that at the current pull-in of 10, it generates the force normally associated with a pull out of 25. If the belt reaches a pull out of 5, the force is as if it were pulled out 40 (5 + the shift of 35), and so on. This option is included for those who liked the general behavior of the old type 1 pretensioner, but has the added feature of the force limit to prevent unrealistic behavior.

The type 6 pretensioner is a variation of the type 4 pretensioner, with features of the type 5 pretensioner. A force vs. time curve is input and the pretensioner force is computed each cycle. The retractor linked to this pretensioner should specify a positive value for PULL, which is the distance the belt pulls out before it locks. As the pretensioner pulls the belt into the retractor, the amount of pull-in is tracked. As the pretensioner force decreases and drops below the belt tension, belt will begin to move back out of the retractor. Once PULL amount of belt has moved out of the retractor (relative to the maximum pull in encountered), the retractor will lock. At this time, the pretensioner is disabled, and the retractor force curve is shifted to match the current belt tension. This shifting is done just like the type 5 pretensioner. It

Force

Defined Forcevs.

Time Curve

Retractor Lock Time

Retractor Pull-out Force

Time

Page 221: SimXpert R3.2 Explicit Workspace Guide

207Airbag and Occupant SafetySeatbelts

is important that a positive value of PULL be specified to prevent premature retractor locking which could occur due to small outward belt movements generated by noise in the simulation.

SEATBELT_RETRACTOR

The unloading curve should start at zero tension and increase monotonically (i.e., no segments of negative or zero slope).

Retractors allow belt material to be paid out into a belt element. Retractors operate in one of two regimes: unlocked when the belt material is paid out, or reeled in under constant tension and locked when a user defined force-pullout relationship applies.

The retractor is initially unlocked, and the following sequence of events must occur for it to become locked:

1. Any one of up to four sensors must be triggered. (The sensors are described below.)2. Then a user-defined time delay occurs.3. Then a user-defined length of belt must be paid out (optional).4. Then the retractor locks and once locked, it remains locked.

In the unlocked regime, the retractor attempts to apply a constant tension to the belt. This feature allows an initial tightening of the belt and takes up any slack whenever it occurs. The tension value is taken from the first point on the force-pullout load curve. The maximum rate of pull out or pull in is given by 0.01 × fed length per time step. Because of this, the constant tension value is not always achieved.

In the locked regime, a user-defined curve describes the relationship between the force in the attached element and the amount of belt material paid out. If the tension in the belt subsequently relaxes, a different user-defined curve applies for unloading. The unloading curve is followed until the minimum tension is reached.

The curves are defined in terms of initial length of belt. For example, if a belt is marked at 10mm intervals and then wound onto a retractor, and the force required to make each mark emerge from the (locked) retractor is recorded, the curves used for input would be as follows:

Pyrotechnic pretensions may be defined which cause the retractor to pull in the belt at a predetermined rate. This overrides the retractor force-pullout relationship from the moment when the pretensioner activates.

If desired, belt elements may be defined which are initially inside the retractor. These will emerge as belt material is paid out, and may return into the retractor if sufficient material is reeled in during unloading.

0 Minimum tension (should be > zero)

10mm Force to emergence of first mark

20mm Force to emergence of second mark

.

.

.

.

.

.

Page 222: SimXpert R3.2 Explicit Workspace Guide

Seatbelts208

Elements e2, e3 and e4 are initially inside the retractor, which is paying out material into element e1.

When the retractor has fed into e1, where

(minimum length defined on belt material input)

(fed length defined on retractor input)

Element e2 emerges with an unstretched length of ; the unstretched length of element e1 is reduced by the same amount. The force and strain in e1 are unchanged; in e2, they are set equal to those in e1. The retractor now pays out material into e2.

If no elements are inside the retractor, e2 can continue to extend as more material is fed into it.

As the retractor pulls in the belt (for example, during initial tightening), if the unstretched length of the mouth element becomes less than the minimum length, the element is taken into the retractor.

To define a retractor, the user enters the retractor node, the ‘mouth’ element (into which belt material will be fed), e1 in Figure 6-5, up to 4 sensors which can trigger unlocking, a time delay, a payout delay (optional), load and unload curve numbers, and the fed length. The retractor node is typically part of the vehicle structure; belt elements should not be connected to this node directly, but any other feature can be attached including rigid bodies. The mouth element should have a node coincident with the retractor but should not be inside the retractor. The fed length would typically be set either to a typical element initial length, for the distance between painted marks on a real belt for comparisons with high speed film. The fed length should be at least three times the minimum length.

If there are elements initially inside the retractor (e2, e3 and e4 in the Figure 6-5) they should not be referred to on the retractor input, but the retractor should be identified on the element input for these elements. Their nodes should all be coincident with the retractor node and should not be restrained or constrained. Initial slack will automatically be set to 1.1 × minimum length for these elements; this overrides any user-defined value.

Lcrit

Lcrit fed length 1.1 minimum length×–=

1.1∞minimum length

Page 223: SimXpert R3.2 Explicit Workspace Guide

209Airbag and Occupant SafetySeatbelts

Weblockers can be included within the retractor representation simply by entering a ‘locking up’ characteristic in the force pullout curve (see Figure 6-6. The final section can be very steep (but must have a finite slope).

BeforeElement 1

Element 2

Element 3

Element 4

All nodes within this area are coincident

Element 1

Element 2

Element 3

Element 4

After

Page 224: SimXpert R3.2 Explicit Workspace Guide

Seatbelts210

Figure 6-5 Elements in a Retractor

Figure 6-6 Retractor Force Pull Characteristics

SEATBELT_SENSOR

Sensors are used to trigger locking of retractors and activate pretensioners. Four types of sensors are available which trigger according to the following criteria:

By default, the sensors are inactive during dynamic relaxation. This allows initial tightening of the belt and positioning of the occupant on the seat without locking the retractor or firing any pretensioners. However, a flag can be set in the sensor input to make the sensors active during the dynamic relaxation phase.

SEATBELT_SLIPRING

Sliprings allow continuous sliding of a belt through a sharp change of angle. Two elements (1 & 2 in Figure 6-7) meet at the slipring. Node B in the belt material remains attached to the slipring node, but belt material (in the form of unstretched length) is passed from element 1 to element 2 to achieve slip. The amount of slip at each timestep is calculated from the ratio of forces in elements 1 and 2. The ratio of

forces is determined by the relative angle between elements 1 and 2 and the coefficient of friction, .

Type 1 – When the magnitude of x-, y-, or z- acceleration of a given node has remained above a given level continuously for a given time, the sensor triggers. This does not work with nodes on rigid bodies.

Type 2 – When the rate of belt payout from a given retractor has remained above a given level continuously for a given time, the sensor triggers.

Type 3 – The sensor triggers at a given time.

Type 4 – The sensor triggers when the distance between two nodes exceeds a given maximum or becomes less than a given minimum. This type of sensor is intended for use with an explicit mass/spring representation of the sensor mechanism.

without weblockers

with weblockers

PULLOUT

FO

RC

E

μ

Page 225: SimXpert R3.2 Explicit Workspace Guide

211Airbag and Occupant SafetySeatbelts

The tension in the belts are taken as and , where is on the high tension side and T1 is the force

on the low tension side. Thus, if is sufficiently close to , no slip occurs; otherwise, slip is just

sufficient to reduce the ratio to . No slip occurs if both elements are slack. The out-of-

balance force at node B is reacted on the slipring node; the motion of node B follows that of slipring node.

If, due to slip through the slipring, the unstretched length of an element becomes less than the minimum length (as entered on the belt material card), the belt is remeshed locally: the short element passes through the slipring and reappears on the other side (see Figure 6-7). The new unstretched length of e1 is

. Force and strain in e2 and e3 are unchanged; force and strain in e1 are now equal to those in e2. Subsequent slip will pass material from e3 to e1. This process can continue with several elements passing in turn through the slipring.

To define a slipring, the user identifies the two belt elements which meet at the slipring, the friction coefficient, and the slipring node. The two elements must have a common node coincident with the slipring node. No attempt should be made to restrain or constrain the common node for its motion will automatically be constrained to follow the slipring node. Typically, the slipring node is part of the vehicle body structure and, therefore, belt elements should not be connected to this node directly, but any other feature can be attached, including rigid bodies.

Figure 6-7 Elements Passing Through Slipring

T1 T2 T2

T2 T1

T2 T1⁄ eμΘ

1.1 minimum length×

Before After

Slipring

Element 1

Element 2Element 1

Element 2

B

Element 3

Element 3

Page 226: SimXpert R3.2 Explicit Workspace Guide

Occupant Dummy Models212

Occupant Dummy ModelsThe occupant dummy models, also known as ATDs (Anthropomorphic Test Devices) were introduced in the previous release of SOL 700 for those applications that airbag was not needed. Many applications such as sled test and aircraft seat design, or armored vehicle design where the occupant behavior is studied when a land mine is detonated do not require airbag simulation.

SOL 700 supports occupant dummies that are readily available in LS-DYNA *key file format. These include:

1. LS-DYNA public domain dummies:

• 5th percentile deformable female dummy• 50th percentile deformable male dummy • 95th percentile deformable male dummy

• 5th percentile rigid female dummy • 50th percentile rigid male dummy • 95th percentile rigid male dummy

2. FTSS (First Technology Safety Systems) ATDs.

The FTSS ATD’s are high fidelity dummies and are available with additional licensing. The following FTSS dummies are supported through SimX Crash or ETA – VPG:

• 5% Female dummy• SID II• Hybrid III - 3% Child Dummy (W.I.P.)• Hybrid III - 6% Child Dummy (W.I.P.)• BIOSID (W.I.P.)

Page 227: SimXpert R3.2 Explicit Workspace Guide

213Simulation

Simulation

Page 228: SimXpert R3.2 Explicit Workspace Guide

Perform the Simulation214

Perform the Simulation

Create an Analysis jobYou set up and submit the analysis of your model by expanding Analysis from the ModelBrowser tree, then right click Nastran Jobs, and select Create new Job.

The Job Name you type in the textbox will become the filename for all analysis files created from this execution. Select Explicit Nonlinear (SOL 700) as the Solution Type. You have 5 choices for Job Type:

1. Export Bdf and Run Solver - writes the model including all model data, all load case information, analysis type, and analysis parameters to an analysis-ready file called job name.bdf, then runs the solver.

1. Export an Analysis Deck only - writes your model including all model data, all load case information, analysis type, and analysis parameters to an analysis-ready file called job name.bdf.

1. Export the Model only - writes your model data: nodes, elements, coordinate frames, element properties, material properties, and loads and boundary conditions without any analysis parameters to a file called job name.bdf.

2. Run a Model Check - analysis is submitted but will exit after initial model assembly. No solution is generated.

3. Submit Job to Batch Queue - allows submittal of multiple models to be analyzed sequentially with a single analysis request.

Case Control Section

The Case Control commands are used to

• Define subcases (e.g., loading and boundary conditions).

• Make selections of loads, constraints, etc.

• Specify output requests.

• Define titles, subtitles and labels for documenting the analysis.

Common subcase

Common subcase defines the master output requests for your analysis. Output requested in the common case will become the default for all subcases. The software will write all of these requests and conditions to the Case Control section. In addition, you can define cases which let you perform multiple analyses with different load and/or constraint sets.

Create Subcase

The subcase dialog box lets you select the loads and constraints to apply to your analysis.You can apply boundary conditions as both the common level or in subcases. If your analysis requires multiple load or constraint sets, you must create subcases.

MPCs: pick a constraint set to define constraint equations.

Page 229: SimXpert R3.2 Explicit Workspace Guide

215SimulationPerform the Simulation

Output Requests

Use the Output Requests dialog box to identify the types of output that you want from the analysis. You can select to output any combination of the results shown on the following form:

Solution Parameters

Here you can specify Solution Parameters such as whether or not to include Large Displacements, Follower Forces, etc.

.

Page 230: SimXpert R3.2 Explicit Workspace Guide

Perform the Simulation216

Subcase Parameters

Here you specify Subcase Parameters such as Ending Time for the simulation, Number of Time Steps.

Page 231: SimXpert R3.2 Explicit Workspace Guide

217SimulationPerform the Simulation

Output File

The purpose of this section is to introduce the output file generated by a typical run. After an input file is submitted for execution, several output files may be generated.

Page 232: SimXpert R3.2 Explicit Workspace Guide

Results218

ResultsIf you submitted your analysis directly from SimXpert, the results will be attached upon job completion. If your analysis ran externally to SimXpert but you have the model in SimXpert, select Attach Results from the File menu and navigate to your results file. If your analysis ran externally to SimXpert and you do not have the model in SimXpert, select Import Results from the File menu and navigate to your results file. This will read in model information as well as results from the results file.

Output data is also stored in Result Cases. If you run your model with several different loading conditions or through several different analysis types, SimXpert will keep the output data from each analysis in a different Result Case.

Postprocessing can be divided into two main categories: Chart and State Plot. State Plot postprocessing can be further divided into the following types of plots:

1. Deformation

Can be displayed in any available render style. You can turn the display of the undeformed shape on or off as desired.

2. Fringe

Color code your model based on result value

3. Vector

Show vectors representing direction and magnitude of result value.

All plot types can be animated. You can animate a single result case by applying a progressive scale factor to the deformation result or you can animate over a selection of result sets. All plot types can be displayed together in the same window if desired.

State Plots

The State Plot properties form is the main control for postprocessing. It is from here you can control which result set is being displayed, how your model is displayed and select your desired postprocessing options.

You can use dynamic rotation to manipulate your model while results are displayed and also during animation.

• How to Select the Data used for postprocessing

The state plot properties form is accessed by clicking on the Results toolbox and selecting State Plot.

To choose the data used in the display, in the Results Cases list click the desired Result Case (A in figure), then click the Results Type to use (B), and, if desired, you can make selections for Derivation and Target Entities. You can limit the Results Cases listed using the Filter text box. If you are animating multiple Results Cases, simply select all desired cases in the Results Cases list.

• Deformed Shape Plots

The following are some of the options control the appearance of your deformed shape plot:

Page 233: SimXpert R3.2 Explicit Workspace Guide

219SimulationResults

1. Deformed display scaling - True: applies the related scale factor to the actual computed values for displacement To see a plot of your actual displacement set the scale factor to 1. Relative: applies the scale factor to display the maximum displacement as a percentage of your maximum model dimension. This is usually an exaggerated plot for ease in visualization.

2. Deformed Shape - controls rendering for Deformed shape display.

3. Undeformed Shape - can display or remove the undeformed model, as well as control how it is Contour Style View Options

• Fringe Plots

The Fringe tab allows access to data transforms. These options are very important to understand since they control how the data is converted from pure discrete numbers to a visual representation. Improper selection of data transforms can lead to erroneous interpretation of the results.

You can specify which domain in the model to use for result averaging in order to obtain an accurate representation of the results. The following domains are available:

1. Property - results will not be averaged across property boundaries

2. Material - results will not be averaged across material boundaries

3. All Entities - results will be averaged at all common nodes

4. Target Entities - results will be averaged only between the elements selected as the target entities

5. Element Type - results will not be averaged across boundaries between different types of elements

6. None - no averaging of results between any elements. Fringe values are based on individual element results only.

When the averaging domain is set to anything other than All Entities the resulting graphics may not be as smooth but this is a more accurate representation of the results when discontinuities exist in the structure.

You can compare the difference between using an averaging domain of None to one of the other averaged domains to assess your mesh quality. If there is a large difference in the maximum result these between the two fringe plots, especially at locations that do not have sharp corners or breaks in the model, the mesh may need to be refined in that area.

The Result averaging method controls how SimXpert converts the results from pure data at element centroids, corners, and nodes to the actual continuous graphical representation. The following methods are available.

1. Derive/Average - calculates the selected result value first then applies a simple average of all the contributing nodes.

2. Average/Derive - averages the contributions of the common nodes then derives the result

3. Difference - computes the minimum and maximum results for the elements sharing a common node. The difference between the maximum and minimum contributor to each node is plotted. The fringe plot of this difference is an indicator of mesh quality: result differences between neighboring elements should not be large. If large discontinuities are found the mesh should be refined in that area. Nodal results will have zero max-difference.

Page 234: SimXpert R3.2 Explicit Workspace Guide

Results220

4. Sum - Sums the result values of all contributing nodes. No averaging.

• Fringe attributes

Style allows you to choose between

1. Discrete - Each range on the spectrum is given a unique color block

2. Continuous Colors - The model is displayed with smooth transitions between each color

3. Element Fill - Elements are displayed with one solid color

• Vector Plots

Vector attributes - allows you to choose whether to scale vector lengths are adjusted, and how the vectors are color coded.

• Animation

Animation attributes- controls number of frames, delay, and type of scale factor used to generate the animation (Sinusoid, Linear, etc.)

Chart Plots

SimXpert can create XY plots of results. Control over the contents of a chart is provided by the chart properties form. The chart properties form is accessed by clicking on the Results toolbox and selecting Chart. It allows you to control the Results Cases and Results Type shown on the XY data plots. Choose the Results Cases and the Results Type from the appropriate list boxes. You can limit the Results Cases you see in the list box by using the Filter button.The Chart Properties form controls whether an XY plot is displayed, and what type of chart to display.

Page 235: SimXpert R3.2 Explicit Workspace Guide

221Example

Example

Impact of a tapered beam

Page 236: SimXpert R3.2 Explicit Workspace Guide

Impact of a Tapered Beam222

Impact of a Tapered Beam

Problem Statement

Simulate the impacting of a square cross section solid, tapered beam with a rigid wall. The impacting is to be simulated by moving the beam with an initial velocity toward wall, while the other end is free. The basic FEA model containing the nodes and the elements is imported from a nastran input file. Complete the model with materials, sections, boundary conditions, loads, and analysis options for performing the simulation.

Beam Dimensions:

Length: 40 in.

Cross Section: 2 in. square at one end, and 4 in. square at the other end.

Plate Dimensions:

6 in. X 6 in. ; Thickness: 0.60

Impact velocity = 7,200 in./sec

Material Properties

E = 30.E6 psi

ν = 0.3

ρ = 7.33E-4 lb-mass/in^3

σy = 58.E3 psi

ET = 29.E3 psi

Steps

Following are the steps to complete the impact model.

1. Launch SimXpert

Select MD Explicit as the Workspace

2. Turn off the Solver Card GUI Option

Tools -> Options -> GUI Options

Make sure the Solver Card is not checked in

Click Apply

3. Set the units for the model

Clik Units Manager

Page 237: SimXpert R3.2 Explicit Workspace Guide

223Impact of a Tapered Beam

Click Standard Units

Select in, lb, s as the units for Length, Mass, and Time respectively

Click OK (twice)

4. Import the FEA mesh from a .Nastran input file

File -> Import -> Nastran

Select the file tapered_beam_model.bdf

Hint: You can find the above file in the PartFiles folder under the help folder in the SimXpert installation directory.

Click Open

Close the (pop-up) nastran.err Notepad window

The imported FEA mesh as shown here represents the beam and the rigid wall.

Figure 8-1 The Tapered Beam Impacting a Rigid Wall

Page 238: SimXpert R3.2 Explicit Workspace Guide

Impact of a Tapered Beam224

5. Create the material.

Materials and Properties-> MAT [21 to 40] -> [024]MAT_PIECEWISE_LINEAR_PLASTICITY

Enter steel as the Title for the material

Enter value for RO: 7.33E-4

Enter value for E: 30.E6

Enter value for PR: 0.30

Enter value for SIGY: 58.E3

Enter value for ETAN: 29.E3

Click Create

6. Modify the element properties for the shell elements

From the Model Browser, Double Click on PSHELL_2... (under Property)

Click on the Material ID selection icon, and Click Select

Select steel, and Click Ok

Click on the Bending Material ID icon, and Click Select

Select steel, and Click Ok

Click on the Transverse Shear Material ID icon, and Click Select

Select steel, and Click Ok

Click Modify

7. Modify the element properties for the solid elements

From the Model Browser, Double Click on PSOLID_1... (under Property)

Click on the MID selection icon, and Click Select

Select steel, and Click Ok

Click Modify

Page 239: SimXpert R3.2 Explicit Workspace Guide

225Impact of a Tapered Beam

8. Create the Boundary conditions for the rigid plate

LBCs -> LBC -> SPC BC -> Fully Fixed Constraint

Pick all the nodes on the plate

Click Done on the Pick panel

This fixes the plate against all translations and rotations, essentially making it a rigid plate.

Figure 8-2 Boundary condition for the rigid plate

9. Create the Initial Velocity on the beam nodes

LBCs -> LBC -> Nodal BC -> Initial Transient Condition

Enter 7200 for ZVEL

Click Define App Region

Pick all the nodes on the beam

Click Create

10. Create Contact for the Beam Elements

CONTACT -> Deformable Body

Select Deformable Solid as Type

Type beam for Name

Select all the beam elements

Click OK

11. Create Contact for the Plate Elements

Page 240: SimXpert R3.2 Explicit Workspace Guide

Impact of a Tapered Beam226

CONTACT -> Deformable Body

Select Deformable Surface as Type

Type plate for Name

Select all the plate elements

Click OK

12. Create an analysis job

Model Browser: Right Click on tapered_beam_model.bdf

Select Create new Nastran Job

Enter name for the Job Name: tapered_beam

Click OK

13. Create the analysis parameters for the job

Right Click on Loadcase Control-> Properties

Enter 0.005 for Ending Time

Enter 100 for Number of Time Steps

Click Apply

Click Close

14. Specify the time step for d3plot and time hstory output

Job Parameters -> PARAM

Enter DYDTOUT for N1

Enter 0.0001 for V1

Enter STEPFCTL for N1

Enter 0.1 for V1

Click Create

Click Exit

15. Specify output requests

Right-Click on Output Requests

Click Add Velocity Output Request

Click OK

Page 241: SimXpert R3.2 Explicit Workspace Guide

227Impact of a Tapered Beam

16. Save the SimXpert database

File -> Save As

Enter name for the file: tapered_beam

Click Save

17. Export an MD Explicit Analysis Input File

Right Click on tapered_beam

Click Export

Enter tapered_beam for File name

Click Save

18. Submit the exported input file tapered_beam.bdf for analysis by MD Nastran.

Open MD Nastran

Select the input file: tapered_beam.bdf

Click Open

Click Run

19. Attach the Analysis Results (after the spawned MD Nastran job is completed)

File -> Attach Results

Select Results

Click the File Path icon

Select the result file: tapered_beam.dytr.d3plot

Click Open

Click OK

20. View the Simulation Results

Results -> Fringe

Result Cases: Select Time 0.005 (the last result case)

Result type: Stress, Components

Derivation: Von Mises

Click Update

Page 242: SimXpert R3.2 Explicit Workspace Guide

Impact of a Tapered Beam228