An Efficient and Robust VUMAT Implementation of El
An Efficient and Robust VUMAT Implementation of El
net/publication/327595782
CITATIONS READS
5 1,204
2 authors, including:
Olivier Pantalé
Ecole Nationale d'Ingénieurs de Tarbes
47 PUBLICATIONS 560 CITATIONS
SEE PROFILE
Some of the authors of this publication are also working on these related projects:
All content following this page was uploaded by Olivier Pantalé on 04 December 2018.
Abstract
This paper describes the development of an efficient and robust numerical algorithm for the im-
plementation of elastoplastic constitutive laws in the commercial nonlinear finite element soft-
ware Abaqus/Explicit through a VUMAT FORTRAN subroutine. In the present paper, while
the Abaqus/Explicit uses an explicit time integration scheme, the implicit radial return mapping
algorithm is used to compute the plastic strain, the plastic strain rate and the temperature at the
end of each increment instead of the widely used forward Euler approach. This more complex
process allows us to obtain more precise results with only a slight increase of the total computa-
tional time. Corrector term of the radial return scheme is obtained through the implementation
of a safe and robust Newton-Raphson algorithm able to converge even when the piecewise de-
fined hardening curve is not derivable everywhere. The complete method of how to implement a
user-defined elastoplastic material model using the radial return mapping integration scheme is
presented in details with the application to the widely used Johnson-Cook constitutive law. Five
benchmark tests including one element tests, necking of a circular bar and 2D and 3D Taylor im-
pact tests show the efficiency and robustness of the proposed algorithm and confirm the improved
efficiency in terms of precision, stability and solution CPU time. Finally, three alternative con-
stitutive laws (the TANH, modified TANH and Bäker laws) are presented, implemented through
our VUMAT routine and tested.
Keywords: Radial return algorithms, Elastoplasticity, Finite element, Strain-dependent,
Thermomechanical
1 Introduction
Over the last past years, numerous studies have been concentrated on dynamic mechanical
properties of materials. Constitutive laws, the relation between internal forces and deformations,
have also received much attention. Under large deformations and high deformation rates such as
forming, machining processes and impact analyses, elastoplastic constitutive laws play a signifi-
cant role in predicting the mechanical behavior of materials.
Although many kinds of constitutive laws have been implemented into the commercial non-
linear finite element software Abaqus [1], in some conditions they cannot fit well some complex
∗ Correspondingauthor
Email address: ❖❧✐✈✐❡%✳'❛♥*❛❧❡❅❡♥✐*✳❢% (Olivier Pantalé)
URL: ❤**♣✿✴✴✇✇✇✳❡♥✐*✳❢% (Olivier Pantalé)
behaviors of materials such as the deformation process involving large strain, high strain rates,
temperature softening, etc... Therefore, Abaqus provides the ability for users to implement only
the constitutive flow, or the complete constitutive behavior law by themselves via FORTRAN
user subroutines: UHARD or VUHARD for the hardening flow law and UMAT or VUMAT for
the complete behavior law. While the user hardening implementation is quite simple and easy,
the user material implementation needs more expertise. The major difference from VUMAT to
UMAT is that VUMAT subroutines do not need the evaluation of the so-called consistent Jaco-
bian matrix, but only the evaluation of the stress tensor σ1 at the end of the increment. The usual
approach used to write a VUMAT subroutine, because the time increment is very small due to the
explicit time integration scheme, is to use a straightforward evaluation of the equivalent plastic
strain increment ∆ε p without requiring any local iterative algorithm [2, 3].
In this paper a different approach has been chosen and consist in evaluating, in the VUMAT
subroutine, the plastic strain increment ∆ε p using the implicit radial return algorithm presented
in section 2. In order to illustrate the proposed approach and to be able to validate it, the Johnson-
Cook constitutive flow law [4], presented in section 3, has been selected to be implemented into
the Abaqus/Explicit code through both a VUHARD and a VUMAT subroutines. The complete
implementation of the Johnson-Cook elastoplastic constitutive law through a VUMAT subrou-
tine is presented in details in section 4. Numerical efficiency and precision of the proposed
implementation are finally investigated, in section 5, through some dynamic benchmarks tests
and have shown the efficiency and robustness of the proposed integration scheme. Section 5 also
present some alternative constitutive laws results for the Taylor impact test.
Time integration algorithms based on finite difference methods are widely used in finite el-
ement solutions of mechanics. In these algorithms, time is discretized on a finite grid, and the
distance between consecutive points on the grid is defined as the time step ∆t. With the positions
and some of the time derivatives at time t, the integration scheme calculates the same quantities
at a later time t +∆t. Through the iteration of the procedure, the time evolution of those quantities
can be traced.
str = s0 + 2G dev ∆E
h i
(12)
and: h i
p1 = p0 + K tr ∆E (13)
Conforming to equation (5), at time t1 , the yield function f is therefore:
q
f = σtr − σy0 (ε0p , ε0p , T 0 ) (14)
with: r
3
σtr = str : str (15)
2
and σy0 the yield stress of the last equilibrated configuration at the beginning of the current incre-
ment (t = t0 ). In order to know if the predicted trial stress str is admissible or not, a test has to
be performed on the sign of the yield function f leading to the two options here after:
• If f ≤ 0, the whole step is fully elastic, which means that the predicted stress is admissible
and we conclude that s1 = str .
• If f > 0, the trial stress is not admissible and a plastic correction has to be performed in
order to compute the final value of s1 .
The plastic correction is computed enforcing the (discrete) generalized consistency parameter
f (Γ) = 0 at the end of the current increment (so that time t = t1 ):
r
3 q
f (Γ) = s1 : s1 − σy1 (ε1p , ε1p , T1 ) = 0 (16)
2
with:
s1 = str −q2GΓn
ε p = ε0p + 23 Γ
q1
p 1
q
2 (17)
ε = 3Γ
1 ∆t
q
T1 = T0 + η y y
2
3 (σ0 + σ1 )Γ
2ρC p
Combination of equations (16) and (17) leads to the following final form of the consistency
parameter f (Γ): √
f (Γ) = σtr − 6GΓ − σy1 (Γ) = 0 (18)
2.3 Root-finding of the non-linear equation
where the only unknown value is the scalar Γ, already defined in equation (11). If one assume
here a linear hardening of the material during the time-step, as usually done thanks to the explicit
integration scheme used in Abaqus/Explicit, the following analytical solution to equation (16)
can be written, as proposed for example by Gao et al. [2] or the Abaqus manual [3]:
r y
3 σtr − σ0
Γ= (19)
2 3G + h
with h = dσy0 /dε0p , the slope of the hardening law at the current point, assumed to be constant
during the time increment ∆t. This approach is usually adopted in VUMAT implementations
because of its simplicity as this later doesn’t require any iteration to solve the proposed problem.
Unfortunately, as it will be presented further, this lead to many instabilities because of the ap-
proximation proposed by this approach when the non-linear terms of the constitutive flow law
becomes important. In our approach, we have therefore chosen to solve equation (18) using an
approach similar to the one presented in Zaera et al. [13], the so called root finding methods used
to solve equation (11) will be presented in section 2.3.
Once the correct final value of the plastic corrector Γ has been obtained, the final values of the
deviatoric part of the stress tensor s1 and the updated internal variables are computed thanks to
equations (17). At the end of the proposed algorithm, the final stress at the end of the increment
is computed using the following equation:
σ1 = s1 + p1 1 (20)
evaluation of the function f (x) itself and not its derivative f ′ (x) as in other methods such as the
Newton-Raphson. Therefore, this method can become competitive when the computation of the
derivative of the function f (x) becomes long to compute; i.e. when the expression of f (x) is
complex.
1
x = 2
(x0 + x1 )
(
x1 = x if f (x). f (x0 ) < 0
x0 = x if f (x). f (x0 ) > 0
′
∆x = − f (x)/ f (x)
x ← x + ∆x
Yes
x ∈ [x0 , x1 ]
No
1
∆x = (x1 − x0 )
2
x = x0 + ∆x
No
|∆x| < εNR
Yes
Return x
partial derivative based on the hardening flow law of the material. However, for most yield
functions, it may be difficult to obtain derivatives using the analytical method. Therefore, in
such cases, we propose here after a numerical solution as an alternative. This numerical solution
is obtained by adding a small increment to the equivalent plastic strain, plastic strain rate and
y y y
temperature respectively in order to calculate the three partial derivatives ∂σ
∂ε p
, ∂σqp and ∂σ
∂T in
∂ε
equation (25):
q q
∂σy σy (ε p + ∆ε p , ε p , T ) − σy (ε p , ε p , T )
= (26)
∂ε p ∆ε p
q q q
∂σy σy (ε p , ε p +∆ ε p , T ) − σy (ε p , ε p , T )
q = q (27)
∂ εp ∆ εp
q q
∂σy σy (ε p , ε p , T + ∆T ) − σy (ε p , ε p , T )
= (28)
∂T ∆T
q
Of course, accurate results depends on a correct choice for the three increments ∆ε p , ∆ ε p
and ∆T . In all following numerical tests, the three increments have been arbitrary fixed to the
same value ∆x = 10−6 .
3 Hardening flow law
and the dependence on temperature σyT (T ) is defined so that, if T < T 0 there is no temperature
dependence of the yield stress and if T ≥ T m the material is assumed to behave like liquid:
y m
σT (T ) = 1 − TTm−T
−T
0
0
if T 0 ≤ T ≤ T m
y
σT (T ) = 1 if T < T 0 (32)
σy (T ) = 0
if T ≥ T m
T
Those two conditions defined by equations (31) and (32) lead to some discontinuities in the
q q
hardening relation σy (ε p , ε p , T ), its derivative h(ε p , ε p , T ) and the yield function itself resulting
in numerical difficulties in the iterative solving procedure. The yield function is therefore not
q
differentiable at ε0 and T 0 . Nevertheless, the robust Newton-Raphson procedure proposed in
section 2.3.2 has been found sufficiently robust to overcome those problems. Analytical forms
3.2 VUHARD implementation in Abaqus/Explicit
q
for the derivatives of the Johnson-Cook flow law σy with respect to ε p , ε p and T are given by the
three following equations:
∂σy pn−1 y p
q
= nBε σ ( ε )σyT (T ) (33)
∂ε p
q
ε
y q q
pn
y p
∂σ C
∂ε pq = q A + Bε σ T (T ) if ε ≥ε0
εp
y
q q (34)
∂σqp = 0 if ε p <ε0
∂ε
n
−m A+Bε p m
y
q
y p
∂σ ) TTm−T
= σ ( ε 0
if T ∈ [T 0 , T m ]
∂T T −T 0 ε
q −T 0 (35)
∂σy = 0
∂T if T < [T 0 , T m ]
n−1
The last problem usually encountered is that, because of the term nBε p in equation (33), h
tends to infinity when the first plastic increment occurs (i.e. when ε p = 0). Therefore, we will
have to apply a special treatment in the hardening parameter computation on the first plastic step.
This will be presented further in section 4.3.
All details concerning the implementation of the radial return mapping algorithm using a
Fortran VUMAT subroutine for the Johnson-Cook flow law are detailed in this section. The
detailed flowchart algorithm is illustrated in Figure 2. The first block of the proposed algorithm
“Start of VUMAT” is used to get the material properties defined as user material constants.
Abaqus/Explicit provides the user subroutine VUMAT the quantities defined here after:
• The strain increment ∆E for the current time step,
• The stress tensor σ0 and the temperature T 0 at the beginning of the current increment,
• The time increment ∆t corresponding to the current time step,
• A table of solution dependent state variables (SDVs) used to store important data such as
q
ε p , ε p , Γ and transfer them from one increment to the other.
Start of VUMAT
No
p0 = 1
3 tr [σ0 ]; s0
= σ0 − p0 1
h i
End of VUMAT
p1 = p0 + K tr ∆E
str = s0 +q2G dev ∆E
h i
2 str : str
3
σtr =
No
σtr > σy0
Yes
σ
Γ = Γ0 ; Γmin = 0; Γmax = √ tr
6G
q
ε1p = ε0p + 2
Γ
q q 3
p 1 2
ε1 = ∆t 3 Γ
T 1 = T 0 + √6ρCη
(σy0 + σy1 )Γ s1 = str
p
q σy1 = σy0
σy1 = σy1 (ε1p , ε1p , T 1 ) Γ = 0
√
f (Γ) = σtr − 6GΓ − σy1 (Γ)
′ √ dσy1 (Γ)
f (Γ) = − 6G − dΓ
′
∆Γ = − f (Γ)/ f (Γ)
(
Γmax = Γ if f (Γ) < 0
Γmin = Γ if f (Γ) > 0
Γ ← Γ + ∆Γ
Yes
Γ ∈ [Γmin , Γmax ]
No
∆Γ = 12 (Γmax − Γmin )
Γ = Γmin + ∆Γ
No
|∆Γ| < εNR
Yes
n = ksσtrk
s1 = str − 2GΓn
σ1 = s1 + p1 1
1
e1 = e0 + 2ρ (σ0 + σ1 ) : ∆E
ω1 = ω0p + √16ρ (σy0 + σy1 )Γ
p
End of VUMAT
The VUMAT subroutine must compute and return the value of the stress σ1 and the SDVs
variables at the end of the increment for each integration point. The internal and dissipated
energies have also to be evaluated in order to compute the temperatures in the model.
The computed stress σ1 will be discarded after the end of the package step.
• If σtr ≤ σy0 , the plastic corrector is zero, so the plastic correction steps can be skipped. We
assume that the predicted stress is the final one s1 = str , the plastic corrector Γ = 0, the
yield stress remains unchanged σy1 = σy0 and we can go directly to the final computations
in section 4.4.
• If σtr > σy0 , the step is at least partly plastic and the plastic corrector described in section
4.3 has to be computed in order to draw back the predicted stress onto the yield surface of
the material at the end of the current increment.
ε0p = 0), as we cannot compute the value of h(Γ) when the plastic strain is zero, we initialize Γ
to an initial value different of zero (Γ = 10−8 ). The interval for the bisection part is initialized
h √ i q
so that Γ ∈ 0, σtr / 6G . The predicted equivalent plastic strain ε1p , plastic strain rate ε1p and
temperature T 1 at the end of the increment are computed thanks to the system of equations (17).
The yield stress σy1 , the yield function f (Γ) and its derivative f ′ (Γ) are then computed. Then, we
test the convergence of the Newton-Raphson algorithm by computing the increment ∆Γ of the Γ
parameter:
f (Γ)
∆Γ = − ′ (39)
f (Γ)
and comparing it to the Newton-Raphson precision εNR defined by the user:
• If ∆Γ > εNR we need to iterate to compute the correction of the Γ value using the following
relation:
Γ ← Γ + ∆Γ (40)
′
and re-evaluate the values of f (Γ) and f (Γ).
• If ∆Γ ≤ εNR we have obtained the final value of the Γ parameter.
The final deviatoric part of the stress tensor s1 is computed from the predicted value str and the
correction term Γ using:
s1 = str − 2GΓn (41)
with n, within the framework of the radial return algorithm, defined by:
n= p
str (42)
str : str
4.4 Final computations
The main work of the final computations is to update the state variables (SDVs) and the en-
ergies. The final stress tensor at the end of the increment σ1 is computed from the hydrostatic
pressure p1 and the deviatoric part of the stress tensor s1 thanks to equation (20). The equivalent
q
plastic strain ε1p , equivalent plastic strain rate ε1p and final temperature T 1 at the end of the incre-
ment are stored in their respective SDVs variables for subsequent re-use in the next increment.
We also have to compute the new specific internal energy e1 from:
1
e1 = e0 + (σ0 + σ1 ) : ∆E (43)
2ρ
and the dissipated inelastic energy ω1p from:
1
ω1p = ω0p + √ (σy0 + σy1 )Γ (44)
6ρ
At this point, the VUMAT subroutine comes to an end. At this point of the flowchart, the
final temperature is not computed, since the software uses a subsequent thermal step to evaluate
the temperature raise due to the dissipated inelastic energy and the conduction part. The internal
energy is modified during this thermal step and this seems to be taken into account during this
extra step (out of the VUMAT subroutine) since the tests on 1 element with imposed displacement
of all nodes gives the exact same results as the Build-in routine.
Table 1: Material properties of the 42CrMo4 steel
E ν A B C
(Gpa) (MPa) (MPa)
206.9 0.29 806 614 0.0089
q
n m ε0 T0 Tm
(s−1 ) (°C) (°C)
0.168 1.1 1 20 1540
ρ λ Cp η
(kg/m3 ) (W/m°C) (J/Kg°C)
7830 34.0 460 0.9
In this section, the performance of the Johnson-Cook law programmed in the VUMAT sub-
routine is compared with the performance of the Abaqus/Explicit Built-In Johnson-Cook law and
of the VUHARD Johnson-Cook implementation, in order to validate the proposed implementa-
tion approach. The benchmark tests consist of two different one element tests (tensile test and
shear test), the necking of a circular bar and the well known Taylor impact test. The same mate-
rial, a 42CrMo4 steel, has been selected for all those tests, and material properties are reported in
Table 1. The proposed benchmarks are using the “Dynamic Temperature-displacement, Explicit”
procedure of Abaqus explicit FEM code. The inelastic heat fraction parameters has been set to its
default value of η = 0.9. This thermomechanical coupling option allows heat to be generated by
plastic dissipation or viscoelastic dissipation. No other thermal boundary conditions are applied
i.e. a globally adiabatic situation.
All benchmarks tests have been solved using Abaqus/Explicit v.6.14 on a Dell Precision
T7500 computer running Ubuntu 16.04 64bits with 12Gb of Ram and two 4 core E5620 Intel
Xeon Processors. All computations have been done using the double precision option of Abaqus,
with one CPU and the VUMAT and VUHARD subroutines have been compiled using the Intel
Fortran 64 v.14 compiler. The following models have been tested for each of the four presented
benchmarks:
• A-N-R model: VUMAT model with Newton-Raphson procedure and an analytical com-
putation of the derivatives using equations (33-35).
• N-N-R model: VUMAT model with Newton-Raphson procedure and a numerical compu-
tation of the derivatives using equations (26-28).
• Direct model: VUMAT model with a direct evaluation of Γ using equation (19) as pre-
sented in other papers [2].
• VUHARD model: Only the Johnson-Cook constitutive flow law defined by equation (29)
and its three analytical derivatives (33-35) have been implemented using a FORTRAN
subroutine.
Figure 3: Numerical models for the one element tensile and shear tests
Tests have also been done using the Bisection method, but we have made the choice to omit them
in this section to reduce the number of results because those results are very closed to the A-N-R
model but computing time is 10% to 30% longer than the A-N-R and the N-N-R models. At this
point, it has to be noted that, Abaqus/Explicit doesn’t use the same objective stress rate when
using the Built-In implementation and the VUMAT subroutine. As reported in documentation
[1] and confirmed by our own tests based on a one element hyperelastic shear test, a Jaumann
rate is used for both the Built-In formulation and the VUHARD subroutine while a Green-Naghdi
rate is used for the VUMAT subroutine. Therefore, a straightforward comparison of Built-In and
VUMAT results is not possible when large rotations occur.
L/3
6.413 6.350
L=26.67
Figure 4: Numerical model for the necking of a circular bar
PEEQ SDV1
(Avg: 75%) (Avg: 75%)
+2.157e+00 +2.179e+00
+1.980e+00 +2.000e+00
+1.804e+00 +1.822e+00
+1.627e+00 +1.643e+00
+1.450e+00 +1.465e+00
+1.274e+00 +1.286e+00
+1.097e+00 +1.108e+00
+9.205e-01 +9.294e-01
+7.439e-01 +7.509e-01
+5.672e-01 +5.725e-01
+3.906e-01 +3.940e-01
+2.140e-01 +2.155e-01
+3.735e-02 +3.708e-02
Figure 5: Equivalent plastic strain ε p contourplot for the necking of a circular bar
5.3 Taylor impact test
Figure 6: Von Mises stress σ vs. displacement for the necking of a circular bar
tion is reported. The smoother variation of the time increment, and greatest values, are obtained
with both versions of Newton-Raphson, leading to the minimal number of increments to com-
plete the simulation. Using the Built-In model and the VUHARD model, a reduction of the stable
time increment from ∆t = 6.5 10−8 s to ∆t = 5.2 10−8 s is noticed after a displacement of 2.52 mm,
while using the Direct method, a large reduction of the stable increment to ∆t = 3.4 10−8 s with
some residual oscillations is encountered after a displacement 2.03 mm. The time increment us-
ing both versions of the Newton-Raphson model is constant up-to a displacement of 3.36 mm and
reduces smoothly after this point because of the striction of the specimen. During the last third
of the simulation time increments of the N-R models are almost equal to the one of the Built-In
model and the VUHARD model.
From those results we can conclude that the integration of the constitutive equation has an
influence on the stable time increment ∆t. We can also note, from the results reported in Table
2 that, using the VUMAT Newton-Raphson doesn’t increase a lot the total computational time
(around 10% more time in this case) as the total number of increments has been reduced by a
factor of 3.8%. We can also note that the VUMAT subroutine is faster than the VUHARD sub-
routine. Of course, computational cost of the VUMAT model can be reduced by optimizing the
FORTRAN routine (removing the numerous number of tests inside the subroutine, optimizing
the computations and the mathematical expressions, ...). It has also to be noted that the requested
precision for the Newton-Raphson subroutine εNR = 10−8 has also an influence on the computa-
tional time, reducing it reduces also the computational time.
Figure 7: Time increment ∆t vs. displacement for the necking of a circular bar
3.2
32.4
Figure 8: Model of the Taylor impact test
cylindrical specimen is launched to impact a rigid target with a prescribed initial velocity. The
numerical model, reported in Figure 8 is established as axisymmetric. The height is 32.4 mm
and the radius is 3.2 mm. The axial displacement is restrained on the right side of the specimen
while the radial displacement is free (to figure a perfect contact without friction of the projectile
onto the target). A predefined velocity of Vc = 287 m/s is imposed on the specimen. The mesh
consists of 250 CAX4RT elements (5 × 50 elements). The total simulation time for the Taylor
impact test is t = 8.0 10−5 s.
Figure 9 shows the equivalent plastic strain contourplot of the deformed rod for two models:
the Built-In model (left side) and the N-N-R model (right side). The distributions of the equiva-
lent plastic strain are almost the same for both models. The maximum equivalent plastic strain ε p
is located into the center element of the model (the red element in Figure 8) and the models give
quite the same value as reported in Table 3 for ε p , T and the final dimensions of the specimen
L f (final length) and D f (final diameter of the impacting face). Figure 10 shows the evolution of
the equivalent plastic strain ε p with time for the different models for the element at the center of
the impacting face (the red element in Figure 8). As reported in this figure and according to the
results presented in Table 3, all models give almost the same results.
It can be noticed from this later that the Direct model (i.e. the classic way to program a
VUMAT subroutine assuming that the explicit time integration scheme allows to use a straight-
forward evaluation of the plastic strain) doesn’t provide results in accordance with the other
models concerning the internal fields and the final geometry of the specimen. This tends to prove
that if one wants to perform an inverse characterization of material constitutive parameters for
dynamic applications based on a Taylor impact test and a FORTRAN VUMAT subroutine for
implementing an exotic constitutive law, this can be source of errors in the identification of the
constitutive equation parameters.
PEEQ SDV1
(Avg: 75%) (Avg: 75%)
+1.797e+00 +1.810e+00
+1.647e+00 +1.659e+00
+1.498e+00 +1.508e+00
+1.348e+00 +1.357e+00
+1.198e+00 +1.206e+00
+1.048e+00 +1.056e+00
+8.985e-01 +9.049e-01
+7.488e-01 +7.541e-01
+5.990e-01 +6.032e-01
+4.493e-01 +4.524e-01
+2.995e-01 +3.016e-01
+1.498e-01 +1.508e-01
+0.000e+00 +0.000e+00
Figure 9: Equivalent plastic strain ε p contourplot for the Taylor impact test
Figure 10: Equivalent plastic strain ε p vs. time for the Taylor impact test
32.4
3.2
x y
a very good correlation of the results concerning geometric dimensions, whereas the results in
terms of deformation and temperature (very localized results on a very constrained element) dif-
fer due to a better taking into account of the constitutive law by the VUMAT subroutine (this has
been confirmed by refining the mesh). Similar to the results established in section 5.2 concern-
ing the necking of a circular bar, the T/I ratio is again increased by about 15% for the different
versions of the VUMAT subroutines, whereas the overall increase in CPU time is only about 5%
due to the reduction of the total number of increments required for simulation by about 10%.
Concerning the VUHARD approach, the increase in the T/I ratio is around 10% with approxi-
mately the same number of required increments as the Built-In method, leading to a total CPU
increase of about 10% also. This proves again the efficiency of the proposed VUMAT algorithm.
• Calamaz et al. [20] proposed the so called TANH constitutive law by adding a term mod-
eling the strain softening to the Johnson-Cook constitutive law, given by:
1
σy = σ JC [D + (1 − D) tanh( )] (45)
ε p + ε0
with: !q !
pε p T − T0
D=1− p tanh (46)
1 + pε T rec − T 0
in which σ JC represents the original Johnson-Cook constitutive law. The constant ε0 can
modulate the strain corresponding to the peak stress, p and q are the additional constitutive
law parameters, and T rec is the onset temperature for the strain softening phenomenon.
• Hor et al. [21] proposed later a constitutive law by modifying the TANH constitutive law,
given by:
q
σy = σε p (ε p , T )σT (T )σ qp (ε p , T ) (47)
ε
where:
pn
p
1
σ ε p (ε , T ) = A + Bε [D + (1 − D) tanh( ε p +ε 0
)]
T −T
m2
σT (T ) = 1 − m1 T −T
0
q m 0
qp ! (48)
p
ε
σεqp (ε , T ) = 1 + C(T ) ln q
ε0
with:
pε p T − T0
! C1 exp C2 TTm
D=1−( ) tanh and C(T ) = (49)
1 + pε p T rec − T 0 T
T m
5.5 Discussion on the benchmarks
and A, B, C1 , C2 , m1 , m2 , n and p are the constitutive law parameters. As with the TANH
model, the constant ε0 can modulate the strain corresponding to the peak stress and T rec is
the onset temperature for the strain softening phenomenon.
• The last constitutive law we have implemented using the VUMAT subroutine is the one
proposed by Bäker [22, 21] and given by:
q
p
1 + C ln ε f (T )
pn0 f (T )
y
σ = Aε q (50)
ε0
with: " !m #
T
f (T ) = exp − (51)
Tm
q
where A, n0 and m are the temperature-dependent material parameters, and C and ε0 are
constants.
The 2D model used for the simulation is the same as the one introduced in Section 5.3.1. The
material used in this case is the 42CrMo4 steel with ferrito-perlitic (referred to as 42CrMo4-FP).
The parameters of the four constitutive laws for 42CrMo4-FP steel were proposed by Hor et al.
[21]. The predefined velocity is set to Vc = 200m/s. The equivalent plastic strain contour-plots
of the deformed rod for the four models are shown in Figure 12.
The plastic deformation is concentrated at the bottom, and maximum equivalent plastic strain
is located in the center element of the specimen. More details concerning the total number of
increments, total computing time, maximum equivalent plastic strain ε p , final length L f , final
radius R f of the bottom and maximum temperature T are reported in Table 5. The results of the
Johnson-Cook and TANH models are almost identical. Compared with the previous two models,
the modified TANH model achieves larger equivalent plastic strain at the bottom, and corre-
spondingly it also achieves larger final radius and higher temperature at the bottom. However, as
we can see, this model has less plastic deformation in the other part. No matter in terms of the
maximum equivalent plastic strain and temperature or in terms of the geometric responses, the
Bäker model has the least plastic deformation. Concerning the Direct approach, it can be seen
that this one usually overestimates the plastic deformation and the temperature for the tree first
models. In terms of global results, the three first models give almost the same results, while the
Bäker model gives quite different results with regards to the previous ones.
• The Johnson-Cook constitutive law implemented through the VUMAT subroutine doesn’t
have exactly the same expression as the Abaqus/Explicit Built-In model because the de-
pendence on the deformation rate has been modified in our implementation as discussed
before in section 3. This can be seen in the Bar Necking benchmark where the VUHARD
and the Built-In models doesn’t provide exactly the same results.
5.5 Discussion on the benchmarks
• The Jaumann stress rate is used for the Built-In model and the VUHARD subroutine while
the VUMAT routine employs the Green-Naghdi stress rate. This can cause differences in
the results in large deformations models when finite rotation of a material point is accom-
panied by finite shear [1].
6 Conclusions
In this paper, an approach has been proposed for the implementation of elastoplastic con-
stitutive laws in Abaqus/Explicit through VUMAT subroutine. The proposed implementation
is robust and efficient, and can be applied to simulate the behavior of various materials defined
by any elastoplastic constitutive model following J2 plasticity and isotropic hardening. In the
proposed algorithm, an implicit time integration scheme based on the radial return method is
employed, which is unconditionally stable and can ensure that the von Mises yield criterion is
always satisfied during computation. Validated through numerical benchmarks, a robust and
efficient root-finding method, the so-called safe version of Newton-Raphson method, has been
implemented to compute the plastic corrector term.
This algorithm can now be re-used by only changing the expression of the flow law in order
to implement alternative constitutive law, such as the revised form of the Johnson-Cook law
proposed by Rule et al. [16], or any other one of the same family. Applications of this kind of
developments mainly concerns inverse identification of constitutive law parameters based on a
dynamic impact tests, or programming of alternative constitutive laws in Abaqus/Explicit. The
proposed implementation has been found more precise with regards to other kind of VUMAT
or VUHARD routines based on a direct evaluation of the plastic strain rate in order to provide
accurate results for the identification procedure.
Acknowledgements
This work is partly supported by the scholarship from China Scholarship Council (CSC)
under Grant CSC N°201406290010.
References
[1] Abaqus v. 6.14 documentation, Dassault Systemes Simulia Corporation.
[2] C. Gao, Fe realization of a thermo-visco-plastic constitutive model using vumat in abaqus/explicit program, in:
Computational Mechanics, Springer, 2007, pp. 301–301.
[3] Abaqus v. 6.14 user subroutines reference guide, Dassault Systemes Simulia Corporation.
[4] G. R. Johnson, W. H. Cook, A constitutive model and data for metals subjected to large strains, high strain rates
and high temperatures, in: Proceedings of the 7th International Symposium on Ballistics, Vol. 21, The Hague, The
Netherlands, 1983, pp. 541–547.
[5] S. Nemat-Nasser, On finite deformation elasto-plasticity, International Journal of Solids and Structures 18 (10)
(1982) 857–872.
[6] M.-H. Yu, Generalized plasticity, Springer Science & Business Media, 2006.
[7] G. I. Taylor, H. Quinney, The latent energy remaining in a metal after cold working, Proceedings of the Royal
Society of London. Series A, Containing Papers of a Mathematical and Physical Character 143 (849) (1934) 307–
326.
[8] J. C. Simo, T. J. R. Hughes, Computational inelasticity, Springer, 1998.
[9] M. L. Wilkins, Calculation of elastic-plastic flow, Tech. rep., Alder, B. (Ed.), Methods in Computational Physics,
Vol. 3. Academic Press, pp. 211-263 (1963).
[10] G. Maenchen, S. Sacks, The tensor code, in methods of computational physics, 3, 181-210. b. alder, s. fernback
and m. rotenberg editors (1964).
[11] F. Dunne, N. Petrinic, Introduction to computational plasticity, Oxford University Press New York, 2005.
[12] J.-P. Ponthot, Unified stress update algorithms for the numerical simulation of large deformation elasto-plastic and
elasto-viscoplastic processes, International Journal of Plasticity 18 (1) (2002) 91–126.
[13] R. Zaera, J. Fernández-Sáez, An implicit consistent algorithm for the integration of thermoviscoplastic constitutive
equations in adiabatic conditions and finite deformations, International journal of solids and structures 43 (6) (2006)
1594–1612.
[14] F. S. Acton, Numerical methods that work, Maa, 1990.
[15] W. H. Press, Numerical recipes 3rd edition: The art of scientific computing, Cambridge university press, 2007.
[16] W. K. Rule, S. Jones, A revised form for the johnson–cook strength model, International Journal of Impact Engi-
neering 21 (8) (1998) 609–624.
[17] L. Schwer, Optional strain-rate forms for the johnson cook constitutive model and the role of the parameter epsilon
0, in: Proceedings of the 6th European LS-DYNA Users Conference, Anwenderforum, Frankenthal, Germany,
2007.
[18] G. Jansen van Rensburg, S. Kok, Tutorial on state variable based plasticity: an abaqus uhard subroutine.
[19] G. I. Taylor, The testing of materials at high rates of loading, Journal of the institution of civil engineers 26 (8)
(1946) 486–519.
[20] M. Calamaz, D. Coupard, F. Girot, Numerical simulation of titanium alloy dry machining with a strain softening
constitutive law, Machining Science and Technology 14 (2) (2010) 244–257.
[21] A. Hor, F. Morel, J.-L. Lebrun, G. Germain, Modelling, identification and application of phenomenological consti-
tutive laws over a large strain rate and temperature range, Mechanics of Materials 64 (2013) 91–110.
[22] M. Bäker, Finite element simulation of high-speed cutting forces, Journal of Materials Processing Technology
176 (1) (2006) 117–126.