Fast Solvers For Thermal Fluid Structure Interaction
Fast Solvers For Thermal Fluid Structure Interaction
MARINE 2013
B. Brinkmann and P. Wriggers (Eds)
Key words: Thermal Fluid Structure Interaction, Partitioned Coupling, Fixed Point
methods, Vector Extrapolation
1 INTRODUCTION
Thermal interaction between fluids and structures plays an important role in many ap-
plications. Examples for this are cooling of gas-turbine blades, thermal anti-icing systems
of airplanes [3] or supersonic reentry of vehicles from space [12, 8]. Another is quenching,
1
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
an industrial heat treatment of metal workpieces. There, the desired material properties
are achieved by rapid cooling, which causes solid phase changes, allowing to create graded
materials with precisely defined properties.
Gas quenching recently received a lot of industrial and scientific interest [19, 7]. In
contrast to liquid quenching, this process has the advantage of minimal environmental
impact because of non-toxic quenching media and clean products like air [17]. Furthermore
it is possible to control the cooling locally and temporally for best product properties and
to minimize distortion by means of adapted jet fields, see [15].
To exploit the multiple advantages of gas quenching the application of computational
fluid dynamics has proved essential [1, 17, 11]. Thus, we consider the coupling of the
compressible Navier-Stokes equations as a model for air, along a non-moving boundary
with the heat equation as a model for the temperature distribution in steel.
For the solution of a coupled problem, we use a partitioned approach [4], where different
codes for the sub-problems are used and the coupling is done by a master program which
calls interface functions of the other codes. This allows to use existing software for each
sub-problem, in contrast to a monolithic approach, where a new code is tailored for the
coupled equations. To satisfy the boundary conditions at the interface, the subsolvers are
iterated in a fixed point procedure.
A fast solver is obtained by making use of a time adaptive higher order time integration
method suggested in [2]. Namely, the singly diagonally implicit Runge-Kutta (SDIRK)
method SDIRK2 is employed. Furthermore, it is imperative to reduce the number of fixed
point iterations. Various methods have been proposed to increase the convergence speed
of the fixed point iteration by decreasing the interface error between subsequent steps,
for example Relaxation [10, 9], Interface-GMRES [13] or ROM-coupling [18]. Here, we
consider Aitken Relaxation and two variants of polynomial vector extrapolation, namely
MPE and RRE [16]. These are compared on the basis of the flow past a flat plate, basic
test case for thermal fluid structure interaction.
2 GOVERNING EQUATIONS
The basic setting we are in is that on a domain Ω1 ⊂ Rd the physics is described by
a fluid model, whereas on a domain Ω2 ⊂ Rd , a different model describing a structure is
used. The two domains are almost disjoint in that they are connected via an interface.
The part of the interface where the fluid and the structure are supposed to interact is
called the coupling interface Γ ⊂ ∂Ω1 ∪ ∂Ω2 . Note that Γ might be a true subset of
the intersection, because the structure could be insulated. At the coupling interface Γ,
coupling conditions are prescribed that model the interaction between fluid and structure.
For the thermal coupling problem, these conditions are that temperature and the normal
component of the heat flux are continuous across the interface.
We model the fluid using the Navier-Stokes equations, which are a second order system
of conservation laws (mass, momentum, energy) modeling viscous compressible flow. We
consider the two dimensional case, written in conservative variables density ρ, momentum
2
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
Here, S represents the viscous shear stress tensor and q the heat flux. As the equation
are dimensionless, the Reynolds number Re and the Prandtl number P r appear. The
equations are closed by the equation of state for the pressure p = (γ − 1)ρe. Additionally,
we prescribe appropriate boundary conditions at the boundary of Ω1 except for Γ.
Regarding the structure model, we will consider heat conduction only. For steel, we
have temperature-dependent and highly nonlinear specific heat capacity cp and heat con-
ductivity λ. Thus, we have the nonlinear heat equation for the structure temperature
Θ(x, t)
d
ρ(x)cp (Θ) Θ(x, t) = −∇ · q(x, t), (1)
dt
where
q(x, t) = −λ(Θ)∇Θ(x, t)
denotes the heat flux vector. Here, we use coefficient functions that have been suggested
in [14] to model the steel 51CrV4 and are given by
λ(Θ) = 40.1 + 0.05Θ − 0.0001Θ2 + 4.9 · 10−8 Θ3 (2)
and
e−cp1 (Θ)/10 + e−cp2 (Θ)/10
cp (Θ) = −10 ln (3)
2
with
cp1 (Θ) = 34.2e0.0026Θ + 421.15 (4)
and
cp2 (Θ) = 956.5e−0.012(Θ−900) + 0.45Θ. (5)
For the mass density ρ = 7836 kg/m3 . Finally, on the boundary, we have Neumann
conditions q(x, t) · n(x) = qb (x, t).
3
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
3 DISCRETIZATION
3.1 Discretization in space
Following the partitioned coupling approach, we discretize the two models separately
in space. For the fluid, we use a finite volume method, leading to
d
u + h(u, Θ) = 0, (6)
dt
where h(u, Θ) represents the spatial discretization and its dependence on the tempera-
tures in the fluid. In particular, the DLR TAU-Code is employed [5], which is a cell-vertex-
type finite volume method with AUSMDV as flux function and a linear reconstruction.
Regarding structural mechanics, the use of finite element methods is ubiquitious.
Therefore, we will also follow that approach here and use quadratic finite elements, leading
to the nonlinear equation for all unknowns on Ω2
d
M(Θ) Θ(x, t) + K(Θ)Θ(x, t) = qb (x, t). (7)
dt
Here, M is the heat capacity and K the heat conductivity matrix. The vector Θ consists
of all discrete temperature unknowns and qb (x, t) is the heat flux vector on the surface.
In this case it is the prescribed Neumann heat flux vector of the fluid.
4
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
4 VECTOR EXTRAPOLATION
4.1 Basic fixed point iteration
To solve the coupled system of nonlinear equations (8)-(9), a strong coupling approach
is employed. Thus, a nonlinear fixed point iteration is iterated until a convergence criterion
is satisfied. In particular, we use a a nonlinear Gauß-Seidel process:
(ν+1) (ν) (ν+1)
F(ui , Θi ) = 0 ui (10)
(ν+1) (ν+1) (ν+1)
T(ui , Θi )=0 Θi , ν = 0, 1, ... (11)
Each solve is thereby done locally by the structure or the fluid solver. More specific, a
Newton method is used in the structure and a FAS multigrid method is employed in the
fluid.
(0) (0)
The starting values of the iteration are given by ui = sui and Θi = sΘ i . The
termination criterion is formulated by the nodal temperatures at the interface of the solid
structure and we stop once we are below the tolerance in the time integration scheme
divided by five.
Γ (ν+1) Γ (ν)
kΘi − Θi k ≤ TOL/5. (12)
The vector
Γ (ν+1) Γ (ν)
r(ν+1) := Θi − Θi (13)
5
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
6
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
For RRE, the coefficients are defined as the solution of the constrained least squares
problem
Xν+1
ν+1
X
min
γj rj
, subject to γj = 1. (22)
γj 2
j=0 j=0
5 NUMERICAL RESULTS
As a test case, the cooling of a flat plate resembling a simple work piece is considered.
The work piece is initially at a much higher temperature than the fluid and then cooled
by a constant air stream, see figure 1.
The inlet is given on the left, where air enters the domain with an initial velocity of
Ma∞ = 0.8 in horizontal direction and a temperature of 273 K. Then, there are two
succeeding regularization regions of 50 mm to obtain an unperturbed boundary layer.
In the first region, 0 ≤ x ≤ 50, symmetry boundary conditions, vy = 0, q = 0, are
applied. In the second region, 50 ≤ x ≤ 100, a constant wall temperature of 300 K is
specified. Within this region the velocity boundary layer fully develops. The third part
is the solid (work piece) of length 200 mm, which exchanges heat with the fluid, but is
assumed insulated otherwise, thus qb = 0. Therefore, Neumann boundary conditions are
applied throughout. Finally, the fluid domain is closed by a second regularization region
of 100 mm with symmetry boundary conditions and the outlet.
Regarding the initial conditions in the structure, a constant temperature of 900 K at
t = 0 s is chosen throughout. To specify reasonable initial conditions within the fluid, a
steady state solution of the fluid with constant wall temperature Θ = 900 K is computed.
7
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
Figure 2: Full grid (left) and zoom into coupling region (right)
0 0
10 10
no relax. no relax.
Aitken Aitken
-2 MPE -2 MPE
10 10
RRE RRE
-4 -4
10 10
Residual error
Residual error
-6 -6
10 10
-8 -8
10 10
-10 -10
10 10
-12 -12
10 10
1 2 3 4 5 6 1 2 3 4 5 6
Iteration steps Iteration steps
(a) 1 time step with a time step size of 1 s (b) 1 time step with a time step size of 5 s
Figure 3: Comparison of the relaxation methods for 1 time step with different timestep sizes
The grid is chosen cartesian and equidistant in the structural part, where in the fluid
region the thinnest cells are on the boundary and then become coarser in y-direction (see
figure 2). To avoid additional difficulties from interpolation, the points of the primary
fluid grid, where the heat flux is located in the fluid solver, and the nodes of the structural
grid are chosen to match on the interface Γ.
To compare the effect of the different relaxation strategies on one fixed point iteration,
we consider the first stage of the first time step in the test problem with a time step size
of ∆t = 1s and ∆t = 5s. In figure 3, we can see how the interface residual decreases
with the fixed point iterations. During the first two steps all methods have the same
residual norm. This is because all methods need at least two iterations to start. For this
example, the extrapolation methods outperform the standard scheme for target residual
norms below 10−5 .
We now compare the different schemes for a whole simulation of 100 seconds real time
when we choose different tolerances T OL. When we use a time adaptive algorithm, a
total number of eight time steps is needed to solve the test case problem in 100 seconds.
8
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
18
no relax.
16 Aitken
MPE
RRE
14
12
Fixed point iterations
10
0
0 1 2 3 4 5 6 7 8
Time steps
In figure 4, we see the number of fixed point iterations needed for each time step. The
tolerance was chosen to be T OL = 10−7 . The dynamic relaxation methods needed a
few less iterations. At the beginning of the time adaptive process, all of the methods
started with the same time step size ∆t = 0.5 s. With an increasing time and therefore
an increasing time step size, caused by the adaptive algorithm, the normal (no relaxation)
method needs more fixed point iterations in the end of that time interval, while the other
methods have remained roughly constant. The total number of fixed point iterations is
shown in tabular 1. As we can see, the extrapolation methods have an advantage over the
normal (no relaxation) method for a tolerance of 10−7 . For T OL = 10−4 , all the methods
need roughly the same number of iterations, which is also confirmed in Figure 3, where
all methods overlap at 10−4 .
9
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
6 CONCLUSIONS
We considered a thermal fluid structure interaction problem where a nonlinear heat
equation to model steel is coupled with the laminar compressible Navier-Stokes equations.
The coupling is based on a Dirichlet-Neumann coupling. To obtain a fast solver, a higher
order time adaptive method is used for time integration and different vector extrapolation
techniques, namely Aitken Relaxation, MPE and RRE were compared for a test problem.
It turns out that for this simple problem, there is not much difference between the
schemes for large tolerances, since the fixed point iteration terminates too quickly for
the extrapolation schemes to make a difference. For tighter tolerances, the extrapolation
schemes save 20% of iterations. Future work is on testing these schemes on more realistic
examples.
REFERENCES
[1] A. L. Banka. Practical Applications of CFD in heat processing. Heat Treating
Progress, (August), 2005.
[3] J. M. Buchlin. Convective Heat Transfer and Infrared Thermography. J. Appl. Fluid
Mech., 3(1):55–62, 2010.
[7] U. Heck, U. Fritsching, and K. Bauckhage. Fluid flow and heat transfer in gas jet
quenching of a cylinder. International Journal of Numerical Methods for Heat & Fluid
Flow, 11:36–49, 2001.
10
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister
[9] U. Küttler and W. A. Wall. Fixed-point fluidstructure interaction solvers with dy-
namic relaxation. Comput. Mech., 43:61–72, 2008.
[10] P. Le Tallec and J. Mouro. Fluid structure interaction with large structural displace-
ments. Comp. Meth. Appl. Mech. Engrg., 190:3039–3067, 2001.
[11] N. Lior. The cooling process in gas quenching. J. Materials Processing Technology,
155-156:1881–1888, 2004.
[16] A. Sidi. Review of two vector extrapolation methods of polynomial type with appli-
cations to large-scale problems. J. Comp. Phys., 3(3):92–101, 2012.
[17] P. Stratton, I. Shedletsky, and M. Lee. Gas Quenching with Helium. Solid State
Phenomena, 118:221–226, 2006.
11