Vous êtes sur la page 1sur 18

!

ALE FLUID STRUCTURE COUPLING WITH MESH MOVING


BASED ON A COARSE HIGH ORDER AUXILIARY MESH
Jeferson Wilian Dossa Fernandes
Sergio Andrs Pardo Surez
jefersondossa@usp.br
parsua.91@usp.br
Escola de Engenharia de So Carlos da Universidade de So Paulo - EESC/USP
Rogrio Carrazedo
rogerioc@utfpr.edu.br
Universidade Tecnolgica Federal do Paran - UTFPR, Campus de Pato Branco
Via do conhecimento km 01, CEP 85503-390, Pato Branco, Paran, Brazil
Rodolfo Andr Kuche Sanches
rodolfo.sanches@usp.br
Escola de Engenharia de So Carlos da Universidade de So Paulo - EESC/USP
Av. do Trabalhador Socarlense, 400, CEP 13566-590, So Carlos, SP, Brazil
Abstract. The most common approach for fluid-structure interaction simulation is to employ
an arbitrary Lagrangian Eulerian (ALE) description for the fluid and Lagrangian description
for the structure. In this case the fluid mesh need to be deformed along time to accommodate the
structural displacements, splitting the coupled problem into three subjects: the fluid dynamics,
the shell dynamics and the fluid mesh dynamics. In this work we use a partitioned technique to
couple an explicit high velocity fluid solver to a nonlinear shell solver without rotation degrees
of freedom. In order to move and deform the fluid mesh we develop a technique where a coarse
high order finite element mesh, called space mesh, is immersed in the fluid mesh and fitted to
the boundaries. In the preprocessing stage,
the parametric local position of each fluid mesh
SECRETARIAT
Eventos
| +55
node is identified into the coarse Ikone
mesh,
as well
as(85)
the3261-1111
space mesh element which contains this
Rua
Dr.
Gilberto
Studart,
55
|
Sala
1616
|
Duets
Officeposition
Tower | Torre
Sul fluid mesh nodes is
node. Along time, the space mesh is deformed and the new
of the
Coc | 60192-105 | Fortaleza | CE | Brasil
evaluated, saving computational
time.
This procedure is tested by numerical examples.
E-mail:
cilamce2014@eventosikone.com.br
Keywords: Fluid-shell interaction, ALE, Partitioned coupling

CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

INTRODUCTION

Fluid-structure interaction (FSI) problems simulation is a challenging and very relevant


subject for many areas of engineering. Experimental FSI analysis are, in general, very expensive
and require considerable time, leading to the search of computational tools for simulating as
precisely as possible such problems.
Although researches on FSI have already reach some maturity, there are still several issues which need to be studied or optimized, so that some of the best computational mechanics
researchers are currently studying this subject.
Numerical fluid structure interaction (FSI) modelling includes three main subjects: the
computational fluid dynamics (CFD), the computational solid dynamics (CSD) and the interaction problem (IP) (Sanches and Coda, 2013, 2014). The strategy used for solving the IP should
be able to adequately combine CSD and CFD in spite of the different characteristics of each
field.
Mathematical modeling for physics problems is traditionally done by Eulerian or Lagrangian
descriptions. The Lagrangian description expresses the continuum medium movement in terms
of the initial configuration and time, being very efficient for problems where finite displacements are the main variables, such as in solid mechanics (CSD), with deforming meshes. On
the other hand, Eulerian description is defined in terms of final configuration and time, being
adequate for problems where main variables are velocities instead of displacements, such as in
fluid flows (CFD), resulting meshes fixed in space.
Therefore, the main issue for the IP is how to combine this two different descriptions.
One widely used methodology to allow fluid mesh to be deformed to accommodate structural
displacements is to use the arbitrary Lagrangian-Eulerian ALE description for Navier-Stokes
equations, allowing to enforce arbitrary deformation to the mesh (Soria and Casadei, 1997;
Donea et al., 1982; Sawada and Hisada, 2007). In this methodology, the fluid mesh needs to be
dynamically deformed in order to accommodate structural displacements or vibrations and at
same time keep the fixed part of fluid flow boundaries unchanged.
In the ALE context, the coupled problem can be formulated as a three- rather than twofield problem (fluid dynamics, mesh dynamics and structure dynamics) Lesoinne and Farhat
(1996). The weak form of fluid equations involves both the position and velocity of the mesh,
so that the good representation of mesh motion is very important. Some good mesh moving
techniques are shown in Kanchi and Masud (2007), where the authors present an adaptive mesh
moving scheme for 3D grids composed of linear tetrahedral and hexahedral elements, Degand
and Farhat (2002) and Farhat et al. (1998) where the authors deal with the mesh as an structural
problem using a 3D torsional spring analogy and Stein et al. (2003) where mesh moving and
remeshing techniques are combined. It is important to mention that problems, with large scale
of displacement will require also a remeshing technique Saksono et al. (2007).
Due to its high computational cost, it is important to have efficient algorithms for all of the
three fields mentioned above, including mesh dynamics. Therefore, in this paper we develop a
technique where a coarse high order finite element mesh, called space mesh, is immersed in the
fluid mesh and fitted to the boundaries. In the preprocessing stage, the parametric local position
of each fluid mesh node is identified into the coarse mesh, as well as the space mesh element
which contains this node. Along time, the space mesh is deformed and the new position of the
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

fluid mesh nodes is evaluated, saving computational time. This procedure is tested by numerical
examples.
We assume the fluid flow to be compressible, which allows us to efficiently employ an
explicit time integrator for saving computational effort. The governing equations are written in
the ALE convective form and integrated in time based on characteristics. This automatically
introduces diffusion in stream direction, stabilizing spurious variations due the employment of
the standard Galerkin procedure Zienkiewicz and Taylor (2000).
For dynamics of structures, we employ a novel unconstrained geometric non-linear formulation for shell analysis based on positions and unconstrained vectors introduced by Coda and
co-workers Coda and Paccolla (2007); Coda and Paccola (2009); Coda (2009); Coda and Paccola (2010); Sanches and Coda (2013). The use of positions as nodal parameters is motivated
by the work present by Bonet et al. Bonet et al. (2000). The main advantage of this formulations
are the absence of large rotation description, resulting in a constant mass matrix and therefore
making naturally possible the use of the Newmark time integrator as an momentum conserving
algorithm and conserves energy for small strain problems (see Sanches and Coda (2013)).
In order to couple fluid and structure, we employ a partitioned scheme, which among other
advantages, allows to use completely different solvers for solid and fluid as well as different
time steps (Sanches and Coda, 2013, 2014; Felippa et al., 2001; Teixeira and Awruch, 2005).
This paper is organized as follows: In section 1 we present the employed shell formulation,
in section 2 we present the compressible fluid dynamics formulation, in section 3 we describe
the coupling scheme and the mesh moving technique, in section 4 we present numerical studies
of the proposed coupling scheme, and finally in section 5 we draw the conclusions.

SHELL DYNAMICS

Shell structures are solids with one dimension much larger than the others. Therefore,
the mid surface of coordinates X in the initial configuration and x in the actual configuration,
serves as a reference to the solid mapping. The mappings f 0 and f 1 , from an auxiliary nondimensional space respectively to the initial and current configurations may be written for any
point out of the middle surface, its position at initial and actual configuration as:
fi0 = Xi = Nj (1 , 2 )Xjim +

h0
3 Nj (1 , 2 )e0ij ,
2

(1)

and
fi1 = xi = Nj (1 , 2 )xm
ji +

h0
ij ,
3 + aj Nj (1 , 2 )32 Nj (1 , 2 ) G
2

(2)

ij are the nodal values (unknowns) for the generalized vector at node j at final configuwhere G

ration, h0 is the initial thickness, e0i is the i th component of the unitary vector e0 , normal to
the middle surface at initial and a is the strain rate along thickness.
Finally, the positional mapping from initial to current is represented by:
1
f = f (X) = f 1 f 0
.

(3)

CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

The gradient A of mapping function may be expressed by:


1
A = f = A1 A0
.

(4)

After evaluating the gradient A, the Green strain tensor and the specific strain energy may
be obtained, following Ogden (1984):

Eij =

1
1
[Aki Akj ij ] = [Cij ij ] .
2
2

(5)

The variables Cij and ij are the right Cauchy-Green stretch tensor and the Kroenecker
delta, respectively. The following quadratic strain energy per unit of initial volume is adopted,
1
ue = Eij Cijkl Ekl
2

(6)

resulting into a linear elastic constitutive law relating second Piola-Kirchhoff stress and Green
strain, usually called Saint-VenantKirchhoff elastic law, i.e.:
Sij =

ue
= Cijkl Ekl
Eij

(7)

where The Cijkl are the components of the elastic constants tensor.
From preceding developments, one may write the equilibrium equation as the minimization
of the energy functional as:
Ue
F + M
x + Cx = 0,
x

(8)

where F is the external forces vector, C is the dissipative matrix and M is the mass matrix.
Coda and Paccola proved that for a positional total Lagrangian description, the Newmark
with = 1/2 presents momentum conservative properties for most of shell dynamics problems
and conserves energy for small strains if the time step is sufficiently large that the asymptotic energy convergence dominates or small enough that a uniform bound on the energy is
achieved (Coda and Paccola, 2009) - (see Hughes (1976) for more details with respect to energy conservation for constant mass matrix nonlinear dynamics with the average acceleration
time integration).
From Newmark method, the equilibrium equation for a given instant s + 1 becomes:

C
Ue
M

F
+
x

MQ
+
CR
+
xS+1 tCQS = 0,
(9)
S+1
S+1
S
S
x S+1
t2
t

xS
x S
1
where QS = t2 + t + 2 1 x
S and RS = x S + t (1 ) x
S .

Equation (9) represents a nonlinear system, which we solve employing Newton-Raphson


method. Each node will have 7 nodal parameters: 3 position vector components xi with i = 1, 2
i with i = 1, 2 or 3 and the strain ratio
or 3, 3 components of the generalized position vector G
along thickness a.
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

FEM FOR FLUID DYNAMICS WITH MOVING BOUNDARIES


The Eulerian description of fluid dynamics governing equations (Navier-Stokes) is given

by:

(ui )
=
,
t
xi

(10)

the mass conservation equation,


(ui )
(uj ui ) ij
p
=
+

+ gi ,
t
xj
xj
xi

(11)

the momentum equation and


(E)

=
(uj E) +
t
xj
xi

T
k
xi

(uj p) +
(ij uj ) + gi ui .
xj
xj

(12)

the energy equation, where is the specific mass, ui the i th velocity component, p pressure,
ij the deviatoric stress tensor (i, j) component, gi the i th direction field forces constant, E
the specific energy, T temperature and k the thermal conductivity.
The Arbitrary Lagrangian-Eulerian (ALE) description is obtained by the introduction of
a reference domain R(t) with arbitrary movement when deriving the governing equations. It
may be considered as a mapping from initial configuration C(t0 ) to final configuration C(t),
written with respect to the moving reference domain (domain covered by the finite element
mesh) Donea et al. (1982) (see Fig. 1).

Figure 1: Adopted kinematics for ALE description adapted from Sanches and Coda (2014)

The Jacobian J, for the transformation from reference domain R(t) to the material domain
C(t0 ), is given by:
J = det (A) onde Aij =

i
with i and j = 1, 2 or 3,
aj

(13)

where i and aj are the position vectors components regarding respectively to R(t) and C(T0 ).
Considering a physical property expressed on the reference configuration as f (i , t) and
equal to F (ai , t) on the initial configuration,considering also that J
= J w, where w is
t
CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

the velocity vector of the reference point of coordinates ,it is possible to write: Based on the
derivative rules applied to (f w) we get:

(JF )
f
=J
+ (f w) ,
(14)
t
t
Substituting f = on equation (14) and considering the mass conservation equation ((10)),
using index notation, one writes:
(J)
((wi ui ))
=J
t
xj

(15)

or, substituting the time derivative of J:

(ui )

+
= wi
,
t
xi
xi

(16)

which is the final form for the mass conservation equation on ALE description.
Following the same procedure, now for (10) and (11), the ALE formulations for momentum
and energy equation are respectively:

(ui ) (uj ui ) ij
p
(ui )
+

+
gi = wj
t
xj
xj
xi
xj

(17)

and
(E) (uj E)

t
xj
xi

T
k
xi

(uj p) (ij uj )
(E)

gi ui = wi
.
xj
xj
xi

(18)

It is important to observe that if the velocity w is null, the formulation relies on the Eulerian
description, while if w = u the formulation relies on the Lagrangian description Donea et al.
(1982).

3.1

Time integration

If there is no diffusion, the time variation of over a characteristic coordinates x is by


definition null. For the Navier-Stokes equations we can write:
(x , t)
Q(x ) = 0,
t

(19)

where Q(x ) contains all the non convective terms.


We assume the following approximation for Eq. (19) (Zienkiewicz and Taylor, 2000):
(y)n+1 (x)n
(Q(y)n+1 ) + (1 )(Q(x)n ),
t
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

(20)

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

where x and y means respectively the characteristic positions at t = n and t = n + 1, is a


constant with value 0 for explicit solution and may be chosen larger than zero 0 and smaller
than 1 for semi-implicit or implicit solution.
The product u and the term Q(x) may be approximated by Taylor resulting the following
expressions:

u(x)n = u(y)n (y x)

Q(x)n = Q(y)n (y x)

(u(y))n (y x)2 2 (u(y)n )


+
x
2
x2
+O(t3 ),

Q(y)n
+ O(t2 ).
x

(21)

(22)

Assuming t = (y x)/u, from Eqs. (21), (20) and (22), and assuming = 0 (explicit
form), we have:

(u(y))n
(y)n+1 = (y)n t
Q(y)n
x

(23)
(t)2 (u(y)n )
2
+
u
Q(y)n + O(t ).
2
x
x
One important point about this procedure is that the high order terms of Eq. (23), obtained due to time integration along characteristics, introduce dissipation on stream lines direction, which as shown by (Zienkiewicz and Taylor, 2000) are equivalent to the Petrov-Galerking
schemes when the time interval tends to the critical time interval, and gets smaller effects as the
time interval get larger.
Applying the procedure of Eq. (23) to the Navier-Stokes equations, one may write for
momentum and energy equations one may write:

(uj ui )
(ui ) ij
p
(ui )n+1 = t
+ wj
+

+ gi +
xj
xj
xj
xi
n

,
(24)
2
t

(uj ui )
(ui ) ij
p
uk
wj

+
gi
2
xk
xj
xj
xj
xi
n
and

(ui E)
(E)
(E)n+1 = t
+ wi
+
xi
xi n

T
(ui p) (ij uj )
t
k

+
gi ui +
xi
xi
xi
xi

t2

(ui E)
(E)
uk
wi
+
2
xk
xi
xi

t2

T
(ui p) (ij uj )
uk

k
+

+ gi ui .
2
xk
xi
xi
xi
xi
n

(25)

where all the right hand side terms are known at the instant t = n.
CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

For mass conservation equation we use the following expression:

( (ui ))n+1

n+1 = t
(ui )n +
+ wi
+
xi
xi
xi

t2

uk
wi
.
2
xk
xi
n

(26)

where is an arbitrary constant with value between 0.5 and 1.0.


Applying the Galerkin method to Eq. (24), (26) and (25), we obtain the spatial discretization and solve the resulting system getting the week solution.
We still need to deal with the discontinuities due to the presence of shock waves, as the
standard Galerkin method is unable to deal with strong discontinuities. Therefore, the artificial
diffusion term based on pressure second derivative is added:

f a

= ta
xi

xi

where is the variable to be smoothed and a is the artificial viscosity given by:

p
3 (|u| + c)
a = qdif h
,
pav xi xi e

(27)

(28)

where |u| is the velocity absolute value, pav is the pressure average over the element, qdif is an
user specified coefficient taken between 0 and 2, c is the sound speed and h is the element size
(Zienkiewicz and Taylor, 2000; Nithiarasu et al., 1998).

PARTITIONED FLUID-STRUCTURE COUPLING

It is desirable a numerical scheme able to make the exactly prediction of an uniform flow.
Lesoinne and Farhat (1996) showed that this condition is satisfied if the scheme under consideration satisfies a discrete version of the geometric conservation laws (DGCL), which states
basically that that the change in volume of each element for a given time interval must be equal
to the volume (or area) swept by the element boundary during the time interval.
It occurs if the mesh motion is developed in a way that it is exactly captured by the time
integrator scheme. In the FSI modeling with different fluid and structure time integrators, enforcing DGCL implies in different values for mesh and structure velocity for the fluid nodes in
the fluid-structure interface.
Geometric conservation poses a difficulty particularly when the divergence ALE formulation is applied, however if a convective ALE formulation is employed, as the one employed
here, constant flow is exactly predicted irrespective of the employed time discretization scheme
(Frster, 2007). Boffi and Gastaldi (2004) proved that the GCL is neither necessary nor sufficient for stability and, as admitted by Guillard and Farhat (2000), there are recurrent assertions
in the literature stating that enforcing the DGCL may be unnecessary.
Taking this facts into account, although possible to do, we do not care about enforcing the
DGCLs in our coupling scheme.
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

4.1

Forces and velocities transfers

As fluid and shell meshes are different and generated in an independent process, during
the pre-processing step, for each fluid node i, a closest point P si at shell mesh domain (s ) is
identified and stored (see Fig. 2). Subsequently, the fluid mesh is adapted moving the node i to
the exact position of P si .

Figure 2: Transfer points

For each shell node k , a closest point P fk on the fluid boundary related to the structure
(s ) is identified and stored.
The Dirichlet boundary conditions for node i are obtained from the shell point P si . For
viscous flow uf (i) = us (P si ) while for inviscid flow we adopt:
uf (i) = uf (i) + [(us (P si ) uf (i)) n]n.

(29)

where uf is the fluid velocity vector, us is the shell velocity vector and n, the unity vector normal
to s .
The Neumman boundary conditions for node k are obtained from fluid point P fk by the
following expression:
qk j = [jl nl pnl ]P fk ,

(30)

where the indexes j and l represent Cartesian direction and nl is the l component form the
normal vector to s .

4.2

Fluid mesh dynamic moving

A good mesh moving algorithm for fluid-structure interaction problems will adapt the fluid
mesh to the solid movement with minimal of mesh distortion.
The fluid mesh is usually very fine close to the structure in order to capture shock waves,
vortex shedding, limit layer or any other flow structure. However, structural movements are
often much more smooth than the mentioned situations, hardly presenting discontinuity.
Based on these facts, we chose not to deal direct with all the degree of freedom of the fluid
dynamic mesh. Instead, we insert another much coarser mesh with high order curved tetrahedral
elements which fits to the boundaries and solve the reference domain movement based on this
mesh. This mesh we call space mesh.
CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

During the preprocessing phase we find to each fluid node P , the space mesh element elsm
where it is immersed and its local coordinates sm 1 (P ), sm 2 (P ) and sm 3 (P ) and store these
informations. The space mesh is dynamically deformed and the positions xf i (P )and velocities
wi (P ) for the fluid mesh is interpolate by:
xf i (P ) = Nsmk (sm (P ))xsmi (k),

(31)

wf i (P ) = Nsmk (sm (P ))wsmi (k),

(32)

and
where Nsmk is the space mesh shape function associated to the node k, xsmi (k) is the nodal
i thcoordinate of node k, and wsmi (k) is the nodal i th velocity component associated to
the node k.
The Laplace equation would be a good choice for a mesh moving model (Kanchi and
Masud, 2007), however it makes necessary to solve a new equation system. Therefore we
adopted the same technique employed by Sanches and Coda (2014), which is based in the one
employed by Teixeira (2001) . This technique consists on distribute the space mesh velocities
and positions based on the distance to the boundary according to:

Xsm ki

ne

akj Xs ji
= ne
,
nf
a
+
b
kj
kl
j=1
l=1
j=1

(33)

where ne is the shell nodes number, nf is the fixed boundary (f ) nodes number, akj is the
weight coefficient that considers the shell movement influence, and bkl is the coefficient that
takes in account the fixed boundary influence and Xsm and Xs may be space mesh and shell
velocities or displacements.
The coefficients a and b are given by:
akj =

1
de1
kj

(34)

bkl =

1
,
de2
kl

(35)

and

where dkj is the distance between the node k and the node j located at the moving boundary,
dkl is the distance between the node k and the node l located at fixed fixed boundary, and e1
and e2 are numbers chosen by the operator which enable to adjust the boundary influence over
the mesh movement. A good choice for open flow problems is e1 = e2 = 4, however for closed
flows with large displacements a smaller number may present better results.

4.3

Coupling dynamic process

As the shell solver is implicit and the fluid solver explicit, a coupling scheme which enable
sub-cycles of time steps is desirable. It is usual that time steps used for shell analysis are larger
than the ones adopted for fluid modeling, therefore we suggest the scheme depicted on Fig. 3.
This scheme may be summarized as:
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

Figure 3: Coupling scheme adapted from Sanches and Coda (2013)

At a given instant ts = i, the structure is solved with the loads imposed by the flow (step
1), with a time step ts , so that the velocities and positions at instant ts = i + 1 are
obtained (step 2).
Shell positions variations inside the time interval ts are approximated by a cubic polynomial, which is obtained based on xs (i), x s (i), xs (i + 1) and x s (i + 1) (steps 3 and 4).
From this polynomial we can find the shell velocities and positions for each fluid time
step tf = (ts )/nsf . Following, the fluid mesh movement is obtained from equations
(33), (31) and (32) (steps 5 and 7).
Fluid Dirichlet boundary conditions are obtained from the shell movement and the fluid
is solved using time steps tf (steps 6 and 8) until reach the instant tf = i nsf , when
fluid loads are imposed to the structure and the process restart.
Mesh Moving Tests
In order to verify the proposed mesh moving technique, we choose a panel flutter problem.
In this example we study the behavior of an initially flat panel subjected to supersonic flow.
The panel starts at x = 0.25m and has: specific mass s = 2710 kg/m3 , Youngs modulus
E = 77.28 GPa and Poissons ratio = 0.33, length 0.5 m, width 0.025 m and thickness
1.35 mm. The boundary conditions at z = 0 and z = 0.025m are those of symmetry regarding
plane xy.
We meshed the panel with 40 8 nodes triangular isoparametric shell elements (cubic order)
and 244 nodes while fluid domain with 30224 4 nodes linear tetrahedral elements and 8584
nodes (see Fig. 4. The space mesh employed for the adopted moving mesh technique has 168
20 nodes tetrahedral isoparametric elements (cubic order) and 1066 nodes (see Fig. 5).
This is example is chosen due to the facts that initially fluid mesh need to precisely capture small amplitude movements in order to produce dynamical instability and it reaches large
amplitudes along time, being a complete test for the proposed coupling scheme.
Initially we perform 3 different tests only to the mesh moving algorithm where there
is no fluid flow and the panel is submitted to: 1) a positive normal uniformly distributed
load (non-conservative load initially oriented to up direction) qn = 5000N/m2 ; 2) a negative
uniformly distributed normal load (non-conservative load initially oriented to down direction
qn = 5000N/m2 ; and 3) a distributed normal uniform load negative in the left half and positive in right half qn = 15000N/m2 if x < 0.5 and qn = 15000N/m2 if x > 0.5.
CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

(a) fluid mesh (xy view)

(b) panel mesh (xz view)

Figure 4: Fluid and panel discretization

Figure 5: Space mesh

For all these cases the panel is fully clamped on the left and with only horizontal displacements free on the right.
The shell time step is t = 0.001. In order to test the coupling procedure, the fluid mesh is
solved with one time step tf = 0.0001, i.e., 10 sub-cycles.
All the three cases showed good results as one can see from figures 6, 7 and 8.

CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

(a) t = 0.007 s s

(b) t = 0.011 s s
Figure 6: Deformed fluid mesh for panel with up oriented uniform distributed load

(a) t = 0.007 s s

(b) t = 0.011 s s
Figure 7: Deformed fluid mesh for panel with down oriented uniform distributed load

CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

Figure 8: Deformed fluid mesh for panel with down oriented uniform distributed load at t = 0.007s

Panel flutter
Based on the results of the preliminary tests, the proposed algorithm seems to be ready for
the true fluid-structure interaction problem.
The flow is considered inviscid and the undisturbed flow has specific mass = 0.339
kg/m3 and pressure p = 28 KPa, M ach number M = 2.3 and sound speed c = 340 m/s,
while the panel has: specific mass s = 2710 kg/m3 , Youngs modulus E = 77.28 GPa and
Poissons ratio = 0.33, length 0.5 m, width 0.025 m and thickness 1.35 mm. The boundary
conditions at z = 0 and z = 0.025m are those of symmetry regarding plane xy.
At the beginning of the analysis, the pressure on the inferior face of the panel is reduced
0.1 %, introducing a disturbance to the panel. This condition is kept until 4 ms, when pressure
on the inferior face is set again to p .
This problem has critical Mach number M = 2 according to the simulation performed by
Sanches and Coda (2014), so that it is expected to get dynamical instability.

Two analysis are performed, one with the boundary conditions fully clamped on the left
and with only horizontal displacements free on the right, in order to get larger displacements
and get results closer to the linear solution, and other with the panel fully clamped on both ends.
Figure 9 depicts the displacements vs. time for x = 6.0 (3/4 of the panel). One can see
that the simulation with free horizontal displacements on the right produced the same result
as Teixeira and Awruch (2005) get for the linear problem, however the fully clamped problem
reaches a limit cycle, similar to the one obtained for the geometrical nonlinear analysis obtained
by Rifai et al. (1999), due to the membrane effect. This shows our algorithm to be robust and
precise.
Figure 10 shows a snapshot of pressure distribution and shell displacement distribution at
instant t = 0.1195 s in a 3D view.
Finally, one can observe the good quality of the proposed mesh moving scheme in figures
11(a) and 11(b), where the deformed fluid mesh (black) and space mesh (red) are depicted for
instants t = 0.119 s and t = 0.1255 s.

CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

0.03

Non-linear ref.
Linear ref.
Fully clamped pres. work.
Free x disp. pres. work

0.02

y(m)

0.01
0
-0.01
-0.02
-0.03
0

0.02

0.04

0.06

0.08

0.1

0.12

0.14

t(s)

Figure 9: Vertical displacements vs. time at x = 0.6m

Figure 10: Fluid pressure and shell displacements distribution for instant t = 0.1195 s (3D view)

(a) t = 0.119 s

(b) t = 0.1255 s

Figure 11: Fluid mesh (black) and space mesh (red)


CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

CONCLUSION

In this work we briefly addressed all the aspects of a standard fluid-structure interaction
numerical simulation, as well as presented a compressible fluid flow and a geometric nonlinear shell formulations, where the shell formulation has no rotation degrees of freedom, and so
is more robust and simple. Following we propose a partitioned coupling technique which allows different time-steps for fluid and structure. In order to move and deform the fluid mesh
we develop a technique where a coarse high order finite element mesh, called space mesh, is
immersed in the fluid mesh and fitted to the boundaries saving computational work and time
during the dynamic process. This procedure is tested in a panel flutter problem, showing good
results, attesting the robustness and efficiency of the proposed technique.

ACKNOWLEDGMENTS
The authors would like to thank CNPq, CAPES and Fundao Araucria for financial support, and professor Humberto Breves Coda for helping with the shell dynamics code.

REFERENCES
Boffi D. and Gastaldi L. Stability and geometric conservation laws for ale formulations. Computer Methods in Applied Mechanics and Engineering, 193(42-44):4717 4739, 2004. ISSN
0045-7825. doi:10.1016/j.cma.2004.02.020.
Bonet J., Wood R.D., Mahaney J., and Heywood P. Finite element analysis of air supported
membrane structures. Computer Methods in Applied Mechanics and Engineering, 190(57):579 595, 2000. ISSN 0045-7825. doi:DOI: 10.1016/S0045-7825(99)00428-4.
Coda H.B. Two dimensional analysis of inflatable structures by the positional FEM. Latin
American Journal of Solids and Structures, 6(3):187212, 2009. ISSN 1679-7817.
Coda H.B. and Paccola R.R. Unconstrained Finite Element for Geometrical Nonlinear Dynamics of Shells. Mathematical problems in engineering, 2009. ISSN 1024-123X.
Coda H.B. and Paccola R.R. Improved finite element for 3d laminate frame analysis including
warping for any cross-section. Applied Mathematical Modelling, 34(4):1107 1137, 2010.
ISSN 0307-904X.
Coda H.B. and Paccolla R.R. An alternative positional fem formulation for geometrically nonlinear analysis of shells: curved triangular isoparametric elements. Computer Methods in
Applied Mechanics and Engineering, 40:185200, 2007.
Degand C. and Farhat C. A three-dimensional torsional spring analogy method for unstructured
dynamic meshes. Computers & Structures, 80(3-4):305 316, 2002. ISSN 0045-7949.
Donea J., Giuliani S., and Halleux J.P. An arbitrary lagrangian-eulerian finite element method
for transient dynamic fluid-structure interactions. Computer Methods in Applied Mechanics
and Engineering, 33(1-3):689 723, 1982. ISSN 0045-7825.
CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

J. W. D. Fernandes, S. A. P. Surez, R. Carrazedo, R. A. K. Sanches

Farhat C., Degand C., Koobus B., and Lesoinne M. Torsional springs for two-dimensional dynamic unstructured fluid meshes. Computer Methods in Applied Mechanics and Engineering,
163(1):231245, 1998. doi:doi:10.1016/S0045-7825(98)00016-4.
Felippa C.A., Park K.C., and Farhat C. Partitioned analysis of coupled mechanical systems.
Computer Methods in Applied Mechanics and Engineering, 190(24-25):3247 3270, 2001.
ISSN 0045-7825.
Frster C. Robust methods for fluid-structure interaction with stabilised finite elements. D.Sc.
Thesis, Universitt Stuttgart, Holzgartenstr. 16, 70174 Stuttgart, 2007.
Guillard H. and Farhat C. On the significance of the geometric conservation law for flow
computations on moving meshes. Computer Methods in Applied Mechanics and Engineering,
S12):1467
190(11A

1482, 2000. ISSN 0045-7825. doi:10.1016/S0045-7825(00)00173-0.


Hughes T.J.R. Stability, convergence and growth and decay of energy of the average acceleration method in nonlinear structural dynamics. Computers & Structures, 6(4-5):313 324,
1976. ISSN 0045-7949. doi:10.1016/0045-7949(76)90007-9.
Kanchi H. and Masud A. A 3d adaptive mesh moving scheme. International Journal for Numerical Methods in Fluids, 54(6-8):923944, 2007. ISSN 1097-0363. doi:10.1002/fld.1512.
Lesoinne M. and Farhat C. Geometric conservation laws for flow problems with moving boundaries and deformable meshes, and their impact on aeroelastic computations. Computer Methods in Applied Mechanics and Engineering, 134(1-2):71 90, 1996. ISSN 0045-7825. doi:
10.1016/0045-7825(96)01028-6.
Nithiarasu P., Zienkiewicz O.C., Sai B.V.K.S., Morgan K., Codina R., and Vazquez M. Shock
capturing viscosities for the general fluid mechanics algorithm. International Journal for
Numerical Methods in Engineering, 28(9):13251353, 1998. ISSN 0271-2091.
Ogden R. Non-linear elastic deformations. Engineering Analysis, 1(2):119 119, 1984. ISSN
0264-682X.
Rifai S.M., Johan Z., Wang W.P., Grisval J.P., Hughes T.J., and Ferencz R.M. Multiphysics
simulation of flow-induced vibrations and aeroelasticity on parallel computing platforms.
Computer Methods in Applied Mechanics and Engineering, 174(3-4):393 417, 1999. ISSN
0045-7825.
Saksono P.H., Dettmer W.G., and Peric D. An adaptive remeshing strategy for flows with
Sstructure
moving boundaries and fluidA

interaction. International Journal for Numerical


Methods in Engineering, 71(9):10091050, 2007. ISSN 1097-0207. doi:10.1002/nme.1971.
Sanches R.A. and Coda H.B. Unconstrained vector nonlinear dynamic shell formulation applied
to fluid structure interaction. Computer Methods in Applied Mechanics and Engineering,
259(0):177 196, 2013. ISSN 0045-7825. doi:http://dx.doi.org/10.1016/j.cma.2013.02.016.

Sanches R.A.K. and Coda H.B.


On fluidUshell
coupling using an arbitrary la
grangianUeulerian fluid solver coupled to a positional lagrangian shell solver. Applied Mathematical Modelling, 38(14):3401 3418, 2014. ISSN 0307-904X. doi:
http://dx.doi.org/10.1016/j.apm.2013.11.025.
CILAMCE 2014
Proceedings of the XXXV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

ALE fluid structure coupling with mesh moving based on a coarse high order auxiliary mesh

Sawada T. and Hisada T. Fluid-structure interaction analysis of the two-dimensional flag-inwind problem by an interface-tracking ale finite element method. Computers & Fluids,
36(1):136 146, 2007. ISSN 0045-7930. doi:10.1016/j.compfluid.2005.06.007. Challenges
and Advances in Flow Simulation and Modeling.
Soria A. and Casadei F. Arbitrary Lagrangian-Eulerian multicomponent compressible flow
with fluid-structure interaction. International Journal for Numerical Methods in Fluids,
25(11):12631284, 1997.
Stein K., Tezduyar T., and Benney R. Mesh moving techniques for fluid-structure interactions with large displacements. Journal of Applied Mechanics, 70(1):5863, 2003. doi:
10.1115/1.1530635.
Teixeira P.R.F. Simulao Numrica da interao de escoamentos tridimensionais de fluidos
compressveis e incompressveis e estruturas deformveis usando o mtodo de elementos
finitos. Doutorado em engenharia civil, Escola de Engenharia, Universidade Federal do Rio
Grande do Sul, Porto Alegre, 2001.
Teixeira P.R.F.E. and Awruch A.M. Numerical Simulation of fluid-structure interaction using
the finite element method. Computers and Fluids, 34:249273, 2005.
Zienkiewicz O.C. and Taylor R.L. The Finite Element Method, v3: Fluid Dynamics.
Butterworth-heinemann Linacre house, 2000.

CILAMCE 2014
Proceedings of the XXXIV Iberian Latin-American Congress on Computational Methods in Engineering
Evandro Parente Jr (Editor), ABMEC, Fortaleza, CE, Brazil, November 23-26, 2014

Vous aimerez peut-être aussi