You are on page 1of 14

Computational Materials Science 39 (2007) 481–494

www.elsevier.com/locate/commatsci

Comparison of the implicit and explicit finite element methods


using crystal plasticity
F.J. Harewood a, P.E. McHugh a,b,*

a
National Centre for Biomedical Engineering Science, National University of Ireland, Galway, Ireland
b
Department of Mechanical and Biomedical Engineering, National University of Ireland, Galway, Ireland

Received 28 February 2006; received in revised form 28 April 2006; accepted 1 August 2006

Abstract

The implicit finite element (FE) method can encounter numerical difficulties when solving non-linear quasi-static problems. The iter-
ative approach employed may have trouble achieving convergence in analyses with a highly non-linear material behaviour, such as a crys-
tal plasticity constitutive model. In the case of the explicit FE method the solver equations can be solved directly to determine the solution
without iteration, thus providing an alternative, more robust method. In this study, a rate-dependent crystal plasticity algorithm was
developed for use with the explicit FE package, ABAQUS/explicit. The subroutine and an equivalent implicit version were used in a series
of comparative boundary value problem analyses. The suitability of the implicit and explicit solvers to various loading conditions was
assessed and multiple processor speedup rates were also investigated. The results of the study showed that, for simpler loading conditions,
the implicit method had a shorter solution time. In the case of loading conditions involving contact, the explicit method proved to be the
preferable choice. The explicit method displayed constantly high levels of parallelisation efficiency compared to the implicit method for
analyses solved using multiple processors. In conclusion, although the implicit FE method is traditionally favoured when solving
quasi-static problems, it is important to recognise the advantages that the explicit method has in solving certain loading conditions.
 2006 Elsevier B.V. All rights reserved.

Keywords: Implicit finite element method; Explicit finite element method; Crystal plasticity theory; Multiple processor parallelisation

1. Introduction explicit approach are reformulated as being dynamic and


in this form they can be solved directly to determine the
The finite element method is a popular computational solution at the end of the increment, without iteration.
tool used in engineering research and industrial design. In Several studies have been published comparing the two
the field of solid mechanics, and specifically non-linear and discussing their respective merits [14–16,29,30,35–37].
quasi-static problems, finite element equation solution These articles focus on the performance of the two methods
methods can generally be classed as either implicit or expli- in metal forming analyses. Rebelo et al. [29] found the
cit and are typically solved incrementally. In the implicit implicit method to be preferable in smaller 2D problems,
approach a solution to the set of finite element equations whereas the explicit method is more robust and efficient
involves iteration until a convergence criterion is satisfied for complicated models involving contact. The reason for
for each increment. The finite element equations in the this is that the implicit solver can encounter numerical dif-
ficulties in converging to a correct solution during an anal-
ysis involving large element deformation, highly non-linear
*
plasticity or contact between surfaces [9,14,29,35]. This
Corresponding author. Address: National Centre for Biomedical
Engineering Science, National University of Ireland, Galway, Ireland.
paper compares the suitability of the two solution methods
Tel.: +353 91 524411x3152. to various metal deformation analyses when employing a
E-mail address: peter.mchugh@nuigalway.ie (P.E. McHugh). user-written constitutive model.

0927-0256/$ - see front matter  2006 Elsevier B.V. All rights reserved.
doi:10.1016/j.commatsci.2006.08.002
482 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

In solid mechanics, crystal plasticity has been used in plasticity algorithms. In the study ABAQUS/standard
two categories of analysis [19]. The first is the investigation and ABAQUS/explicit are considered. The rate-dependent
of the performance of single metallic crystals under defor- crystal plasticity formulation presented by Peirce et al.
mation. The size scales of these analyses are at the granular [26] is used. It is expressed in terms of a stress update algo-
microscale and each metallic grain is explicitly modelled. rithm and is implemented as a user-defined material subrou-
They are solved as boundary value problems. The analysis tine for both versions of the code.
of the macroscale behaviour of polycrystalline aggregates The implicit and explicit solution procedures are out-
forms the second category of analysis. Typically during lined in Sections 1.1 and 1.2. In Section 2 the crystal plas-
large-scale deformation, randomly oriented crystals experi- ticity formulation of Peirce et al. [26] is presented. For the
ence lattice distortion and rotation which leads to a poly- implicit analyses the UMAT, developed by Huang [10] for
crystalline texture or orientation pattern. This is achieved implementation in ABAQUS/standard, is used. A new
using polycrystalline aggregate constitutive models and subroutine (VUMAT) was developed by the authors for
results in material anisotropy (e.g. [4,7,23,27]). The present implementation in ABAQUS/explicit. The VUMAT is based
study focuses on the former category: the implementation on the Huang UMAT [10]. Both user-defined subroutines
of crystal plasticity to study individual grain behaviour. are described in Section 3. In Section 4 the methods are
Boundary value problems employing crystal plasticity compared in terms of finite deformation analyses in 2D
have been shown to yield accurate macroscopic predictions and 3D. The impact of parallel processing on the compar-
of large strain ductility and the point of mechanical failure ison between the methods is also given in Section 4.
in small-scale metallic devices [31]. In a constitutive model, Finally, conclusions are drawn in Section 5.
such as that presented in Peirce et al. [26], the stresses are
calculated based on a non-linear strain hardening response 1.1. Implicit solution method
function. Such problems necessitate large deformations of
the FE mesh and display a highly non-linear mechanical The word ‘implicit’ in this paper refers to the method by
response. For these two reasons, it is of considerable inter- which the state of a finite element model is updated from
est to assess the effectiveness and efficiency of the explicit time t to t + Dt. A fully implicit procedure means that
solution method in solving such problems. the state at t + Dt is determined based on information at
Crystal plasticity has been used in many studies to model time t + Dt, while the explicit method solves for t + Dt
large deformations and strain localisations in metals and based on information at time t.
metallic based materials (e.g. [13,19,31–34,39]). Unfortu- There are a range of solution procedures used by impli-
nately a crystal plasticity constitutive theory is not provided cit FE solvers. A form of the Newton–Raphson method is
as standard in the commercially available FE software and, the most common and is presented here. Vectors and
as such, it is generally necessary to develop a stress update matrices are denoted as underlined. When solving a
algorithm and implement it in an external user-defined quasi-static boundary value problem, a set of non-linear
material module. Several researchers have developed stress equations is assembled:
update algorithms that define single crystal behaviour for Z Z
use with commercial finite element software such as ABA- GðuÞ ¼ B rðuÞ dV  N T t dS ¼ 0
T
ð1:1Þ
QUS and ANSYS [1,3,5,7,8,10,12,17,21,22,28]. In addition v S

to the algorithm by Huang [10], a number of authors have where G is a set of non-linear equations in u, and u is the
developed rate-dependent implicit algorithms for use with vector of nodal displacements. B is the matrix relating
ABAQUS (e.g. [5,8,17,21]). the strain vector to displacement. The product of BT and
Although the majority of algorithms developed have the stress vector, r, is integrated over a volume, V. N
captured rate-dependent mechanical behaviour, there has is the matrix of element shape functions and is integrated
also been significant effort in developing rate-independent over a surface, S. The surface traction vector is denoted
crystal plasticity formulations. The essential difference by t. Eq. (1.1) is usually solved by incremental methods,
between these two types of formulations is the presence where loads/displacements are applied in time steps, Dt,
of the relationship between the rate of shear strain on each up to an ultimate time, t.
slip system and the shear stress, as presented by Asaro and The state of the analysis is updated incrementally from
Needleman [2]. Its absence is a source of numerical difficul- time t to time t + Dt. An estimation of the roots of Eq.
ties in boundary value problems using the rate-independent (1.1) is made, such that for the ith iteration:
constitutive formulation. Several researchers have imple-
mented rate-independent algorithms successfully to achieve  1
oGðutþDt Þ
meaningful results (e.g. [1,22]). duiþ1 ¼ utþDt
iþ1  u tþDt
i ¼  i
GðutþDt
i Þ ð1:2Þ
ou
In this paper a new crystal plasticity algorithm is pre-
sented. This formulation was developed for use with the where uitþDt is the vector of nodal displacements for the ith
FE solver ABAQUS/explicit. The objective of the present iteration at time t + Dt. The partial derivative on the right-
work is to compare the performance of the implicit and hand side of the equation is the Jacobian matrix of the
explicit solution methods using two equivalent crystal governing equations and can be referred to as the global
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 483

stiffness matrix, K. Eq. (1.2) is manipulated and inverted to where F is the vector of externally applied forces, I is the
produce a system of linear equations: vector of internal element forces and M is the lumped mass
matrix. As the lumped mass matrix is diagonalised it is a
KðutþDt
i Þduiþ1 ¼ GðutþDt
i Þ ð1:3Þ trivial process to invert it, unlike the global stiffness matrix
in the implicit solution method. Therefore each time incre-
Eq. (1.3) must be solved, for each iteration, for the change
ment is computationally inexpensive to solve.
in incremental displacements, dui+1. In order to solve for
A stability limit determines the size of the time increment:
dui+1 the global stiffness matrix, K, must be inverted.
Although, this is a computationally expensive operation, 2
Dt 6 ð1:7Þ
iteration ensures that a relatively large time increment xmax
can be used while maintaining accuracy of solution [9,19]. where xmax is the maximum element eigenvalue. A conser-
Following iteration i, dui+1 has been determined and a vative and practical method of implementing the above
better approximation of the solution has been made, inequality is:
tþDt
uiþ1 , through Eq. (1.2). This in turn is used as the current
 e
approximation to the solution for the subsequent iteration L
(i + 1). Dt ¼ min d ð1:8Þ
c
The accuracy of the solution is dictated by the conver-
gence criterion where the updated value for G must be less where Le is the characteristic element length and cd is the
than a tolerance value. Complications can arise in an anal- dilatational wave speed:
ysis that has a highly non-linear stress–strain response or sffiffiffiffiffiffiffiffiffiffiffiffiffiffi
where there is contact and sliding between two surfaces. d k þ 2l
c ¼ ð1:9Þ
For a complex job it can be difficult to predict how long q
it will take to solve or even if convergence will occur. k and l are the Lamé elastic constants and q is the material
ABAQUS/standard uses a form of the N–R iterative density. A quasi-static problem that is solved using the ex-
solution method to solve for the incremental set of equa- plicit method would have much smaller time increments
tions. Formulating and solving the Jacobian matrix is the than an equivalent problem solved using the implicit meth-
most computationally expensive process. Several variations od. Although the incremental solution is easy to obtain
on the N–R method exist to improve the solution time. The using the explicit method, it is not unusual for an analysis
modified Newton method is the most commonly used alter- to take 100,000 increments to solve. In order to maintain
native and is suitable for non-linear problems. The Jaco- efficiency of the analyses it is important to ensure that
bian is only recalculated occasionally and in cases where the sizes of the elements are as regular as possible. This is
the Jacobian is unsymmetric it is not necessary to calculate so that one small element does not reduce the time incre-
an exact value for it. The modified Newton method ment for the whole model.
converges quite well using a symmetric estimate of the It is often impractical to run a quasi-static analysis using
Jacobian [9]. its true time scale as the runtime would be very large. A
number of methods can be used to artificially reduce the
1.2. Explicit solution method runtime of the simulation. The first involves simply speed-
ing up the applied deformation or loading rate and the
The explicit method was originally developed, and is pri- second involves scaling the density of the material in the
marily used, to solve dynamic problems involving deform- model. According to Eqs. (1.8) and (1.9), when the density
able bodies. Accelerations and velocities at a particular is scaled by a factor, f2, the runtime is reduced by a factor f.
point in time are assumed to be constant during a time The latter method is preferable as it does not affect the
increment and are used to solve for the next point in time. strain rate dependent response of viscoplastic/rate-depen-
ABAQUS/explicit uses a forward Euler integration scheme dent materials.
as follows [9]: It is important when performing a quasi-static simula-
1 tion that the inertial forces do not affect the mechanical
uðiþ1Þ ¼ uðiÞ þ Dtðiþ1Þ u_ ðiþ2Þ ð1:4Þ
response and provide unrealistic dynamic results. To
ðiþ1Þ ðiÞ
1 1 Dt þ Dt ðiÞ reduce the dynamic effects Kutt et al. [16] recommend that
u_ ðiþ2Þ ¼ u_ ði2Þ þ €
u ð1:5Þ
2 the ratio of the duration of the load and the fundamental
where u is the displacement and the superscripts refer to the natural period of the model be greater than five. It has been
time increment. The term ‘explicit’ refers to the fact that shown that by keeping the ratio of kinetic energy to the
the state of the analysis is advanced by assuming constant total internal strain energy at <5% dynamic effects in the
values for the velocities, u,
_ and the accelerations, €u, across model are negligible [6,14]. This is the criterion for quasi-
half time intervals. The accelerations are computed at the static behaviour that is employed in this paper.
start of the increment by During implicit analyses where the material gives a non-
linear stress–strain response many iterations are usually
uðiÞ ¼ M 1  ðF ðiÞ  I ðiÞ Þ
€ ð1:6Þ needed to solve for an increment. This leads to progressively
484 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

smaller time steps being used and should the code encounter considered equal. Quantitatively, slip system strain harden-
large non-linearities convergence may be impossible to ing is specified by the following hardness function as defined
achieve in practical terms. As there is no iteration involved by Peirce et al. [26]:
in the explicit method, convergence problems are not an  
 h0 c a 
issue. 
gðca Þ ¼ g0 þ ðg1  g0 Þ tanh   ð2:3Þ
g1  g 0 
The solution time of the implicit solver is proportional
to the square of the wavefront size in the global stiffness From which one can determine the hardening moduli,
matrix. This has implications when increasing the size of through differentiation:
the model and when running 3D simulations. In the case  
dgðca Þ  h0 c a 
of the explicit solver there is a linear relationship between haa ¼ hab ¼ hðca Þ ¼ ¼ h0 sech2   ð2:4Þ
dc a g g 
1 0
the size of the model and the solution time, as dictated
by the characteristic element length and the number of In the above expressions the material hardening parame-
elements in the model [9,14,15,29,35–37]. ters g0, g1 and h0 are the initial hardness of a slip system,
the maximum slip system hardness when og/oc = 0 and the
2. Theory value of og/oc when c = 0, respectively. These material
constants can be derived from the strain hardening part
The finite element analyses performed in this study of an experimental tensile stress–strain (r–e) curve for a
incorporate elastic and plastic constitutive laws in the material. The values used in this study are taken from the
context of finite deformation kinematics. The elasticity is single crystal tensile test data for 316L stainless steel pre-
considered to be isotropic and linear in terms of finite sented by Okamoto et al. [25], and as calibrated in [31]
deformation quantities and can be described using the
g0 ¼ 50 MPa; g1 ¼ 330 MPa; h0 ¼ 225 MPa;
Young’s modulus, E, and Poisson’s ratio, m. This is a rea-
1
sonable approach as the elastic strains in the model are a_ ¼ 0:001 s
very small in comparison to the plastic strains. Plasticity A rate sensitivity parameter, n = 20 is used for all of the
is described using rate-dependent crystal plasticity theory analyses except where stated.
[26]. A quantity of importance in the above equation is the
Crystal plasticity theory is a physically based plasticity accumulated slip, ca. This is a measure of the total crystal-
theory that represents the deformation of a metal at the lographic plastic strain at a point and is defined as follows:
microscale. The flow of dislocations in a metallic crystal
XN Z t
along slip systems is represented in a continuum frame-
ca ¼ j_cðaÞ jdt ð2:5Þ
work. Plastic strain is assumed to be solely due to crystallo- a¼1 0
graphic dislocation flow. The rate-dependent, viscoplastic
single crystal theory as presented in Peirce et al. [26] and where t is the time and the summation is over all the slip
Huang [10], and employed in several works such as systems at a point.
McHugh and Connolly [20], Savage et al. [31] and McGarry The material chosen, 316L stainless steel, has a face-cen-
et al. [18], is used. The rate-dependence is implemented in tred-cubic (FCC) crystalline structure. For this material the
the formulation through a power-law that relates the slip systems are defined by the following Miller indices:
resolved shear stress s(a) to the slipping rate c_ ðaÞ on each slip h1 1 1i{1 1 0}.
system a,
 ðaÞ n 3. Development of explicit user material subroutine
 
ðaÞ  s 
c_ ðaÞ ¼ asgnðs
_ Þ ðaÞ  ð2:1Þ
g The crystal plasticity constitutive theory is not provided
where a_ and n are a reference strain rate and rate sensitivity as standard in any of the commercially available finite
exponent, respectively, and g(a) is the slip system strain element analysis software. It is therefore necessary to
hardness. As n tends to infinity the material reaches the implement the theory in the form of a user-defined stress
rate-independent limit. update algorithm. This is implemented in the finite element
The slip system strain hardness, g(a), is determined by code ABAQUS/standard, an implicit solver, by means of a
integration of the following evolution equation UMAT, as coded in [10]. It was necessary to develop a VUMAT
for use with ABAQUS/explicit. Much of the coding
X
N
involved in the two algorithms is the same but there are
g_ ðaÞ ¼ hab j_cðbÞ j ð2:2Þ
b¼1
several key issues that must be addressed to maintain con-
sistency of results between the two solvers.
where hab is the strain hardening modulus; haa and hab These subroutines, written in Fortran, implement the
(a 5 b) are the self and latent hardening moduli, respec- theory in the form of a stress update algorithm that is
tively, and the summation ranges over the number of called at each integration point for every iteration during
slip systems, N. In this work, Taylor isotropic hardening a finite element simulation [9]. Recalling Eq. (1.1), the
is assumed where the self and latent hardening moduli are stress component must be updated during each iteration
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 485

and this operation is performed by the UMAT/VUMAT. The To determine the size of the initial time increment in
stress update is calculated thus: ABAQUS/explicit a bogus set of tiny strain increments
are passed in to the VUMAT at the start of the analysis. From
rðuitþDt Þ ¼ rðut þ Dui Þ ¼ rðut Þ þ Dri ð3:1Þ
the stress response of the material, a conservative value for
During every iteration of an analysis the finite element the stable time increment is calculated (Eqs. (1.8) and
solver provides the subroutine with quantities such as the (1.9)). The finite element solver requires that the material
strain and time increments, Dei and Dt, and the increment be elastic for this initial check. Due to the fact that the crys-
in stress, Dri, is calculated [9]. tal plasticity subroutine is computationally intensive, an
In this section the development of the crystal plasticity elastic stress–strain response must be defined that ensures
VUMAT for use with ABAQUS/explicit is described. Partic- a relatively small time increment. During this initial time
ular attention is paid to the differences between it and increment calculation stage a material response is defined
the crystal plasticity UMAT [10]. A schematic of the VUMAT with the same elastic properties as are used to describe
layout is presented in the Appendix. the elasticity in the body of the crystal plasticity subrou-
tine. This ensures that a relatively efficient time increment
3.1. System equations is employed. If a smaller increment is required a stiffer elas-
tic modulus may be used, although the solution time will be
The most important difference between the sets of equa- longer. This does not affect the response of the material
tions used in the two solvers is the lack of presence of a glo- during the analysis; it is purely for the purpose of time
bal stiffness matrix in the explicit solver. When writing a increment calculation.
UMAT it is vital that the Jacobian matrix be accurately
represented to get correct and efficient finite strain problem 3.4. Time integration scheme
solutions. It is not necessary to define any such matrix in the
VUMAT interface. Although this makes the writing of the
The forward gradient time integration scheme that
subroutine more straightforward, the choice of elements forms part of the stress update algorithm in [10] involves
available to the user is restricted to mainly first order. the solution of the following non-linear equation for the
incremental slip system shear strains using the Newton–
3.2. Vectorised interface Raphson method:
The explicit solution process involves a large number of   
 sa þ Dsa  n 
increments, each of which is easily solved for. Conse- Dc ðaÞ ðaÞ
¼ ð1  hÞDtc_ jt þ hasgnðs
_ 
aÞ 
  Dt
ga þ Dga  tþDt
quently, the explicit finite element calculation procedure
is well suited to being split up and solved by a number of ð3:2Þ
processors. With this in mind the VUMAT is constructed with
a vectorised interface. At the beginning of each increment where h ranges from 0 to 1. This is a non-linear implicit
the stress and state variable data are passed in, in the form equation as the increments of resolved shear stress, Dsa,
of two-dimensional arrays. Each column in an array con- and current strength, Dga, are functions of Dc(a). Solving
tains the information relating to an integration point of Eq. (3.2) in this way ensures that the convergence rate dur-
the material. When a simulation is performed using multi- ing the analysis is high and allows for a relatively large time
ple processors the analysis data can be split up into blocks increment to achieve convergence.
and solved independently. Thus, vectorisation is preserved The explicit solver does not require the use of iteration.
in the writing of the subroutine in order that optimal Time rates of change are assumed to be constant through-
processor parallelisation can be achieved. out each time increment and a value of h = 0 is used in Eq.
(3.2) such that an incremental quantity is calculated, in a
3.3. Size of time increment simple Euler fashion, as the product of the rate quantity
and the time increment, for example:
The initial time increment used in ABAQUS/standard is
DcðaÞ ¼ c_ ðaÞ Dt ð3:3Þ
chosen by the user. Subsequent increments are controlled
by an automatic incrementation control. However, when
implementing the UMAT it was necessary to improve the con- 3.5. Material rotation
trol in order to improve time-stepping accuracy. The varia-
tion in the accumulated slip, ca, throughout each iteration is During elastic deformation of a crystal, the crystal lattice
measured. If the rate of increase is excessive then the itera- undergoes rotation and distortion. This effect is captured by
tion is aborted and a smaller time increment size is used. the vectors that define the slip directions, s*(a), and the nor-
This is found to be an efficient method of incrementation mals to the slip planes, m*(a), as the deformation continues.
ðaÞ ðaÞ
control and prevents premature termination of an analysis. These vectors have components si and mi in the refer-
The same procedure is not necessary using ABAQUS/expli- ence Cartesian coordinate system. The incremental value
cit as the time increments are sufficiently small. of s*(a) is calculated thus:
486 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494
( )
ðaÞ
X ðbÞ
X ðbÞ ðaÞ
end of the previous increment and the start of the current
DS i ¼ Deij  lij DcðbÞ þ xij Dt  #ij DcðbÞ Sj one. It is treated thus:
b b
rtþDt ¼ dR  rt  dRT þ dr ð3:12Þ
ð3:4Þ
P ðbÞ ðbÞ P ðbÞ ðbÞ where rt+Dt is the current Cauchy stress and dr is the stress
where b lij Dc and b #ij Dc are the incremental
increment that has been calculated in the previous incre-
plastic strain and plastic lattice spin respectively. The quan-
ment. The value passed in at the start of each increment is
tities in the brackets equal the sum of the elastic strain and
the Cauchy stress in the model coordinate system. It is ‘ro-
the elastic spin increments. The increment of total crystal
tated’, as shown, at the end of each increment. The dR var-
rotation is denoted by xij Dt, where xij is the sum of the
iable is calculated using the Hughes–Winget algorithm [9]
rotation on each slip system, a, and is calculated by
1
ðaÞ ðaÞ ðaÞ dR ¼ ðI  12DxÞ  ðI þ 12DxÞ ð3:13Þ
xij ¼ asymðS i mj Þ ð3:5Þ
where I is the identity matrix and Dx is the anti-symmetric
where asym(Aij) denotes the asymmetric part of a tensor
part of the incremental velocity gradient, i.e. the incremen-
Aij. The incremental value of the slip normal, Dm*(a), is
tal form of W (Eq. (3.9)).
calculated similarly to Eq. (3.4).  
An important feature of crystal plasticity theory is that d Du
Dx ¼ asym ð3:14Þ
both the lattice stretch and rotation influence the amount dxtþDt=2
of plasticity:
This value is used in the calculations of s*(a) (Eq. (3.4)) and
X
N
m*(a) and is calculated from the variable dR according to
Lp ¼ c_ ðaÞ sðaÞ mðaÞ ð3:6Þ Eq. (3.13).
a¼1
In the case of the VUMAT the material is taken to lie on a
where Lp is plastic velocity gradient in the current state and corotational coordinate system, i.e. the coordinate system
the summation ranges over all the slip systems, a, in the rotates with the material. As each time increment is so
crystal. small, incrementally, it is assumed that all material rota-
The most important issue that the programmer must be tions are rigid body. Hence for each increment the problem
aware of is in regard to the way in which stress rates and, can be viewed as a small strain problem. The rotation used
consequently, rotations are dealt with. In the case of FE in ABAQUS/explicit is the Green–Naghdi spin rate. The
simulations using solid continuum elements and a user- Hughes–Winget algorithm is also used but takes a slightly
defined material ABAQUS/standard employs the Jaumann different form
stress rate, whereas ABAQUS/explicit employs the Green– 1
Naghdi stress rate [9,11]. The stress rates are defined, dR ¼ ðI  12DXÞ  ðI þ 12DXÞ ð3:15Þ
respectively, as: where DX is found from
rJ
r ¼ r_  W  r þ r  W ð3:7Þ _ T
DX ¼ DRR ð3:16Þ
and The rotations used by each code are different. However,
rG these differences are only evident when kinematic hardening
r ¼ r_  X  r þ r  X ð3:8Þ is employed. Johnson and Bamann [11] showed that when a
where r_ is the time derivative of stress, W is a spin rate kinematic hardening model is used, employing the Jaumann
derived from the velocity gradient stress rate, a sinusoidal response is exhibited by the shear
  stress beyond the yield point. This is not physically realistic.
ov When the Green–Naghdi stress rate is employed the shear
W ¼ asym ð3:9Þ
ox stress is shown to monotonically increase with the shear
and X is found from the right-hand polar decomposition of strain. As the crystal plasticity subroutine does not incorpo-
the total deformation gradient, F; rate kinematic hardening, both methods yield the same
results.
F ¼RU ð3:10Þ
Ultimately, during each time increment of the VUMAT,
and the increment of stress is calculated thus:
X ðaÞ
X ¼ R_  RT ð3:11Þ Drij ¼ Dglobal
ijkl Dekl  ½vij   DcðaÞ  rij  Dedil ð3:17Þ
a
In the stress update algorithms these quantities must be
calculated incrementally. where
In ABAQUS/standard the material is treated as being ðaÞ
vij ¼ Dglobal
ðaÞ ðaÞ ðaÞ
ijkl lkl þ xik rjk þ xjk rik ð3:18Þ
based in a fixed global coordinate system. Incremental
rotations are passed in to the UMAT at the start of each Dglobal
ijkl is the 4th order elastic constitutive tensor in the
increment. This array, dR, is the amount by which the global coordinate system and Dedil is the increment of dila-
stress and strain arrays have been rotated between the tational strain.
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 487

results are identical (Fig. 2). It is interesting to note that


Weber et al. [38] found that the Hughes–Winget algorithm
is not absolutely objective. A simultaneous rotation and
simple shearing of material was performed and a non-
objective stress response was generated. However, when
the values of Dt are small the performance of the algorithm
is satisfactory.

4. Comparative analyses

A range of 2D and 3D boundary value problems incor-


porating crystal plasticity are analysed using the implicit
and explicit finite element solvers, ABAQUS/standard and
ABAQUS/explicit, respectively. The mechanical response
Fig. 1. Schematic of the analysis to investigate the rotation of the
is used as a means of comparing the performance of both
material. user material subroutines. As the model has the ability to
detect localisations in the material it is also desirable that
To investigate the way that material rotation is dealt the contour profiles of the accumulated shear strain, c, com-
with in both user material subroutines a simple analysis pare well. To ensure a quasi-static analysis in the case of the
is run. In a two-step simulation a square of material is explicit method the kinetic energy must be negligible (<5%)
tensed uniaxially and in the second step, while maintaining compared to the internal energy [6].
the axial tension, the material is rotated (Fig. 1). The com- As shown in Section 1.2, the system of equations used to
ponents of the stress are monitored in the ABAQUS output solve for each time increment in the explicit code assumes a
database (odb) and the same components are also written constant acceleration and velocity across time steps. For a
directly from the material subroutines. The analysis is car- practical time increment to be maintained it is necessary to
ried out for the implicit and explicit solvers. apply displacements that follow an amplitude wave. A
Two components of stress are plotted in Fig. 2. In the smooth step time–displacement relationship is used to
case of the UMAT the components of stress calculated are ensure that the nodal accelerations and velocities remain
directly transmitted to the odb. This is not the case with continuous as the model is being strained.
the VUMAT. As the formulation is based in a corotational All computational simulations were performed using an
coordinate system, rotation of the material is not ‘seen’ SGI 3800, 500 MHz processor, high performance com-
by the VUMAT and there is no change in the orientation of puter, on one processor except in the cases where explicitly
any tensors. All components are passed into the VUMAT stated as being multiple processor. The analyses were
unrotated and the necessary rotations are performed performed using ABAQUS version 6.3.
following the stress update. Therefore when developing
the crystal plasticity VUMAT it was assumed that there is 4.1. 2D analyses
zero incremental rotation of the material and the tensor
dR (Eq. (3.13)) is the identity matrix. The calculated stress The 2D geometry used in this study is based on that
components in the VUMAT and UMAT differ but the odb presented in Savage et al. [31]. A 25 lm thick wire, with
the granular microstructure explicitly represented, is con-
structed. Each grain is idealised as a hexagon of area
92 lm2 (Fig. 3). The material modelled in this study,
316L stainless steel, has a face-centred-cubic (FCC) crystal
structure. The orientations of the FCC crystal axes are
randomly generated and assigned to each grain. Orienta-
tion mismatch among the grains causes stress localisations
and the coalescence of plastic strain due to favourable
grain orientations determines the site of eventual failure.

Fig. 2. Plot of two components of stress during tension and rotation of


the material. There are three outputs for each component: from the Fig. 3. Model of 316L stainless steel wire with a thickness of 25 lm. The
ABAQUS odb, directly from the UMAT, and directly from the VUMAT. granular microstructure is idealised as a series of hexagons (highlighted).
488 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

The model is meshed with first order reduced integration


plane strain quadrilateral elements (CPE4R).

4.1.1. Tension
The left-hand edge of the model is constrained in the
horizontal direction and a horizontal displacement is
applied to the right-hand edge. Rigid body motion is pre-
vented by constraining the left-hand bottom corner of the
model in all degrees of freedom. The wire is tensed beyond
the failure strain, which is taken as the strain at the point of
ultimate tensile stress (UTS). The strain is defined as the
ratio of the increase in length to the original length,
(l1  l0)/l0, and the stress is the ratio of force applied to
Fig. 4. Comparison of macroscopic mechanical performance for 2D
the wire to the original cross-sectional area of the wire, tension analyses.
F/A0. This produces engineering stress–engineering strain
(reng–eeng) curves and is a convenient method for present-
Table 1
ing tensile data. Computation times for 2D analyses using implicit (UMAT) and explicit
The reng–eeng response of the two models shows good (VUMAT) solvers
agreement with the failure point particularly well compared Analysis Runtime Ratio, Size of time
(Fig. 4). The distribution of plastic shear strain during (h, min) explicit/ increment,
necking is also very similar for the two analyses (Fig. 5). standard min/max
The solution time of the implicit method is 56 min as Tension UMAT 2D 0, 56 2.34 1.86e4/0.01
compared to 2 h 11 min for the explicit method (Table 1). Tension VUMAT 2D 2, 11 1.37e5/6.36e5
The shorter implicit solution time can be explained by the Bending UMAT 2D 1, 53 2.39 1.85e4/6.0e3
fact that the size of the incremental global stiffness matrix Bending VUMAT 2D 4, 30 4.86e6/1.2e5
Contact 1 UMAT 2D 1, 50 1.41 9.25e5/1.2e2
is relatively small due to the size of the model. As the solu- Contact 1 VUMAT 2D 2, 35 1.86e5/3.8e5
tion time in implicit analyses is proportional to the square Contact 2 UMAT 2D 0, 40a 0.875 5.74e4/3.8e2
of the wavefront of the global stiffness matrix in the model, Contact 2 VUMAT 2D 0, 35a 2.57e5/3.81e5
this simulation is computationally easy to solve. a
The solution time at equivalent points in the two analyses.

4.1.2. Bending rotation, about the z-axis (normal to the page), is applied
The left-hand boundary of the model is constrained in to this node. A bending moment is produced that is con-
all degrees of freedom. The degrees of freedom of the nodes stant along the length of the wire. The average curvature
along the right-hand edge are tied to a reference node and a along the length of the wire is used as a deformation

Fig. 5. Accumulated shear strain, c, in the 25 lm wire under tension solved using (a) the implicit solver and (b) the explicit solver.
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 489

Fig. 6. Comparison of macroscopic mechanical performance for 2D


bending analyses. Fig. 8. Comparison of the force–displacement behaviour of the rigid
cylinder for 2D contact analyses.

measure, analogous to eeng used in the tension analyses.


by the mass scaling factor employed to reduce the solution
The macroscopic comparison of bending moment–curva-
time of the analysis. Solution times are much closer for this
ture curves for the two FE analyses show the same perfor-
analysis than for the previous two. The solution times are
mance (Fig. 6). The ratio of solution times is similar to the
1 h 50 min and 2 h 35 min for implicit and explicit respec-
2D tension analyses (Table 1).
tively. The presence of contact does not affect the solution
process of the explicit code as strongly as the implicit code.
4.1.3. Contact
The second contact analysis models the interaction
The introduction of contact between surfaces increases
between two deformable materials. A block of material
the computational cost for the implicit solver. Smaller time
(E = 10 GPa, m = 0.3) is modelled as compressing a 25 lm2
increments are required to achieve convergence and com-
of the stainless steel wire. The basis for this analysis is purely
putational expense is further increased by the formation
to investigate the ability of the implicit and explicit codes to
and inversion of the stiffness matrix. Due to the nature of
solve a more numerically complicated analysis. The geome-
the explicit FE solver and the small time increments
try of the model is shown in Fig. 9. The bottom edge of the
involved, simple algorithms may be implemented to nego-
stainless steel is displaced by 0.01 mm in the vertical direc-
tiate contact conditions with a minimal loss of computa-
tion, while the top edge of the stiff block is held. This ensures
tional efficiency [9,15,29,37].
contact and compression of the wire. The same contact
Two types of analyses involving contact are performed.
algorithm as in the previous analysis is implemented.
The first analysis simulates a three-point bending of the
The implicit solver is unable to complete the simulation.
wire and models contact between a rigid body and the
A displacement of 7.27 · 103 mm is achieved before
stainless steel. A rigid semi-circular cylinder is brought into
numerical difficulties prevent further analysis. When the
contact with the wire at the midpoint while the left- and
implicit iterative solver encounters a highly non-linear
right-hand edges provide the reaction forces and are only
response very small time increments must be employed to
free to rotate about the z-axis (Fig. 7). A master–slave con-
tact algorithm is employed for both analyses. Frictionless
contact is assumed between the rigid surface and the wire.
It is interesting to note the force–displacement response
of the rigid body in both analyses (Fig. 8). In the explicit
case when the cylinder comes into contact with the wire
there is a vibration that dissipates quickly and subsequently
both curves follow the same path. This is a transient effect
and does not affect the final state of the model. It is caused

Fig. 7. 2D contact analysis. 25 lm wire is deformed by a rigid cylinder.


The left- and right-hand edges are free to rotate. Fig. 9. Model of contact simulation involving two deformable materials.
490 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

solve the equilibrium equations. However in this case, the Table 2


solver attempts increasingly small time increments without Computation times for 3D analyses using implicit (UMAT) and explicit
(VUMAT) solvers
achieving equilibrium. The minimum time increment for
the analysis in Table 1 is given as 5.74e4. However, in Analysis Runtime Ratio, Size of time
(h, min) explicit/ increment,
the final time increment, prior to termination of the job, standard min/max
time increments in the order of 1.0e8 are attempted with-
Tension UMAT 3D 27, 30 5.04 4.52e4/1.24e2
out success. Severe discontinuities at the surfaces in contact Tension VUMAT 3D 138, 43 1.06e5/5.01e5
are the cause of termination of the analysis. The explicit Torsion + 3D 40, 03 3.78 2.37e4/1.21e2
solver does not encounter such problems and this analysis bending UMAT
is completed. The solution time for the implicit simulation Torsion + 3D 151, 18 5.06e7/5.01e5
at the point of termination is approximately 40 min. The bending VUMAT
Contact UMAT 3D 42, 32 1.46 1.88e4/3.42e3
time taken by the explicit solver to solve to the same point Contact VUMAT 3D 62, 05 2.12e6/8.47e6
is 35 min while the total solution time is 40 min. Prior to
the premature termination of the implicit analysis the
force–displacement responses and the contour plots of 4.2.1. Torsion and bending
stress compare very well between both models. It is thus A combined loading of rotation around the x-axis (lon-
evident that the explicit solver is more suited to this analy- gitudinal axis of wire) and rotation around the z-axis is
sis in terms of solution time and ability to complete the applied to the right-hand end of the wire. The left-hand
analysis. end of the wire is constrained in all degrees of freedom.
The implicit code has a shorter solution time than the
4.2. 3D analyses explicit code. This can be expected for a simple deforma-
tion case. The ratio of explicit solution time to implicit
The model used in the 3D analyses is geometrically solution time is somewhat larger for the 3D displacement
simpler in comparison to the 2D analyses, with the grains driven analyses compared with the 2D analyses (Table 2).
being represented as cubes. The wire has a 25 lm2 section The increase in model size from 2D to 3D has a greater
with a length of 75 lm. Each grain is meshed with first order effect on the explicit solution times. The bandwidth size
reduced integration brick elements (C3D8R) (Fig. 10). in the implicit analyses remains relatively small, while the
Similarly to the 2D models, a random 3D crystallographic combination of the short explicit time increments and the
orientation is assigned to each grain. size of the model significantly increase solution times.
The 3D analyses are carried out in order to investigate It appears that the implicit solver is the quicker solver
what effect, if any, a more three-dimensional stress state for all three types of 3D model loading but it is important
has on the solution times. Three types of analyses are car- to comment that in the case of the contact analysis the
ried out; tension, contact, and a combination of torsion explicit solver solves for the initial interaction between
and bending. The two former loading conditions are imple- the surfaces more quickly. At time, t = 0.4 the solution
mented in the same way as the 2D analyses. time is 18 h 12 min for the implicit solver while it is 14 h
51 min for the explicit solver at the same point in the load-
ing history. The contact that follows is not as computation-
ally difficult to solve. Therefore, the implicit solver
increases the size of the time increments after the initial
contact. This shows that in an analysis where the contact
conditions are more complex, i.e. between two deformable
materials, or are constantly changing, the explicit solver
would prove to be the better option.

4.3. Material strain-rate sensitivity

The material in each of the previous analyses uses a rel-


atively rate-dependent value of n = 20 (Eq. (2.1)). By
increasing the value of n the material becomes more rate-
independent. It is known that a material with an increased
rate sensitivity delays the development of shear bands
[24,26]. An analysis employing a material with low rate sen-
sitivity, i.e. nearly rate-independent, is computationally
more difficult to solve as higher strain gradients must be
Fig. 10. 3D crystal plasticity model with a cubic crystalline structure. One resolved.
grain is highlighted, there are 3 · 3 grains in the cross-section and nine A more rate-independent parameter, n, is assigned to the
grains along the length. material and the 2D tension case is again simulated. Values
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 491

Table 3 two processors indicates a solution time saving of 50%. A


Computation times for the 2D tension analysis using different values for negative efficiency indicates that a longer solution time is
the rate sensitivity exponent
required when using multiple processors than when using
Tension Rate sensitivity Runtime Size of time increment, one processor.
analysis exponent, n (h, min) min/max
There is no speedup with the implicit solver when using
UMAT 20 0, 56 1.89e3/0.01 multiple processors for this simple analysis. There is actu-
UMAT 50 1, 24 7.05e5/2.3e3
UMAT 100 1, 42 5.06e5/1.0e3
ally a loss in solution time as indicated by the negative
VUMAT 20 2, 11 1.37e5/6.36e5 processor efficiency. This can be explained by the extra
VUMAT 50 2, 22 1.24e5/6.36e5 computation time required to assemble the system equa-
VUMAT 100 2, 23 1.22e5/6.36e5 tions from a number of processors. The efficiency values
for each of the explicit analyses are shown to be quite good
of n = 50 and n = 100 are chosen. The resulting runtimes (Table 4). When four processors are used to solve the 2D
show that as the material becomes more rate insensitive tension analysis the solution time is 44 min. This compares
the implicit solver has trouble converging to a final solution favourably to the quickest solution time of 56 min using
(Table 3). The explicit solver is affected to a much smaller the implicit solver.
degree. Table 3 shows that there is a significant reduction In the 2D analyses a very high speedup efficiency is
in the size of the time increments using the implicit achieved when the explicit analysis is run across two pro-
solver when the rate sensitivity exponent is increased, cessors. The efficiency is not as high when four processors
whereas, there is little change in the size of the explicit time are used. There is a type of model size dependence associ-
increments. ated with the explicit speedup factors. When using the
domain parallelisation setting a larger model can be split
4.4. Processor parallelisation amongst a large number of processors. Each domain
requires a significant amount of processor capability to
As stated in Section 3.2 the VUMAT is constructed in a solve the analysis. If a large number of processors is used
vectorised format, the solver in ABAQUS/explicit is simi- to solve a relatively small model the computational power
larly constructed. This ensures that a high level of efficiency required of each processor may be quite low, such that two
can be achieved when multiple processors are used. The 2D domains may be solved by one processor. The speedup
tension case is solved across multiple processors using both over using fewer processors is not simply a product of
the implicit and explicit solvers. The simulations are solved the increase in number of processors.
using 2 and 4 processors on the SGI 3800 multiple proces- In order to investigate whether a better speedup can be
sor computer. achieved in a large model the 3D tension case is run across
The results of these analyses are presented in Table 4. In two processors. The solution time is 17 h 31 min using the
order to characterise the efficiency of using multiple proces- implicit solver. This gives an efficiency of 75.5%. Although
sors the following formula was developed: this solution time compares favourably to the 3D explicit
pffiffiffiffiffiffi analyses it is worth noting the high efficiency in the explicit
gprocessor % ¼ jCj  sgnðCÞ  100 ð4:1Þ case (Table 4). Given the large size of the model, further
with increase of the number of processors would continue to
    yield a high efficiency and would likely result in a shorter
t1 1 1 solution time than the implicit analysis.
C¼   1 ð4:2Þ
tx  v x v
where t is the solution time and x is the number of proces- 5. Conclusions
sors used. For example, an efficiency of 100% when using
A crystal plasticity material subroutine has been devel-
Table 4 oped by the authors for use with the explicit finite element
Computation times and parallelisation efficiency for analyses solved using solver ABAQUS/explicit. The results from a variety of 2D
multiple processors and 3D loading conditions are shown to be the same as the
Tension # Processors Runtime Efficiency original UMAT. Either solver is shown to be more efficient
analysis (h, min) (%) when solving certain types of simulations. In the simpler
UMAT 2D 1 0, 56 – analyses, where deformation is directly applied to the mate-
UMAT 2D 2 0, 57 13.2 rial, the implicit FE solver is shown to solve more quickly.
UMAT 2D 4 1, 02 20.0 The ratio of explicit runtime to implicit runtime is approx-
UMAT 3D 1 27, 30 –
imately 2.35 for the simple 2D analyses. The ratio for anal-
UMAT 3D 2 17, 31 75.5
VUMAT 2D 1 2, 11 – yses in 3D is approximately double that value. The
VUMAT 2D 2 1, 13 89.1 inclusion of time increment sizes in Tables 1 and 2 reveals
VUMAT 2D 4 0, 44 81.2 the influence of different loading conditions on similar
VUMAT 3D 1 138, 43 – models. It is noteworthy, when comparing the tension anal-
VUMAT 3D 2 74, 35 92.7
yses to the bending analyses in Table 1, that the bending
492 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

loading has a far greater effect on the explicit analyses than It is interesting to note the increase in solution times
the implicit analyses. A similar trend is clear in the 3D when a more rate-independent material is used in the 2D
analyses from Table 2. The opposite is true of the contact tension analyses. The small time increments used in the
analyses; the introduction of contact has little effect on the explicit solver ensure that the highly non-linear material
size of the explicit time increments but significantly reduces behaviour is dealt with, with a minimal increase in time.
the size of the implicit increments. This is not the case with the implicit solver where smaller
As regards the implicit solution iteration process, for time increments must be employed to achieve convergence.
each increment, ABAQUS chooses an initial guess, u0tþDt , When one considers the high multiple processor effi-
assuming an incrementally linear response for the material, ciency that is achieved by the explicit solver compared to
based on the tangent stiffness calculated at the end of the the implicit solver for every situation considered in this
previous increment ðKðutfinal ÞÞ. In the case of a linear elastic study, the former option would prove to be the more
material this would provide the correct solution directly. favourable when the user has a multiple processor com-
For non-linear problems this should yield a good initial puter at his/her disposal. Given the ongoing technological
guess for small increments, Dt. Increasingly non-linear advances, multiple processor computers are becoming
problems require increasingly small time increments to more commonly used. Therefore it is important to recog-
maintain solution accuracy. Within the constraints of nise the link between the speedup efficiency, the number
ABAQUS, in the context of the scope of this paper, few of processors assigned to solve an analysis, and the size
options are provided for improving the process. In the of the model. The optimal number of processors should
problems of interest here the non-linearities due to contact be determined for each analysis so that a high parallelisa-
and material response are of such a severity as to require tion efficiency can be maintained.
time step sizes far smaller than are practically usable to
generate solutions with the implicit method.
The explicit solver is better suited to deal with complex Acknowledgements
contact and sliding conditions, particularly in cases of large
element deformation. In the contact analyses that include a The authors wish to acknowledge funding from
rigid body the runtimes using the implicit code are shorter Embark, Irish Research Council for Science, Engineering
than the explicit code. This disguises the fact that the explicit and Technology: Funded by the National Development
code actually solves the contact condition more quickly. The Plan. The simulations in this work were performed on
second 2D contact analysis involving more complex contact the SGI 3800 high performance computer at NUI, Galway.
conditions and greater element deformation provides a
clearer indication of the benefits of the explicit solver. Appendix
F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494 493

References [6] W.J. Chung, J.W. Cho, T. Belytschko, Engineering Computations 15


(6) (1998) 750–776.
[1] L. Anand, M. Kothari, Journal of the Mechanics and Physics of [7] J.D. Clayton, D.L. McDowell, International Journal of Plasticity 19
Solids 44 (4) (1996) 525–558. (9) (2003) 1401–1444.
[2] R.J. Asaro, A. Needleman, Acta Metallurgica 33 (6) (1985) 923–953. [8] M. Grujicic, Y. Zhang, Materials Science and Engineering A 265 (1–2)
[3] D.J. Bammann, Materials Science and Engineering A 309–310 (2001) (1999) 285–300.
406–410. [9] Hibbitt, Karlsson, and Sorenson, ABAQUS Theory Manual,
[4] R. Becker, Acta Metallurgica et Materialia 39 (6) (1991) 1211–1230. Pawtucket, RI, USA, 1997.
[5] S.-H. Choi, Acta Materialia 51 (6) (2003) 1775–1788. [10] Y. Huang, Harvard University Report, MECH 178, 1991.
494 F.J. Harewood, P.E. McHugh / Computational Materials Science 39 (2007) 481–494

[11] G.C. Johnson, D.J. Bammann, International Journal of Solids and [26] D. Peirce, R. Asaro, A. Needleman, Acta Metallurgica et Materialia
Structures 20 (8) (1984) 725–737. 31 (12) (1983) 1951–1976.
[12] J. Kaczmarek, International Journal of Plasticity 19 (10) (2003) 1585– [27] D. Raabe, Acta Metallurgica et Materialia 43 (3) (1995) 1023–1028.
1603. [28] J.L. Raphanel, C. Teodusiu, L. Tabourot, in: C. Teodusiu, J.L.
[13] H.-K. Kim, S.-I. Oh, International Journal of Plasticity 19 (8) (2003) Raphanel, F. Sidoroff (Eds.), Large Plastic Deformations: Funda-
1245–1270. mental Aspects and Applications to Metal Forming, A.A. Balkema,
[14] J. Kim, Y.H. Kang, H.-H. Choi, S.-M. Hwang, B.S. Kang, The Rotterdam, 1993, pp. 153–168.
International Journal of Advanced Manufacturing Technology 20 (6) [29] N. Rebelo, J.C. Nagtegaal, L.M. Taylor, Numerical Methods in
(2002) 407–413. Industrial Forming Processes (1992) 99–108.
[15] S. Kugener, AMP Journal of Technology 4 (1995) 8–15. [30] W. Rust, K. Schweizerhof, Thin-Walled Structures 41 (2–3) (2003)
[16] L.M. Kutt, A.B. Pifko, J.A. Nardiello, J.M. Papazian, Computers & 227–244.
Structures 66 (1) (1998) 1–17. [31] P. Savage, B.P. O’Donnell, P.E. McHugh, B.P. Murphy, D.F. Quinn,
[17] J.W. Kysar, Journal of the Mechanics and Physics of Solids 49 (5) Annals of Biomedical Engineering 32 (2) (2004) 202–211.
(2001) 1099–1128. [32] B.M. Schroeter, D.L. McDowell, International Journal of Plasticity
[18] J.P. McGarry, B.P. O’Donnell, P.E. McHugh, J.G. McGarry, 19 (9) (2003) 1355–1376.
Computational Materials Science 31 (3–4) (2004) 421–438. [33] N.J. Sorensen, B.S. Andersen, Computer Methods in Applied
[19] P.E. McHugh, in: IUTAM Summer School on Mechanics of Mechanics and Engineering 132 (3–4) (1996) 345–357.
Microstructured Materials, Udine, Italy, 2003. [34] A. Staroselsky, L. Anand, Journal of the Mechanics and Physics of
[20] P.E. McHugh, P.J. Connolly, Computational Materials Science 27 (4) Solids 46 (4) (1998) 671–696.
(2003) 423–436. [35] J.S. Sun, K.H. Lee, H.P. Lee, Journal of Materials Processing
[21] F.T. Meissonnier, E.P. Busso, N.P. O’Dowd, International Journal of Technology 105 (1–2) (2000) 110–118.
Plasticity 17 (4) (2001) 601–640. [36] L. Taylor, J. Cao, A.P. Karafillis, M.C. Boyce, Journal of Materials
[22] C. Miehe, J. Schroder, International Journal for Numerical Methods Processing Technology 50 (1–4) (1995) 168–179.
in Engineering 50 (2001) 273–298. [37] S.P. Wang, S. Choudhry, T.B. Wertheimer, White Papers in MARC
[23] K.W. Neale, K. Inal, P.D. Wu, International Journal of Mechanical Corp., 1997.
Sciences 45 (10) (2003) 1671–1686. [38] G.G. Weber, A.M. Lush, A. Zavaliangos, L. Anand, International
[24] A. Needleman, Computer Methods in Applied Mechanics and Journal of Plasticity 6 (6) (1990) 701–744.
Engineering 67 (1) (1988) 69–85. [39] A.G. Youtsos, E. Gutierrez, G. Verzeletti, Acta Mechanica 84 (1990)
[25] K. Okamoto, A. Yoshinari, J. Kaneda, Y. Aono, T. Kato, Materials 109–125.
Transactions 41 (7) (2000) 806–814.

You might also like