Finite Element Simulation of Solidification Problems
Finite Element Simulation of Solidification Problems
Nomenclature
c = heat capacity TL = liquidus temperature
C = capacitance matrix To = initial temperature
f = time function T~ = solidus temperature
F = loading term x = space coordinates
h = heat convection coefficient a = interface heat transfer coefficient
H = specific enthalpy 3' = iteration parameter
[ J[ = Jacobian determinant F = boundary of domain
[ J[ = patch approximation to [ J I 8T = solidification range
k = thermal Conductivity At = timestep magnitude
K = conductance matrix V = vector gradient operator
L = latent heat e = convergence tolerance
= unit outward normal 0 = timestepping parameter
N~ = nodal shape function 0 = known vector in alternating-direction
q = known heat flux formulation
R/ = nodal heat capacity X = Laplace modifying parameter
S = phase change interface (~, ~ ) = local space coordinates
t = time P = density
T = temperature ~ = time limit
= known boundary temperature q~(~) = shape function factor
T = vector of nodal temperatures +(~) = shape function factor
Ta = ambient temperature a = domain of interest
Tc = solidification temperature
62 R.W. Lewis and P.M. Roberts
1. Introduction
The growing use of computational modelling techniques in recent years
reflects the potential economic benefits they offer to many industrial processes,
including casting methods in the foundry. Numerical simulations of the
thermal, and mechanical, behaviour of both castings and moulds, will permit
designers to create robust, effective products, whilst simultaneously minimis-
ing process costs and waste. To achieve a practical simulation package, a heat
transfer analysis program is required at the core of an overall flexible CAD
system, incorporating pre- and post-processing graphics and other geometric
modelling tools. With such a system the designer can reliably predict hot spots
which could result in shrinkage porosity; alterations in geometric configura-
tion or to process parameters will eliminate such risks and ensure directional
solidification in advance of any casting being poured. The desired mechanical
properties of the finished casting can be controlled by predicting, via numeri-
cal experimentation, the effects of using differing mould materials and the
placement of various chills and/or cooling lines. Waste associated with risers
can be significantly reduced by optimising their magnitude and location.
This paper focusses on the mathematical model which is the basis of the
numerical heat transfer analysis program. The development of a non-linear
heat conduction simulator which uses the finite element method is presented.
Finite elements are employed because of their facility in modelling complex
domain configurations, and handling of non-linear boundary conditions. For
completeness some details of the discretisation process are given together with
a brief description of the mathematical model, i.e. differential equation and
boundary conditions, involved.
Various timestepping methods are considered for use in conjunction with
the Galerkin semi-discrete weighted residual form of the differential equation,
and the treatment of the non-linear terms which arise is also discussed. The
representation of latent heat effects is an important feature in the modelling of
solidification problems. The tracking of the phase change boundary is an
important numerical problem, which is resolved in our work by use of the
enthalpy method which incorporates latent heat in a smooth manner.
Techniques for improving the efficiency of the simulation program are then
looked at, including an alternating-direction implicit, and a 'mixed'
implicit/explicit solution algorithm coupled with a direct profile solver. A
quadratic conductivity approximation is also presented which speeds up
matrix generation.
A crucial component in simulating casting solidification is the handling of
the heat transfer at the interface between the mould and the metal, a critical
process parameter acutely affecting the solidification ratel The heat transfer
coefficient can vary in response to type and thickness of die coat, to the
pressure, temperature and cooling rate of the metal, and due to the formation
of an air gap. A coincident node technique is illustrated for dealing with the
air gap problem. A short description of an infinite element approach for
representing heat losses to an external medium is also given.
Finite element simulation of sofidification problems 63
I I A
H= forpc dT (10)
or
dH
p c - dT" (11)
Then Eq. (1) (or Eq. (5)) becomes
V" (k V T ) = _Td__d_~H
_• (12)
or
V - (k V T ) =/~r. (13)
Thus in Eq. (11) we are only solving for temperature; the front tracking
problem has been 'removed', and the latent heat L will be included in the
definition of enthalpy H (see below).
2.2.1. Spatial discretisation. The finite element method has been chosen to
discretise the domain f] in space, rather than by using finite differences, on the
basis of its inherent flexibility in handling complicated shapes and boundary
conditions. Thus the domain 62 (2- or 3-dimensional) is divided up into
distinct regions or elements ~2e such that
M
U ~e=~.
e=l
Nodal points are then distributed at element vertices, along the element
edges, and possibly in the element interiors, as in Fig. 2. The usual element
Finite element simulation of solidification problems 65
<ZZ22
Fig. 2. Schematic discretisation of general domain into finite elements.
where N~ are the basis, or shape functions and T~ the nodal temperatures.
Substituting this approximation into the Galerkin weighted residual form of
the differential equation, Eq. (12), we obtain the semi-discrete system
CT + KT = F (15)
where T is the vector { T/} of unknown nodal temperatures. The capacitance
matrix C, the conductance matrix K, and the thermal loading term F are
defined as follows:
dH
c,, = £-a-f u,u, d a (16)
values at t". Other values for 0 can of course be used, 0 = 2 has been
recommended, having been derived from finite element timestepping - where
the time domain is notionally discretised by 'shape' functions in the time
'direction'. Values of 0 >/½ lead to an unconditionally stable scheme - i.e.
errors in the solution do not grow, but for 0 < 1 the time step magnitude, At,
must be kept within the Courant limit - proportional to the element size and
diffusion term k, and inversely proportional to the capacitance term Oc or
(dH/dr).
The '0-method' has been used extensively in the examples to be presented
later, but other algorithms have been investigated during the development of
the heat conduction program [2,3]. These includes the three level scheme of
Lees [4], which can be expressed as
c +x =r
2 At 3
or
(20)
The three-level recurrence relation (20) solves for T at t n+2, given two
previous values T "+1, T n. It is unconditionally stable, but requires some form
of start-up e.g. by use of the above two level scheme, or by using T 1 = T o and
a very small initial timestep (the use of different timesteps At between
t" --* t "+1 and t "+1 --* t "+2 requires some modification to Eq. (20)). Although
stable, our experience has shown that solutions exhibited oscillatory, 'noisy'
behaviour - this was, however, considerably attenuated by redefining T ~ in
equation (20) to be the average [3]
(r + r o+ r
3
Another timestepping algorithm which has been utilised is that of a Laplace
modified scheme [5], used in conjunction with the finite element alternating-
direction method [2,6,7]. More details regarding the solution strategy of the
alternating-direction technique will be given below. However, it is pertinent to
include the Laplace modified algorithm in this section on timestepping proce-
dures. Applied to Eq. (12), a first order Laplace-modified algorithm, within a
Galerkin weighted residual form, gives
= - A t £ dHk-/dT'VT n. v N I J I d £ (21)
68 R.W. Lewis and P.M. Roberts
2.2.3. Nonlinear problems. Although tacitly assumed, our notation so far has
ignored the possible dependencies of the coefficients k, p, c, H on the
independent variables space, time and temperatures. Thus Eq. (12) should be
written as
dH
V" (k(x, t, T) V T ) = -d-~(x, t, T). T. (22)
Variations in space and time do not present any special difficulties - apart
from discontinuities. More serious, however, is the dependence of the coeffi-
cients k, (dH/dT) on the actual solution, i.e. the temperature distribution.
We are faced with the problem of how to determine the coefficients, i.e. what
temperature values should be used. The matrix problem is given by (ignoring
spatial/temporal coefficient dependencies)
C(T)I"+ K ( T ) T = F(T). (23)
Put into the timestepping algorithm given by Eq. (19), we have
[ C ( r ) + O A t x ( r ) ] - r "+' = [ C ( T ) + ( O - 1) AtK(T)]. T" + Ate(T)
(24)
or, simply,
L (T) = P ( T ) T - G(T) = 0. (25)
For such nonlinear problems some form of iterative solution procedure is
required (linear problems can be considered as only requiring one iteration!).
Taking a truncated Taylor series expansion of Eq. (25) we obtain the well
known Newton-Raphson iteration scheme
{ T~=T"
T~%+~= T• + ATk k = O, 1, 2 . . .
Ark = - ( ~ L ( T ; ) ) - I L ( T ; )
(26)
where k denotes the number of iterations. The 'Jacobian' matrix (or 'tangen-
Finite element simulation of solidification problems 69
The above heat conduction model must take into account the effect of latent
heat if it is to be used to simulate solidification. The latent heat L may be
used to determine the progression of the phase change interface S in the
formulation of the Stefan problem Eq. (5)-(9). As we have noted this
formulation requires some form of sophisticated front tracking algorithm.
However there is a simpler approach we can follow [9]. The latent heat effect
is approximated by a sharp increase in heat capacity within a narrow tempera-
ture range about the solidification point, Tc, as illustrated schematically in Fig.
3. The temperature range ~T from the solidus temperature, Ts, to the liquids
value, TL, can be extremely small so that for many substances the heat
capacity curve oc(T) exhibits a discontinuous Dirac function at To. Since we
are using numerical integration, which is only adequate for relatively smooth
curves, the direct calculation of Oc as a coefficient will lead to very poor
results.
However, the integral of the heat capacity, the physical quantity known as
the enthalpy H, as given by Eq. (10)
H= forOC dT
~:~H /H
/
/
/
/
/
/i
f
/
f
/
f /
I I I >T
%%T.
Fig. 3. Variation of heat capacity and enthalpy near a phase change.
Finite element simulation of solidification problems 71
capacity pc(T) curve. Hence we interpolate for the enthalpy in the same way
as for the temperature, i.e.
N
H = E Ni(x)Hi(t)" (30)
i=l
The enthalpy values are then utihsed in deriving the temperature derivative
(dH/dT) for the integrand of entries in the capacitance matrix, see Eq. (16).
Several averaging techniques have been used to determine this derivative term,
such as
d H _ = 1 _~I{~H
_~_ _ff~_~0T'
(31)
dr 3, v..i / v . . , ,
or
1/2
E (OH/Ox,) 2
dH i=1
, 1/2 "
t2.
3 7"
-f2.
YT,
Fig. 4. Finite element mesh for alternating-direction formulation (a) general region ag, (b)
isoparametric base mesh fL
where
kn
- fu (dH/dT)n V T ~" V N [ J I d~
, O~i , O~i
where Oi = ~ and ~ = -~-~. You will notice that the perturbation term is
necessary to 'complete the square' in the integrand.
Thus,
K=Kx.Ky (39)
74 R.W. Lewis and P.M. Roberts
where Kx, Ky have very narrow band structure - tridiagonal for four-noded
bilinear elements, or pentadiagonal for nine-noded biquadratic elements and
so on. The system given by Eq. (35) may be solved as follows. Firstly O" is
determined at each time step - this involves standard finite element integrals.
Secondly, we solve for v" from K x v ' = D -1/2 AtO n, and then for w" from
Kyw" = v'. Finally we have T "+1 = T" + O-1/Zwn. The solution stages can be
performed rapidly using well known algorithms, and furthermore, K~, Ky are
block structured making for efficient vectorisation. K~, Ky are also time
independent and so need only be constructed once.
The above AD algorithm has been successfully used to solve solidification
problems on relatively simple geometries; but further program development
will enable the potential savings to be realised for quite complex configura-
tions.
Explicit time stepping requires no matrix inversion, and is thus very quick to
operate, but is limited by timesteps constrained by stability criteria. Implicit
schemes, on the other hand, are unconditionally stable and can take quite
large timesteps (but is still first order, 0(At), accurate); however, they require
matrix inversion/factorisation which can be time consuming for problems, as
in three dimensions, which involve large bandwidths. The mixed implicit-ex-
plicit technique, pioneered by Hughes and Liu [11,12], seeks to combine the
advantages of each scheme whilst minimising their deficiencies. Hence, explicit
solution can be carried out cheaply in areas of the domain where the solution
is changing slowly, whereas, to maintain stability, implicit treatment of ther-
mally 'active' regions is required [13].
Taking the first order system given in Eq. (15)
Ci" + K T = F
we can classify the elements of the mesh as being explicit (0 = 0, C 'lumped'
in Eq. (19)) or implicit (0.5 ~ 0 ~< 1.0 in (19)), giving
K = K I + K E]
/
C = (7t + Ce ~. (40)
r=r,+r~ ]
Setting V= T, and /~.+1 as an intermediate nodal temperature vector, we can
express Eq. (16) in the form, for a single element,
C V "+1 + K , T ~+1 + KEir'+ 1 = F "+1 (41)
where
ir "+a = T" + AtV'(1 - 0) (42)
Finite element simulation o f solidification p r o b l e m s 75
and
Tn+l = ~ n + l + Atvn+lo. (43)
Substitution of Eq. (43) into (41) results, after some manipulation, in the form
[ C + AtOKI IT n+ l = [AgO(lN n + l - KE ~n+ l ) + C~/~n+l] . (44)
For an explicit element, i.e. 0 = 0, Eq. (42) becomes
T n+l = T n + A t V n
but from Eq. (16)
v.=c-l[v.-xr.]
and hence
C T "+1 = C T " + A t [ F " - KT"].
This equation is exactly the same given by the predictor of Eq. (27), again with
0 = 0, for Tg + 1. Setting 0 = 0 in Eq. (44) gives
C T n+ l = C # n+ l = C T ~ + t [ F ~ - K T ~ ]
The governing Eq. (1) is nonlinear, and, as we have noted, this necessitates
some form of iterative solution procedure. This requires the re-formulation of
the system matrices C ( T ) and K ( T ) for each iteration due to their tempera-
ture dependence. This is particularly expensive for finite elements since this
would involve, adopting a simplistic approach, costly re-integration of all the
terms of Eqs. (16)-(18).
However, we can partly alleviate this computational burden by making
assumptions about the form of the temperature dependent coefficients -
76 R.W. Lewis and P.M. Roberts
or
c=I(c0R) (46)
where
Co,./= f N / N / d ~ (47)
and R is the vector of heat capacities (derived from enthalpy values H ) . The
matrix Co can be formed once at the start of the problem by numerical
integration; subsequent calculations of the diagonalised capacitance matrix
can be obtained much more rapidly by matrix multiplication as in Eq. (46).
We now apply similar 'group' formulation ideas to the conductance matrix
K ( T ) . Samonds et al. [14] recently put forward a 'quadratic conductivity
approximation' whereby the finite element integrals involving k can be
evaluated initially, with subsequent evaluations of K by matrix multiplication
involving the nodal temperatures.
Hence, we approximate by a quadratic function, i.e.
k ( T ) = a + bT + eT 2 (48)
where a, b, c are material constants. If we ignore the boundary condition
contribution, for clarity, then the integral term which gives us the product
K ( T ) . T in Eq. (15) over a single element becomes
which on substitution of the quadratic form Eq. (48) yields, after some use of
vector operator identities,
b
lke=afuvN" VT d~e+ -~fuevN" v(T2) d~e + ~c £evN" v(T3) d~e.
(50)
Finite element simulation of solidification problems 77
The next simplifying assumption is to interpolate the square and cube of the
temperature onto the same finite element basis as T, i.e.
N N
T2 = E N~T~2, T3 = E N~T~3 (51)
i=1 i=1
which gives us
where
@ ® @ e
i 3 S ; ss }
@) (~)
Fig. 5. Linear dements with common interface (a) standard connections, (b) coincident interface
nodes.
Ke=Ke+faN,(Nj-½N,.)dFz
rz
i, j = l , 2 . . . . N, (55)
Finite element simulation of solidification problems 79
When dealing with external boundaries which are distant from the main area
of interest it is impractical to enmesh the external region with finite elements.
The associated computational overhead would be great even for a truncated
external mesh. A viable alternative is to discretise the entire external region as
if it were of infinite dimension, using 'infinite elements' [16,17] which map the
infinite regions onto the usual prototype domain for numerical integration.
Although perhaps this may be of limited use in casting simulation, it has
important practical applications in many areas, including heat transfer, and
the infinite element technique has been used successfully by the present
authors in the context of heat losses from geothermal or petroleum reservoirs
to the surrounding rock strata [16].
Zienkiewicz et al. [17] put forward an infinite element method based on a
mapping of a semi-infinite region onto [ - 1 , 1 ] " - the usual finite element
domain for Gauss-Legendre integration. The one-dimensional mapping is
schematically illustrated in Fig. 6(a), with a two-dimensional infinite 'strip'
element shown in Fig. 6(b), and its use in conjunction with a finite element
mesh given in Fig. 6(c).
Referring to Fig. 6(a), the one dimensional mapping, which is at the heart
of the mapped infinite element method can be expressed as
or
x=No()xo+N2()x2.
This map transforms the region [xl, x3) (x 3 at infinity) onto the interval
- 1 ~<~ ~< 1 with X 1 = (X 0 -t- X2)/2. Note that N0(~ ) + N2(~) -- 1, and so the
map is not affected by a shift of origin.
This transformation can be easily coupled with existing shape function
mappings (e.g. isoparametric) to derive 'strip' elements of the form illustrated
by Fig. 6(b). It should be noted that all that is required to utilise these infinite
elements into existing finite element programs is some minor modifications to
80 R.W. Lewis and P.M. Roberts
• • •
~3 (20
/
NAP / / /
/ /
/ ./
-I 0 t
(a.?
__ _ _ _ x-~. (~:1)
>~
~ ~l I
rL / i--.
Fig. 6. Infinite elements: (a) one dimensional mapping, (b) strip element, (c) coupling with finite
element mesh.
the routine which calculates the Jacobian matrix determinant for numerical
integration.
5. Numerical examples
In this section we present some of the test problems which have been
simulated using the finite element heat conduction program with its various
Finite element simulation of solidification problems 81
Thus the A D method is 2.5 times faster than the usual timestepping methods,
LEES ALGORITHM
ALTERNATING DIRECTION - - - - - -
CRANK-NICOLSON
-5 "1
t~
-io
l--l
-15
c~
uJ
-20
-25
.,~>x~...
-30
-35
' I ' I , I ' I , I , I ' I '
t, B 12 16 20 24 28
TIME [SECONDS) x 10-I
Fig. 8. Temperature h i s t o r i e s a t p o i n t x = y = 1.
this figure should rise to about 10 for vector processor machines. The above
times are for an ICL 2966 computer, a scalar machine with virtual memory
capability.
The AD algorithm has also been successfully utilised for problems involv-
ing non-rectangular domains; a wedge shaped domain with similar physical
properties and problem definition to the above example has been successfully
simulated [2].
The AD code, however, requires further development to model general
mesh configurations and to cater for three dimensional meshes. An existing
three-dimensional heat conduction program, incorporating the predictor-cor-
rector timestepping scheme, has been amended to investigate the various
procedures for improved casting simulation discussed in the previous section.
To demonstrate the effectiveness of the implicit-explicit method an experi-
mental casting of a tapered slab of aluminum bronze in a resin bonded silica
sand mould was simulated [13]. Table 1 gives the thermal properties of the
metal, where the latent heat figure is a weighted average of the constituent
pure metals. Table 2 gives the properties of the sand mould - two sets of
conductivity curves were investigated. The cross-sectional finite element mesh,
shown in Fig. 9, consists of 56, 8-noded quadratic, isoparametric elements,
with the sand elements shaded. The initial temperature of the molten metal
was 1156 o C, with the initial mould-metal interface set at the liquidus temper-
ature, 1080 ° C. No thermal resistance, i.e. perfect conduction, was assumed at
the interface, and the latent heat was taken to evolve linearly over the
solidification range. The external boundary, of the sand elements, was fixed at
room temperature, 20°C, with the initial temperature being the same
Finite element simulation of solidification problems 83
throughout the sand mould. For the riser, the top boundary was fixed at the
initial metal temperature, 1156 ° , with the sides assumed to be perfectly
insulated.
The initial timestep was taken as 1.0 s, but this was altered by the
predictor-corrector controlling algorithm, with an iteration tolerance of 0.5 o C.
The first run assumed 0 = 7 = ½ (Crank-Nicolson, implicit) for all elements,
and Fig. 10 depicts the movement of the solidus temperature contour (1050 o C)
at 90s intervals, for the high sand conductivity case. The shape and progres-
sion of the solidification front agrees well with physical expectations, even for
the coarse mesh used. A similar numerical experiment on a slab which is not
tapered, as in Fig. 11, shows that a large proportion of the slab solidifies
almost simultaneously, unlike the even progress of the solidification for the
tapered case. This suggests feeding problems in this region yielding shrinkage
porosity, an effect which occurs in practice.
Density, O : 1,444.7 k g / m 3
Conductivity, k ( T ) : (High) 0.6606 - 2.084 × 1 0 - 4 T + 7.741 × 10- 7T2
( J / s i n ° C) (Low) 0.2828-1.681 X 1 0 - 4 T + 1.352 × 10-7T 2
Specific heat, c(T)
Temperature ( ° C) c(J//kg o C)
200 975.7
400 1092.9
600 1151.5
800 1159.9
1000 1176.7
84 R.W. Lewis and P.M. Roberts
The problem was run again, this time making all the sand elements explicit
(0 = 0), i.e. 64% of the mesh is solved by explicit timestepping. When using the
active column profile solver this resulted in a reduction of 40% in the running
time, with little qualitative difference from the results already shown. Thus the
efficiency of the implicit-explicit scheme, coupled with the profile solver, can
provide substantial savings in casting simulation.
The tapered slab problem was solved for once again, but this time employ-
ing the quadratic conductivity approximation to achieve even further processing
time reduction. Figure 12 shows the temperature history profiles, at selected
points along the slab, with consistent capacitance matrices (lumped for explicit
elements) and a piecewise linear determination of k from the set of values
given in Tables 1, 2 at each integration point. Figure 13 shows the same
profiles, but using the quadratic conductivity approximation and the diagona-
lised capacitance technique [14]. There is very close agreement between the
two sets of curves - a maximum difference of only 2%. However the assembly
time of the quadratic approximation case was 46% that of the standard
method, and, since the assembly time makes up 85% of the total solution cost,
Finite element simulation of solidification problems 85
"7
I
I
.q
I
I
7
7
\
\
/
Fig. 10. Tapered slab casting - solidification front history.
thus giving an overall saving of 39% in total processing time. This is for the
predictor-corrector algorithm running in mixed implicit-explicit mode, with
explicit elements in the sand mould.
To demonstrate the three dimensional simulation capability, investigations
were carried out [15] into a production gravity die casting of an aluminium-
silicon-copper alloy (BS.1490 : LM4) with material properties given in Table 3.
u
100(
i!!
V
-- 158
~a 95o:
"~ 900 -116
E 850
-74
800
750 -3z
700
I ;0 ~O0 3'oo' z~O0500
' ;O0 700
. . BOO
. . 900
. . 10001100 12oo
time (St
Fig. 12. Temperature history curves for tapered slab - standard matrix assembly.
Half of the die assembly, with its finite element mesh, is shown in Fig. 14, with
the cast shaded - the internal geometry/mesh of the cast is shown in Fig. 15.
The die composed of Grade 17 grey iron, the material properties for which can
be found in Table 4.
Thermocouples were placed at various positions both in the die and in the
cavity. The resulting temperature histories at these points are given in Fig. 16,
for a melt which was poured at approximately 760 o C.
The finite element mesh consisted of 374 linear brick (8-noded) elements
and 645 nodes. The coincident node method was employed at the interface,
1050
10001
950 : IS8 158
~a
ro 900 116
B50
BOO : ?4
750 2
700 , , , , , , , , , ,
100 200 3'00 400 500 600 700 800 900 1000 1100 1200
time (S)
Fig. 13. Temperature history curves for tapered slab - quadratic conductivity function.
Finite element simulation of solidification problems 87
w i t h a h e a t t r a n s f e r c o e f f i c i e n t a = 5.0 × 10 - 2 c a l / s e c - c m 2- ° C, r e d u c e d a f t e r
19 s e c o n d s b y 75% t o m o d e l t h e f o r m a t i o n o f a n air g a p . A r o u n d t h e r i s e r w e
t o o k a = 3.0 × 10 - 2 c a l / s e c - c m 2- ° C, r e d u c e d a f t e r 25 s e c o n d s b y 60%. T h e s e
v a l u e s w e r e b a s e d u p o n p r e v i o u s e x p e r i m e n t a l a n d c o m p u t a t i o n a l w o r k [15].
...._¢----
J ~
f J
i
J
J
f
f
T h e b o t t o m o f t h e die a n d t h e p l a n e o f s y m m e t r y w e r e a s s u m e d to b e
p e r f e c t l y i n s u l a t e d , w h e r e a s free c o n v e c t i o n was a s s u m e d 'at t h e r e m a i n i n g
e x t e r n a l faces. T h e t e m p e r a t u r e h i s t o r i e s c a l c u l a t e d at t h e t h e r m o c o u p l e
p o s i t i o n s a r e s h o w n in Fig. 17. T h e s e results w e r e o b t a i n e d u s i n g all i m p l i c i t
650.
600 _
I - -
550
oJ
50O . . . . . . . . 18
ro
L
Ig
E 450 18 22 * 20
L~O0 22
350 , , , i i , i i i
0 20 ~0 60 80 100 120
finle IS}
~
650 1
6oo
242 255
l+O0- 242
350 , . . . . . , ,
0 20 40 60 80 100 120
lime (S)
Fig. 1 7. Numerical temperature histories for die casting - standard matrix assembly.
90 R.W. Lewis and P.M. Roberts
650
600
QI
B 500 a61
- 31s
~- /+50 - 46~. ~.2 .'z
I+00 _ 2~2
35O
20 /+0 60 80 100 120
time (S)
Fig. 18. Numerical temperature histories for die casting - explicit time stepping and quadratic
conductivity function.
6. Summary
Acknowledgements
References
1. O.C. Zienkiewicz and K. Morgan: Finite Elements and Approximation, 1st edn., p. 328, John
Wiley & Sons Ltd., New York (1983).
2. R.W. Lewis, K. Morgan and P.M. Roberts: Application of an alternating-direction finite
element method to heat transfer problems involving a change of phase, Numerical Heat
Transfer, Vol. 7 (1984).
3. R.W. Lewis, K. Morgan and P.M. Roberts: Determination of thermal stresses in solidification
problems. In: J.F.T. Pittman, O.C. Zienkiewicz, R.D. Wood and J.M. Alexander (eds)
Numerical Analysis of Forming Processes, Chap. 15, John Wiley & Sons Ltd., (1984).
4. M. Lees: A linear three-level difference scheme for quasi-linear parabolic equations, Math.
Comp. 20 (1966) 516-622.
5. J. Douglas Jr. and T. Dupont: Alternating-direction Galerkin methods on rectangles. In: B.
Hubbard (ed.), Proc. Numerical Solution of Partial Differential Equations, Vol. 2, pp. 133-214,
Academic Press, New York (1977).
6. L.J. Hayes: Implementation of finite element alternating-direction methods on non-rectangu-
lar regions, lnt. J. Numerical Methods in Engineering 16 (1980) 35-49.
7. P.M. Roberts: The development of alternating-direction finite element methods for enhanced
oil recovery simulation, Ph.D. Thesis, University College Swansea, University of Wales,
Swansea (1984).
8. M. Samonds: Finite element simulation of solidification in sand mould and gravity die
castings, Ph.D. Thesis, University College Swansea, University of Wales, Swansea (1985).
9. G. Comini, S. Del Guidice, R.W. Lewis and O.C. Zienkiewicz: Finite element solution of
non-linear heat conduction problems with special reference to phase change, Int. J. Numerical
Methods in Engineering 8 (1974) 613-624.
10. K. Morgan, R.W. Lewis and O.C. Zienldewicz: An improved algorithm for heat conduction
problems with phase change, lnt. J. Numerical Methods in Engineering 12, (1978) 1191-1195.
11. T.J.R. Hughes and W.K. Liu: Implicit-explicit finite elements in transient analysis: implemen-
tation and numerical examples, ASME. J. Appl. Mech. 45 (1978) 375-378.
12. W.K. Lin: Development of mixed time partition procedures for thermal analysis of structures,
Int. J. Numerical Methods in Engineering, 19, (1983) 125-140.
13. M. Samonds, K. Morgan and R.W. Lewis: Finite element modelling of solidification in sand
castings employing an implicit-explicit algorithm. Applied Mathematical Modelling, 9 (1985)
170-174.
14. M. Samonds, R.W. Lewis, K. Morgan and R. Symberlist: Efficient three-dimensional finite
element metal casting simulation employing a quadratic conductivity approximation, Proc.
Fourth lnt. Conf. on Numerical Methods in Thermal Problems, Part 1, pp. 64-77, Pineridge
Press, Swansea (1985).
15. M. Samonds, R.W. Lewis, K. Morgan and R. Symberlist: Finite element modelling of the
mould-metal interface in casting simulation with coincident nodes on thin elements. In: R.W.
Lewis, K. Morgan, J.A. Johnson, W.R. Smith (eds) Computational Techniques in Heat
Transfer, Vol. 1, Pineridge Press, Swansea (1985).
16. R.W. Lewis, K. Morgan and P.M. Roberts: Infinite element modelling of heat losses during
thermal recovery processes, paper SPE 13515, 8th SPE Symp. Reservoir Simulation, Dallas,
Texas (1985).
17. O.C. Zienkiewicz, C. Emson and P. Bettess: A novel boundary infinite element, Int. J.
Numerical Methods in Engineering, Vol. 19, pp. 393-404 (1983).