Weld Joints FEA
Weld Joints FEA
Weld Joints FEA
1446
INTRODUCTION
The use of the Finite Element Method (FEM) in product development is now well established, however, its use in manufacturing processes is not very common and is part of the field
of new applications in computational mechanics. The most important reason for this development is the industrial needing to improve productivity and quality of products and to have better
understanding of the influence of different process parameters. The modeled phenomena play
an important role at various stages of the production of steel parts, for example, welding, heat
treatment and casting, among others.
The importance of these applications lies in determining the evolution of stresses and deformations to predict, for example, susceptibility to cracking and thus prevent failures during
manufacturing or even service. Furthermore, this simulation tool can be used to optimize some
aspects of manufacturing processes.
Welding is defined by the American Welding Society (AWS) as a localized coalescence of
metals or non-metals produced by either heating of the materials to a suitable temperature with
or without the application of pressure, or by the application of pressure alone, with or without
the use of filler metal (Mackerle, 2004). Welding techniques are one of the most important and
most often used methods for joining pieces in industry. Any information about the shape, size
and residual stress of a welded piece is of particular interest to improve quality.
The analysis of welding processes involves several branches of Physics, and requires the
coupling of different models addressed to describe the behavior of a phenomenological system.
Many of these models have been implemented numerically and are being used in an efficient
way to solve the problems on an individual basis.
In the arc welding process, the energy required for metal fusion is produced by Joule effect.
This effect produces the energy required to melt the base and filler metal, forming what is known
as the liquid pool. The piece surface temperature varies from 1700 K to 2500 K, depending on
the material. In the liquid pool, convective effects take place, what improve the heat transport
in the base metal. Finally, after removing the heat sources, the metal solidifies.
During the process, temperature changes in the alloy produce solid state transformations.
These microstructural transformations cause changes in the material properties during the evolution of the process. Heating and cooling induce localized volumetric changes. The thermal
strains that occur in the vicinity of the welding zone are elastoplastic and the resulting stresses
react causing permanent distortions.
Distortions introduce residual deformation that complicates the assembly of welded structures and reduces their quality. Also, in certain applications, this distortion may bring the structure useless .
The article is organized as follows. First in Section 2 we describe briefly the coupled thermomechanical problem. In Section 3 and 4 we describe the developed model for the thermal and
mechanical problems, their hypotheses and the equations involved and also the discretization
procedure to obtain the set of equations in both fields. Finally in Section 6 the stress distribution
in a butt-welded joint is modeled as an application example.
2
1447
THERMAL PROBLEM
1448
3.1
Problem definition
Under the assumptions of incompressibility, negligible viscosity and dissipation, linear dependence of the heat flux on temperature gradient (Fouriers law), and no melt flow during the
solidification process, the energy balance for each subdomain i is governed by the classical
energy balance equation
H
(T ) = q
t
(x, t) i
(1)
where T denotes the temperature, H the enthalpy (per unit volume), = (T ) the material
thermal conductivity, assumed isotropic and q = q(x, t) is the welding volume heat input (to be
defined later in Section (3.4) in the context of welding analysis). Equation (1) is supplemented
by the following initial condition
T = T0
x i ,
t = t0
at T
at q
at c
(2)
(3)
(4)
(5)
(6)
1449
where T is a constant value (equal to the melting temperature for isothermal solidification, and
either the solidus or liquidus temperature otherwise), hi denotes the jump of the quantity () in
crossing the interface , which is moving with speed u in the direction given by the unit vector
. Note that the second equation states the jump energy balance at the interface.
In order to retrieve T as the only primal variable, enthalpy is defined as
Z T
cd + Lfl
(7)
H(T ) =
Tref
being c and L the unit volume heat capacity and latent heat, respectively, and Tref an arbitrary
reference temperature; fl is a characteristic function of temperature, called volumetric liquid
fraction, defined as
if T < Tsol
0
if Tsol T Tliq
0 flm (T ) 1
(8)
fl (T ) =
1
if T > Tliq
where Tsol and Tliq denote the solidus and liquidus temperatures, respectively, i.e., the lower
and upper bounds of the mushy temperature range.
3.2
First, the weak or variational form of the balance equation (1) is derived , supplied by the
boundary conditions (2-6), using the weighted residuals method. The proper choice of weighting functions together with the application of Reynolds transport theorem allows to cancel the
terms arising from the interface conditions (6). Furthermore, using the definition (7), a weak
temperature-based form of the governing equation is obtained:
Z
Z
Z
Z
T
W c
dV +
W Lfl dV +
W T dV +
W q dS +
t
t
q
Z
Z
+
W henv (T Tenv ) dS
W q dV = 0
(9)
c
N
X
Ni (x, y, z)Ti
(10)
being Ti the temperature at each node i (i = 1, 2, , N ) arising from the discretization of the
analyzed domain .
We substitute T by its approximation (10) into equation (9). Then we adopt as weighting
function W the interpolation function N (W Ni , Galerkin method). A non linear system of
N ordinary differential equations is set, stated in matrix form as
=C
L
T
+
+ KT F = 0
t
t
(11)
where T is the vector of unknown nodal temperatures, C the capacity matrix, L the latent heat
vector, K the conductivity (stiffness) matrix and F the external flux vector.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1450
Z
Li =
Lfl Ni dV
Z
Z
Ni Nj dV +
henv Ni Nj dS.
Kij =
(12)
qNi dV
(13)
The transient conduction problem in the absence of phase change has been widely discussed
in the classic finite element literature (see e.g. Zienkiewicz and Taylor (2000)).
We follow the discontinuous integration scheme given in Fachinotti et al. (1999, 2001) that
allows us to solve exactly the integrals (12) in a relatively easy manner.
3.3
Solution scheme
Time integration is done with the unconditionally stable first-order backward Euler method.
This implicit scheme is applied on equation (11), which leads to a set of non-linear equations
to be solved for the values of the temperatures at finite element nodes, at the end of the time
increment considered:
n+1 = Cn+1
Tn+1 Tn Ln+1 Ln
+
+ Kn+1 Tn+1 Fn+1 = 0
t
t
(14)
The solution of the highly non-linear discrete balance equation (14) is achieved by means of
the well-known Newton-Raphson method.
At each new iteration i, is approximated using a first order Taylor expansion,
(T (i) ) (T (i1) ) + J(T (i1) ) T (i) = 0
(15)
being J = d /dT the Jacobian or tangent matrix of the equation system (14), and T (i) =
T (i) T (i1) the incremental correction of temperatures. Thus, T can be evaluated as follows:
T (i) = [J(T (i1) ) ]1 (T (i1) )
(16)
The Newton-Raphson scheme is efficient provided that the initial guess T (0) lies within the
convergence radius of the solution T . Alternatively, the convergence can be improved using a
line-search procedure.
Verification of the model has been performed comparing numerical and analytical results
for a transient non-linear heat transfer problem with exact solution. This problem was solved
exactly by zisik and Uzzell (1979) and the numerical results, in agreement with the corresponding analytical ones are reported in Anca et al. (2004)
.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
3.4
1451
The moving heat source is implemented as a typical transient formulation where the heat
source moves along the part with time. In order to model the heat source the three-dimensional
double ellipsoid proposed by Goldak et al. (1984) as shown in Figure 3 is studied. One characteristic of the double ellipsoid geometry is that it can be easily changed to model both the
shallow penetration arc welding processes and the deeper penetration laser and electron beam
processes. The heat flux distribution is Gaussian along the longitudinal axis. The front half of
the source is a quadrant of one ellipsoidal source while the rear half is a quadrant of another
ellipsoidal source. Four parameters define each ellipsoid. Physically, they correspond to the dimensions of the molten zone. Knowing the cross-section of the molten zone from experiment,
the heat source parameters can be determined. As a first approximation, Goldak et al. (1984)
assume that it is reasonable to take the distance in front of the source equal to one half of the
weld width and the distance behind the source equal to twice the weld width.
In order to simulate arc heating effects the equivalent heat input is assumed as a constant
internal heat generation per unit volume.
It is convenient to introduce a coordinate, , fixed on the heat source and moving with it. The
moving reference frame on the heat source is related to the coordinate fixed on the work piece
by:
= z v(t )
(17)
where v is the welding speed and is the time lag necessary to define the position of the heat
source at time t = 0. The weighting fractions associated with the front and rear ellipsoids are
denoted by ff and fr , respectively, and these fractions are specified to satisfy ff + fr = 2.
Let us denote q the power density in W/m3 within the ellipsoid, and let a , b and c denote the
semi-axes of the ellipsoid parallel to the x, y, axes. Then, the power density distribution inside
the front quadrant, is specified by
6 3ff Q
x2
y2
2
q(x, y, ) = (
) exp(3 2 ) exp(3 2 ) exp(3 2 )
(18)
a
b
cf
abcf
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1452
6 3ff Q
x2
y2
2
q(x, y, ) = (
) exp(3 2 ) exp(3 2 ) exp(3 2 )
a
b
cr
abcr
(19)
In these equations, Q is the heat available at the source. For an electric arc the heat available
is
Q = V I
(20)
where is the heat source efficiency, V is the arc voltage, and I is the arc current. The parameters a, b, cf and cr are independent, and can take different values for the front and rear quadrants
of the source, to properly model the weld arc. One characteristic of this model is that start and
stop effects of the heat source can be taken into account.
The spatial distribution of heat is calculated from equations (18) and (19) and is applied as a
volumetric heat generation.
3.5
Verification
In order to verify the developed moving heat source model, a 3D finite element model of a
thick plate was generated. Because of symmetry, one half of the welding plate was meshed.
Figure 4 shows the problem geometry used in the 3D FEM analysis.
The model uses the same heat source distribution and material properties as those in Goldaks
work and are summarized in tables 1, 2 and 3.
Arc Parameter Symbol
Value
Current
I
1170
Voltage
U
32.9
Efficiency
0.95
Total Heat
Q
36538.35
Speed
v
5
Unit
A
V
W
mm/s
1453
Parameter Value
a
20
b
20
cf
15
cr
30
ff
0.6
fr
1.4
Unit
mm
mm
mm
mm
Parameter
Symbol Value
Density
7200.0
Specific Heat, (solid)
cs
680.0
Specific Heat, (liquid)
cl
680.0
Latent Heat
L
291660
Conductivity (solid)
s
34.0
Conductivity (liquid)
l
2s
Solidus temp.
Tsol
1774
Liquidus temp.
Tliq
1763
Initial temp.
T0
283
Unit
[kg/m3 ]
[J/kg o K]
[J/kg o K]
[J/kg]
[W/mo K]
[W/mo C]
[o K]
[o K]
[o K]
Figure 5 plots the top surface temperature distribution along the x axis 11.5 seconds after the
arc has passed. The numerical results we have computed are compared with the experimental
test of Christensen et al. (1965).
2000
Current (FEM)
Crhistensen (Experimental)
Temperature [C]
1500
1000
500
0.01
0.02
0.03
0.04
Distance [m]
Figure 5: Comparison of the present model solution with Christensen experimental results.
MECHANICAL PROBLEM
During a thermal welding process, the weld site and immediate surrounding area experience
different rates of heating/cooling and thus expansion/contraction. This effect leads to considCopyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1454
erable thermal strains. Due to the heat application localized nature, the expansion due to these
strains is constrained by the cool material away from the site of the applied heat. The physical and chemical properties of the material also change at the weld site and heat affected zone
(HAZ), both during and after the welding process. These changes affect mechanical material
properties, and must be taken into account in the mechanical analysis.
Due to the intrinsic three-dimensional nature of loads, boundary conditions and geometry
usually involved in welding processes, a 3D mechanical model was implemented. It should be
noted that the weld pool itself is not modelled in the mechanical analysis. This is only a soft
region serving as a mean for heat input to the thermomechanical model. In this sense, the use of
a cut-off or zero-strength temperature, ZST , was assumed. This is also the temperature above
which no further changes in material properties are accounted for in the mechanical analysis.
The thermoelastic material behavior is, for most cases, based on a hypoelastic version of
Hookes law with inclusion of thermal strains. The Youngs modulus and the thermal dilatation
coefficient, are the most important parameters. Poisson ratio has a smaller influence on the
residual stresses and deformations (Tekriwal and Mazumder., 1991). The plastic material model
used for solidified metal was a rate-independent model with an associative J2 von Mises law and
isotropic hardening. The argument for using rate-independent plasticity at high temperatures is
based on the involved time scales (Lindgren, 2001). In the weld thermal cycle the material has
a high temperature during a relatively short time, and therefore the accumulated rate-dependent
plasticity may be neglected.
Inertial effects are ignored in momentum balance equations, according to the assumption of
null acceleration within the solid.
4.1
Melting-Solidifying Behavior
It is recognized that finite element techniques, with standard constitutive material modelling,
yield good solutions in thermal stress analysis, even when the solid is subjected to temperatures near the solidification ones. However, there are particular aspects in the formulation for
melting/solidifying problems that need to be carefully considered.
Three different configurations for every material point and its neighborhood (Figure 6) are
considered for the mechanical simulation of this process:
i) the reference configuration (B), in which the particle label is assigned;
ii) the (intermediate) natural configuration (B 0 ) which corresponds to that state where the material point solidified just below the zero strength temperature (ZST), and started to develop
mechanical strength;
iii) the current configuration (B t ).
1455
Figure 6: Reference (B), natural (B 0 ) and current (B t ) body configurations in the melting/solidification problem.
Note that, since the solidification time instant is not the same one for all points in the domain
of analysis, each material point has its own (intermediate) natural configuration.
Defining uo as the displacement from the reference to the natural configuration, ut the displacement from the reference to the current configuration and u the displacement from the
natural to the current configuration, one can write:
ut = u + uo
(21)
Usually, when a finite element procedure is used, the mesh is defined in the reference configuration (the set of points at time t = 0) as depicted schematically in Figure 6.
Let us consider that X and xo are coordinate systems in the reference and natural configurations, respectively. As a consequence of the assumption of small deformations introduced to
describe motion, and by assuming the existence of the intermediate deformation gradient in the
neighborhood of every point, one has: X xo 1.
I The same assumption allows us to evaluate
sym
the strain = xo u, related to the motion from the natural to the final configurations, by the
following approximation:
sym
= sym
(22)
xo u X u
By taking gradients in equation (21) and using the assumptions stated above, we can verify the
validity of the additive decomposition of strains:
t = + o
(23)
t
where t = sym
X u is the strain tensor at the actual configuration (time t) with respect to the
o
reference configuration, and o = sym
X u is the strain at the natural configuration with respect
to the reference one.
1456
Stresses in the solid shell are directly related to the mechanical strains through the constitutive material law.
In order to test the formulation we selected a standard elastoplastic model, based on the
classical J2 theory with isotropic hardening (Simo and Hughes, 1998) and the von Mises yield
criteria.
We remark that for a correct representation of the steel constitutive behavior in the zone of
interest, it is mandatory to account for the strong dependence of the material parameters on
temperature.
1457
Remarks:
The strain o is computed the first time that all nodal temperatures of the considered
element fall below the zero strength temperature (ZST), and is stored at the finite element
Gauss point as an additional tensorial internal variable. The Zero Strength Temperature is
defined as the minimum temperature amongst those at which strength is zero (Nakagawa
et al., 1995). In this work ZST is set iqual to the metal solidus temperature.
In this model, the solid phase domain changes with time. This fact introduces some difficulties concerning the mesh definition for the FE analysis. The procedure we have implemented consists in defining a fixed mesh that describes the complete domain, including
the liquid and mushy zones. Nodes in the liquid and mushy zones are initially fixed. In
subsequent time steps, when the nodal temperatures fall below the ZST, nodal d.o.f.s are
freed and the stiffness contribution of the solidified zone is taken into consideration (see
Figure 7).
The described numerical model does not predict the real displacement field inside the
solid phase, because the displacement field of the natural configuration is not recorded.
The technique of subtraction of the strain term o from the total strain t must be emphasized for its simplicity and accuracy. Stress computations based on total strain without
subtraction of the initial strain o , give completely unrealistic results, a fact that may be
verified by comparison with results obtained by using the semi-analytical formulation
of Weiner and Boley (1963). Note also that this approach is less expensive than those
used by other authors based on recording the flow strain for liquid elements (Abid and
Siddique, 2005; Yaghi and Becker, 2004).
All elements internal variables, included the o strain, are set to zero as soon as the element temperature rises above ZST.
Mechanical elements have a special treatment during the liquid/solid and solid/liquid
phase changes: while the temperature is above the ZST, the corresponding elemental
d.o.f.s are not included in the system of equations for the unknowns of the mechanical problem. This methodology incorporates an advantage compared to other techniques found in literature (e.g. assigning a very low stiffness to the elements that are
in liquid/mushy phases, brings poor conditioning of the algebraic equation system to be
solved).
To avoid restructuring the stiffness matrix each time step, liquid mechanical d.o.f.s are
decoupled from the rest by zeroing the corresponding rows and columns, and putting
a non-zero term in the diagonal entry of the stiffness matrix. Also, the corresponding
position in the residue is zeroed.
Figure 8(a) shows the initial stiffness matrix distribution when all domain is solid. Figures
8 (b), (c) and (d) show an increase in the decoupled rows as the solid domain decreases
its size.
1458
4.2
According to the local state theory (Lematre and Chaboche, 1994), at a given instant t the
thermodynamic state at any particle X of a material medium is completely defined by the values
of a certain number of state variables at this particle. Computations on inelastic materials take
advantage of strain-driven formulations, in which state variables are the strain and a set of
phenomenological internal strain-type variables describing material history, together with the
temperature field T here assumed to be known a priori.
Linear kinematics is assumed. Then, the total strain can be additively decomposed as follows:
= e + i ,
(24)
e being the thermoelastic (reversible) strain and i the inelastic (irreversible) strain. Either
term may play the role of an internal variable, but i is typically chosen (option followed in this
work).
We also adopt a scalar internal variable , which characterizes isotropic hardening from the
phenomenological point of view. The hypothesis of isotropic hardening is widely accepted in
welding applications (Lindgren, 2001; Francis and Rahman, 2000; Chang and Teng, 2004).
Furthermore, the adopted hardening parameter is the equivalent inelastic strain:
Z tr
2 i
=
k ( )k d,
(25)
3
0
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1459
where is the inelastic strain rate and k k = iij iij its L2 -norm.
Although driving variables lie in the strain space, response functions (i.e. the yield criterion
and the evolution laws) are usually written in terms of their conjugated thermodynamic forces:
the stress tensor (dual of e ) and the isotropic hardening variable in stress space, R = R().
The stress tensor depends on and i through the decomposition (24). For linearly-elastic
isotropic materials, the stress is defined by the state law:
i
= [ tr (e ) 3T her ] 1I + 2 dev(e ),
{z
}
| {z }
|
m
s
(26)
with T as the linear thermal expansion coefficient and Tref an arbitrary reference temperature.
The von Mises criterion is defined:
r
2
f = ksk
[Y + R()] ,
(28)
3
with Y denoting the initial yield stress and R() the hardening relation .
Associated to this yield criterion, the following J2 flow rule is considered:
i = n,
(29)
being n = s/ksk the normalized stress deviator defining the normal to the Von Mises yield
surface f = 0 in the deviatoric-stress space, and 0 the consistency parameter. For plastic
materials, is determined by means of the consistency condition
f = 0.
(30)
Finally, having chosen the equivalent inelastic strain as hardening variable, the flow rule (29)
completely defines the hardening law:
r
r
2 i
2
k k =
.
(31)
=
3
3
4.3
Following Simo and Hughes (1998), the evolution laws (29) and (31) are discretized using
the implicit Euler-backward finite-difference scheme. Then, given the total strain increment
at the particle X during the time interval [tn , tn+1 ], tn+1 = tn + t, the material state at X
is updated from the previous instant tn to the current one tn+1 by a standard return-mapping
algorithm.
The consistent tangent stiffness matrix was implemented. The correct evaluation of this
matrix is essential to achieve good numerical response in the determination of equilibrium condition.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1460
4.4
(32)
(33)
(34)
These lead to the standard quasi-static boundary value problem in solid mechanics (Hughes,
1987) which consists in finding the displacement field u that satisfies the integral equations
Z
Z
Z
s
: wdV =
b wdV +
t wdS,
(35)
s
s,t
throughout the domain s , for all the admissible displacement weighting functions w.
Equation (35) is the weak form of the momentum balance equations (32), where b is the
body-force (per unit volume) and t is the traction prescribed over the portion s,t of the boundary (displacement boundary conditions over the complementary portion s,u are assumed to
hold a priori).
The displacement trial functions are defined as follows:
u=
nu
X
Ni Ui
(36)
i=1
being Ni the displacement shape function associated to the node i = 1, 2, . . . , nu , being Ui the
nodal displacement
After replacing u in (35) by its respective finite element approximation (36), and by adopting
the shape functions as weight functions (Galerkin formulation), it yields
R = Fint Fext = 0,
(37)
where
Z
Fint =
B T (u) dV
(38)
Z
Fext =
N b dV +
s
N T t dS
(39)
s,t
Beimg B the typical finite element matrix defining the strain-displacement kinematics relation
t = BU .
The nonlinear system of equations (37) is solved iteratively, approximating this system at the
i-th iteration using a linear Taylor expansion
R(U (i) ) R(U (i1) ) + J(U (i1) ) U (i) = 0
(40)
where J = dR/dU is the Jacobian or tangent matrix, and U (i) = U (i) U (i1) is the search
direction. Iterative correction of variables is defined by:
U (i) = [J(U (i1) ) ]1 R(U (i1) )
(41)
As described for the thermal problem, this Newton-Raphson scheme is complemented with
line-search procedures to accelerate the convergence.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1461
4.4.1
Incompressible material behavior may lead to some difficulties in numerical simulation, such
as volumetric locking, inaccuracy of solution, checkerboard pattern of stress distributions, or
occasionally, divergence. Mixed u-p elements are intended to overcome these problems. Mixed
u-p elements use both, displacements and hydrostatic pressure as primary unknown variables.
The standard quasi-static boundary value problem in solid mechanics, stated in mixed u-p
form (Hughes, 1987), consists in finding the displacement field u and the mean-stress field p
that satisfy the integral equations
Z
Z
dev grad w dV +
Z h
Z
p div w dV =
tr (M )
b w dV +
pi
q dV = 0,
t w dS,
(42)
(43)
throughout the domain , for all the admissible displacement and mean-stress weighting functions w and q, respectively.
Equation (42) is the weak form of the momentum balance equations, where b is the bodyforce (per unit volume) and t is the traction prescribed over the portion of the boundary
(displacement boundary conditions over the complementary portion u are assumed to hold a
priori).
The displacement and mean-stress trial functions are defined as follows:
u=
nu
X
Ni Ui = N U ,
(44)
Np j Pj = Np P ,
(45)
i=1
np
p=
X
j=1
(46)
R2 = KpT U Mp P = 0,
(47)
1462
where
Z
B T dev dV + Kp P ,
Z
Z
T
N b dV +
N T t dS,
Fext =
Z
Kp =
B T 1N
I p dV,
Z
1 T
Mp =
Np Np dV,
Fint =
(48)
(49)
(50)
(51)
(52)
In the above equations, symmetric second order tensors like the stress deviator dev and the
unit tensor 1I are mapped into vectors as usually done in the finite element practice, and B is the
typical finite element matrix defining the shape functions derivative.
If the material is only nearly incompressible and the pressure variables are considered on
the elemental level only then the pressure terms can be statically condensed out and solved for
displacements only.
As pointed out by Cifuentes and Kalbag (1992); Benzley et al. (1995), hexahedral elements
are superior to linear tetrahedral elements, and also better than quadratic tetrahedron elements
when plastic deformation occurs, and therefore we used q1 p0 hexahedral elements to do the
tests.
The discrete equilibrium equations are solved by using a standard Newton-Raphson method.
The Jacobian matrix corresponds to that obtained from an equivalent purely Lagrangian elastoplastic quasi-static incremental problem (see for instance Simo et al. Simo and Hughes (1998)).
4.5
The thermal stress calculated by the finite element model developed in the present work has
been compared with the semi- analytical solution developed by Weiner and Boley (1963) for
thermal stresses during one-dimensional solidification of a semi-infinite elastic-perfectly plastic
body after a sudden decrease in surface temperature.
The thermal problem they solved corresponds to the Neumanns classical one, a phase change
1D problem with uniform initial temperature Ts (solidification temperature) and fixed temperature Tw < Ts on one end, being T o = Ts Tw defined as the temperature drop.
They took an elastic-perfectly plastic material model for the mechanical problem, with a
constant Young modulus E and yield stress y varying linearly with temperature:
y(T ) = yo
Ts T
To
T Ts
(53)
T o Cp
p = 2 Ks ; Ks =
;
( 2 1);
(54)
Cp
2L
The thermal diffusivity (Ks ) is the ratio of conductivity () to density () and specific heat (Cp ),
while L is the latent heat.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1463
y
y
T Ts
T =
To
(1 )yo
(1 )
(1 )y
=
; y =
= mT ; m =
T ET o
T ET o
T ET o
where T is the thermal expansion coefficient and the Poisson ratio.
x
z
Figure 10: Finite element model for the 1-D numerical validation test.
The problem has been solved in a prismatic domain using the finite element procedure
described in subsection 4.4, and imposing Extended Plane Strain (EPS) conditions (x =
constant z = constant) along transversal directions z and x, to be consistent with the original
hypothesis proposed by Weiner et al.
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1464
The FE mesh consists in hexahedral elements, as shown in Figure 10. The EPS conditions are
imposed via Lagrange multipliers, constraining all nodal x- and z-displacements to be identical.
0.05
0
FEM
Exact
0.05
= 0.465; m = 0.097
0.1
0.2
0.4
0.6
0.8
Figure 11: Stress distribution along the y-coordinate. Comparison of semi-analytical (Weiner and Boley, 1963)
and numerical solutions.
Figure 11 compares the semi-analytical results with the numerical ones. The curves plot the
non-dimensional stress component
xx (=
zz ) along the non-dimensional y-line (longitudinal
direction) for m = 0.097 and = 0.465. The agreement of the numerical FE solution with the
semi-analytical one is evident from the figure.
It should be noted that this semi-analytical solution gives a maximum tensile (compressive)
stress which is constant in time. This behavior is due to the particular thermal boundary conditions adopted (which correspond to a similarity solution) in the mentioned semi-analytical
study.
5
SOLUTION SCHEME
Due to the weak nature of mechanical to thermal field coupling, the non-linear transient
analysis is divided in two parts.
First, thermal analysis is performed to predict the temperature history of the whole domain,
and then it is applied as input for the subsequent structural analysis.
The coupling is organized using a staggered scheme, where for every time step the thermal problem are solved first, and then the mechanical problem is solved using as inputs the
temperature obtained previously, as shown in Figure 12.
Algorithm 1 shows the global calculation scheme. At the time being, a fixed time step is
specified.
1465
5.1
As pointed out in Section 4 hexahedral finite elements are used to solve the mechanical
problem. In the other hand, the thermal problem is solved using tetrahedral elements.
In order to share the same nodes in both problems, first a mesh of hexahedra for the mechanical model is generated. Then by splitting each hexahedron in six tetrahedra, as depicted in
Figure 13, the thermal finite element mesh is obtained.
6
6.1
APPLICATION EXAMPLES
Residual Stresses in Fusion Welding
Residual stresses associated with thermal welding processes are of particular importance
because they are frequently the same order of magnitude than yield stresses. Fatigue failure of
welded structures occurs usually at the weld site, along or adjacent to the weld toe. Residual
stresses and strains may also approach yield magnitude in the transverse direction to the weld.
1466
The magnitude of the residual stresses and their distribution depends on numerous factors,
including the type of welding, number of passes, material properties and degree of constraint
during the process. Material that is rigidly constrained will have greater residual stresses than
one that is allowed to distort during the process.
During a thermal welding process, the weld site and immediate surrounding area experience
different rates of heating/cooling and thus expansion/contraction, and this leads to large thermal strains. Due to the heat application localized nature, the expansion due to these strains is
constrained by the cooler material away from the site of the applied heat.
A stress parallel to the direction of the weld bead is called longitudinal residual stress, denoted by the letter z . The longitudinal residual stress arises due to longitudinal expansion and
contraction during welding. Along the weld line, a high tensile residual stress arises near the
weld toe, and then decreases to zero, finally becoming compressive, as distance from the weld
line on the flange increases.
A stress normal to the direction of the weld bead is known as a transverse residual stress,
denoted by the letter x . A tensile residual stress is produced at the surface of the specimen
near the weld and decreasing close to zero as the distance from the weld toe increases.
6.2
Butt-welded Plates
In this example a butt-welded plate is presented with length, width and thickness respectively
equal to L = 500mm, W = 500mm, th = 6mm. A 3-dimensional symmetrical model was
used to estimate the residual stresses of the butt-welded joint using the finite element method.
The material properties used in the model correspond to a CMn steel. The plate is clamped
in the corners opposite at the site to the welded line. Natural convection in top and bottom
surfaces of the plate is assumed, with a heat transfer coefficient of 45 [ mW2 K ].
The welding parameters are summarized in table 4 and 5.
Arc Parameter Symbol Value
Current
I
250
Voltage
U
23
Efficiency
0.825
Total Heat
Q
4743.75
Speed
v
4.8
Unit
A
V
W
mm/s
The symmetric model has 3750 elements and 6000 nodes after meshing.
1467
Unit
mm
mm
mm
mm
6.2.1
Simulation results
The process takes about 100 s to complete the weld. After extinguishing the arc, cooling of
the weldment takes about 35 min to return to the ambient temperature. The time stepping has
a minimum time step of 0.5 s during welding. The complete analysis has taken about 14 hs of
CPU, on a Intel Core2 1.86 GHz processor.
The temperature results (Figure 14) shows that because of the locally concentrated heat
source, the temperature near the weld bead and heat-affected zone rapidly changes with the
distance from the centre of the heat source.
Related to the residual stresses, Figures 15 and 16 show calculated longitudinal (z ) and
transverse (x ) stresses. The behaviour is analogous to that found in the literature. As expected
the maximum residual stress is produced near the heat affected zone. The longitudinal normal
component of stress is in the order of the yield stress.
7
CONCLUSIONS
In the present article finite element models have been used to analyze the thermal and mechanical phenomena observed in welding processes. Thermal histories and residual stresses
Copyright 2008 Asociacin Argentina de Mecnica Computacional http://www.amcaonline.org.ar
1468
5 108
2.5 108
2.5 108
x (0, th/2, z)
z (0, th/2, z)
5 10
0.1
0.2
0.3
0.4
0.5
4 108
3 108
2 108
x (x, th/2, L/2)
1 108
0
1 108
2 108
0.05
0.1
0.15
0.2
0.25
1469
1470
Lematre J. and Chaboche J. Mechanics of Solid Materials. Cambridge University Press, 1994.
Lindgren L.E. Finite element modeling and simulation of welding. part 2: Improved material
modeling. J. Thermal Stresses, 24(3):195231, 2001.
Mackerle J. Finite element analysis and simulation of welding-an addendum: a bibliography
(1996-2001). Modelling Simul. Mater. Sci. Eng., 10:295318, 2004.
Nakagawa T., Umeda T., Murata J., Kamimura Y., and Niwa N. Deformation behavior during
solification of steels. ISIJ Int., 35(6):723729, 1995.
zisik M. and Uzzell J. Exact solution for freezing in cylindrical symmetry with extended
freezing temperature range. Journal of Heat Transfer, 101:331334, 1979.
Simo J. and Hughes T. Computational Inelasticity. Springer-Verlag, New York, 1998.
Tekriwal P. and Mazumder. J. Transient and residual thermal strain-stress analysis of gmaw.
ASME J. of Engineering Materials and Technology, 113(336-343), 1991.
Weiner J. and Boley B. Elasto-plastic thermal stresses in a solidifying body. J. Mech. Phys.
Solids, 11:145154, 1963.
Yaghi A. and Becker A. State of the art review - weld simulation using finite element methods.
Technical report, University of Nottingham, UK, 2004.
Zienkiewicz O. and Taylor R. The Finite Element Method, volume 1: The Basis. ButterworthHeinemann, 5th. edition, 2000.