0% found this document useful (0 votes)
53 views11 pages

Fast Solvers For Thermal Fluid Structure Interaction

This document summarizes a study on using vector extrapolation methods to accelerate the convergence of a fixed point iteration for coupling thermal fluid-structure interaction simulations. The study considers gas quenching of steel, modeled using the compressible Navier-Stokes equations for the fluid and nonlinear heat equation for the solid. A partitioned approach is used, with the subproblems solved iteratively using a fixed point method. Three vector extrapolation methods - Aitken relaxation, minimal polynomial extrapolation, and reduced rank extrapolation - are analyzed to accelerate the convergence of the fixed point iterations by reducing the interface error between steps. The governing equations, discretization methods, and vector extrapolation acceleration techniques are described for modeling transient heat transfer between the fluid

Uploaded by

Bara Alsayed
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
53 views11 pages

Fast Solvers For Thermal Fluid Structure Interaction

This document summarizes a study on using vector extrapolation methods to accelerate the convergence of a fixed point iteration for coupling thermal fluid-structure interaction simulations. The study considers gas quenching of steel, modeled using the compressible Navier-Stokes equations for the fluid and nonlinear heat equation for the solid. A partitioned approach is used, with the subproblems solved iteratively using a fixed point method. Three vector extrapolation methods - Aitken relaxation, minimal polynomial extrapolation, and reduced rank extrapolation - are analyzed to accelerate the convergence of the fixed point iterations by reducing the interface error between steps. The governing equations, discretization methods, and vector extrapolation acceleration techniques are described for modeling transient heat transfer between the fluid

Uploaded by

Bara Alsayed
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 11

V International Conference on Computational Methods in Marine Engineering

MARINE 2013
B. Brinkmann and P. Wriggers (Eds)

FAST SOLVERS FOR THERMAL FLUID STRUCTURE


INTERACTION

PHILIPP BIRKEN∗ , TOBIAS GLEIM† , DETLEF KUHL† AND ANDREAS


MEISTER∗
∗ Instituteof Mathematics
University of Kassel
Heinrich-Plett-Str. 40, 34132 Kassel, Germany
e-mail: {birken,meister}@mathematik.uni-kassel.de, web page:
http://www.mathematik.uni-kassel.de/

† Institute of Mechanics and Dynamics,


University of Kassel
Mönchebergstr. 7, 34109 Kassel, Germany
e-mail: {tgleim,kuhl}@uni-kassel.de - Web page: http://www.uni-kassel.de

Key words: Thermal Fluid Structure Interaction, Partitioned Coupling, Fixed Point
methods, Vector Extrapolation

Abstract. We consider thermal fluid structure interaction to model industrial gas


quenching in steel forging, where hot steel is cooled using cold high pressured gas. This
allows to define properties of the finished steel part, as for example yield strength, locally
at low cost and without environmental problems.
For the numerical simulation, a partitioned approach via a Dirichlet-Neumann coupling
and a fixed point iteration is employed. In time, previously developed efficient time
adaptive higher order time integration schemes are used. The respective models are
the compressible Navier-Stokes equations and the nonlinear heat equation, where the
parameter functions are obtained from measurements on a specific steel.
Here, the use of different vector extrapolation methods for convergence acceleration
techniques of the fixed point iteration is analyzed. In particular, Aitken relaxation, mini-
mal polynomial extrapolation (MPE) and reduced rank extrapolation (RRE) are consid-
ered.

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

m = ρv and energy per unit volume ρE:


∂t ρ + ∇ · m = 0,
2 2
X 1 X
∂t mi + ∂xj (mi vj + pδij ) = ∂x Sij , i = 1, 2,
j=1
Re j=1 j
2 2
!
1 X X 1
∂t (ρE) + ∇ · (Hm) = ∂x Sij vi − qj .
Re j=1 j i=1
Pr

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.

3.2 Coupled time integration


If the fluid and the solid solver are able to carry out time steps of implicit Euler type,
the master program of the FSI procedure can be extended to SDIRK methods very easily,
since the master program just has to call the backward Euler routines with specific time
step sizes and starting vectors.
Time adaptivity is obtained by using embedded methods as suggested in [2]. To this
end, all stage derivatives are stored by the subsolvers. Then, the local error is estimated
by the solvers separately, which then report the estimates back to the master program.
Furthermore, if the possibility of rejected time steps is taken into account, the current
solution pair (u, Θ) has to be stored as well.
To comply with the condition that temperature and heat flux are continuous at the
interface Γ, a so called Dirichlet-Neumann coupling is used. Namely, the boundary con-
ditions for the two solvers are chosen such that we prescribe Neumann data for one solver
and Dirichlet data for the other. Following the analysis of Giles [6], temperature is pre-
scribed for the equation with smaller heat conductivity, here the fluid, and heat flux is
given on Γ for the structure. Choosing the conditions the other way around leads to an
unstable scheme.
In the following it is assumed that at time tn , the step size ∆tn is prescribed. Applying
a DIRK method to equation (6)-(7) results in the coupled system of equations to be solved
at Runge-Kutta stage i:

4
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister

F(ui , Θi ) := ui − sui − ∆tn aii h(ui , Θi ) = 0, (8)

T(ui , Θi ) := [M − ∆tn aii K]Θi − MsΘ i − ∆tn aii q̄(ui ) = 0. (9)



Here, aii = 1− 2/2 is a coefficient of the time integration method and sui and sΘ i are given
vectors, called starting vectors, computed inside the DIRK scheme. The dependence of
the fluid equations h(ui , Θi ) on the temperature Θi results from the nodal temperatures
of the structure at the interface. This subset is written as ΘΓi . Accordingly, the structure
equations depend only on the heat flux of the fluid at the coupling interface.

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)

is often referred to as the interface residual.


To improve the convergence speed of the fixed point iteration, different vector extrap-
olation techniques have been suggested. These are typically classic techniques, where a
set of k vectors of a convergent vector sequence is extrapolated to obtain a faster con-
verging sequence. We are now going to describe three techniques that we will test in this
framework.

5
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister

4.2 Aitken Relaxation


Relaxation means that after the fixed point iterate is computed, a relaxation step is
added:
Γ (ν+1) Γ (ν+1) Γ (ν)
Θ̃i = ων+1 Θi + (1 − ων+1 )Θi . (14)

Several strategies exist to compute the relaxation parameter ω.


Γ (ν+1)
The idea of Aitken’s method is to enhance the current solution Θi using two
Γ (ν+2) Γ (ν+1) Γ (ν+1) Γ (ν)
previous iteration pairs (Θi , Θi ) and (Θi , Θi ) obtained from the Gauß-
Seidel-Step (10)-(11). An improvement in the scalar case is given by the secant method
Γ (ν−1) Γ (ν+1) Γ (ν) Γ (ν)
Γ (ν+1) Θi Θi − Θi Θi
Θ̃i = Γ (ν−1) Γ (ν) Γ (ν) Γ (ν+1)
. (15)
Θi − Θi − Θi + Θi
The relaxation factor in equation (14) for the secant method (15) is then
Γ (ν−1) Γ (ν)
Θi − Θi
ων+1 = Γ (ν−1) Γ (ν) Γ (ν) Γ (ν+1)
. (16)
Θi − Θi − Θi + Θi
As customary, we use an added recursion on ωi in which we use the old relaxation factor
ων :
rΓ (ν)
ων+1 = −ων . (17)
rΓ (ν+1) − rΓ (ν)
In the vector case the division by residual rΓ (ν+1) − rΓ (ν) is not possible. Therefore, we
multiply nominator and numerator formally by (rΓ (ν+1) − rΓ (ν) )T to obtain
(rΓ (ν) )T (rΓ (ν+1) − rΓ (ν) )
ων+1 = −ων . (18)
krΓ (ν+1) − rΓ (ν) k2
Two previous steps are required to calculate the relaxation parameter. For the first
fixpoint iteration, a relaxation parameter ν1 is needed and therefore it must be prescribed.

4.3 Polynomial Vector Extrapolation


Another idea we will follow here are Minimal Polynomial Extrapolation (MPE) and
Reduced Rank Extrapolation (RRE) [16]. Here, the new approximation is given as a
linear combination of existing iterates with coefficients γν to be determined:
ν+1
Γ (ν+1) X
Θ̃i = γj ΘΓi j . (19)
j=0

For MPE, the coefficients are defined via


cj
γj = Pν+1 , j = 0, ..., ν + 1 (20)
i=0 ci

6
Philipp Birken, Tobias Gleim, Detlef Kuhl and Andreas Meister

where the coefficients cj are the solution of the problem


Xν+1
min cj rj + rν+1 . (21)

cj 2
j=0

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

These problems are then solved using a QR decomposition.

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.

Figure 1: Test case for the coupling method

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

(a) Entire mesh (b) Mesh zoom

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

Figure 4: Number of fixed point iterations per time step

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 .

Table 1: Total number of iterations for 100 secs of real time

T OL No relax. Aitken MPE RRE


10−4 #Iterations 53 48 50 50
10−7 #Iterations 89 74 75 75

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.

[2] P. Birken, K. J. Quint, S. Hartmann, and A. Meister. A Time-Adaptive Fluid-


Structure Interaction Method for Thermal Coupling. Comp. Vis. in Science,
13(7):331–340, 2011.

[3] J. M. Buchlin. Convective Heat Transfer and Infrared Thermography. J. Appl. Fluid
Mech., 3(1):55–62, 2010.

[4] C. Farhat. CFD-based Nonlinear Computational Aeroelasticity. In E. Stein,


R. de Borst, and T. J. R. Hughes, editors, Encyclopedia of Computational Mechanics,
volume 3: Fluids, chapter 13, pages 459–480. John Wiley & Sons, 2004.

[5] T. Gerhold, O. Friedrich, J. Evans, and M. Galle. Calculation of Complex Three-


Dimensional Configurations Employing the DLR-TAU-Code. AIAA Paper, 97-0167,
1997.

[6] M. B. Giles. Stability Analysis of Numerical Interface Conditions in Fluid-Structure


Thermal Analysis. Int. J. Num. Meth. in Fluids, 25:421–436, 1997.

[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.

[8] M. Hinderks and R. Radespiel. Investigation of Hypersonic Gap Flow of a Reentry


Nosecap with Consideration of Fluid Structure Interaction. AIAA Paper, 06-1111,
2006.

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.

[12] R. C. Mehta. Numerical Computation of Heat Transfer on Reentry Capsules at Mach


5. AIAA-Paper 2005-178, 2005.

[13] C. Michler, E. H. van Brummelen, and R. de Borst. Error-amplification Analysis of


Subiteration-Preconditioned GMRES for Fluid-Structure Interaction. Comp. Meth.
Appl. Mech. Eng., 195:2124–2148, 2006.

[14] K. J. Quint, S. Hartmann, S. Rothe, N. Saba, and K. Steinhoff. Experimental vali-


dation of high-order time integration for non-linear heat transfer problems. Comput.
Mech., 48(1):81–96, 2011.

[15] S. Schüttenberg, M. Hunkel, U. Fritsching, and H.-W. Zoch. Controlling of Distor-


tion by means of Quenching in adapted Jet Fields. Materialwissenschaft und Werk-
stofftechnik, 37(1):92–96, 2006.

[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.

[18] J. Vierendeels, L. Lanoye, J. Degroote, and P. Verdonck. Implicit Coupling of Parti-


tioned Fluid-Structure Interaction Problems with Reduced Order Models. Comp. &
Struct., 85:970–976, 2007.

[19] U. Weidig, N. Saba, and K. Steinhoff. Massivumformprodukte mit funk-


tional gradierten Eigenschaften durch eine differenzielle thermo-mechanische
Prozessführung. WT-Online, pages 745–752, 2007.

11

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy