ArticlePDF Available
AIAA-2000-3456
1
American Institute of Aeronautics and Astronautics
Copyright © 2000 by the American
Institute of Aeronautics and Astronautics
I. D. Parsons, P. Alavilli, A. Namazifard,
A. Acharya, X. Jiao and R. Fiedler
Center for the Simulation of
Advanced Rockets
University of Illinois, Urbana, IL
Abstract
We describe simulations of solid rocket motors that
involve coupling between the core fluid flow, the
structural response of the propellant and case, and the
combustion of the propellant. A partitioned predictor-
corrector algorithm is employed to treat the fluid-
structure interaction. The combustion rate of the
propellant is coupled to the fluid flow via an empirical
power law relationship. Our algorithm couples the
physical processes involved using a partitioned
approach, enabling us to use existing codes to perform
the bulk of our simulations. We give special
consideration to the jump conditions that hold at the
fluid-structure-combustion interface, and specialize them
for the early burn phase. The interface between the
eroding solid and the fluid is treated using an ALE
formulation, which provides a consistent technique for
handling the eroding solid. Data are presented that
demonstrate the parallel performance of our code on a
variety of architectures. Results from simulations of the
space shuttle solid rocket motor demonstrate the
applicability of our approach. Future extensions of the
simulation capability to include thermal effects,
turbulence and material failure will be discussed.
1. Introduction
Simulation of solid rocket motors presents challenges
in many areas. A complete simulation requires
consideration of different physics (e.g., fluid flow,
structural deformation, fuel combustion, etc.), careful
treatment of the interface between these zones and
efficient parallel numerical algorithms. In this paper, we
outline a preliminary implementation of a parallel code
that couples the structural deformations experienced by
the rocket fuel and casing with the fluid flow in the core
of the rocket.
A code that will perform coupled multi-physics
simulations can be designed using either a monolithic or
a partitioned strategy. The monolithic approach requires
that a single new code be developed by the various
researchers who work in the different physics groups.
Global iterations are performed that simultaneously
update all of the variables in the different physics zones.
The interface conditions are enforced as part of the
global iterations. In contrast, the partitioned approach
uses existing application codes that may have been
developed by the different groups independently of any
integration effort. Interface conditions are enforced by
iteration between these different physics modules. Thus,
the partitioned approach provides a relatively
straightforward path for integration of the physics
demanded by a complete simulation of a solid rocket
motor.
The paper is constructed as follows. We first describe
the three component codes: ROCFLO, ROCSOLID and
ROCFACE. We then discuss the implementation and
parallel performance of a partitioned algorithm that
requires iteration to self-consistency between
ROCSOLID and ROCFACE. We end the paper with a
brief description of a large-scale demonstration
simulation of the space shuttle solid rocket motor.
2. ROCFLO - The Fluids Solver
ROCFLO is a CFD code developed to simulate solid
rocket booster core flow dynamics. Rocket flow
problems exhibit singular features compared to other
flow environments, primarily the fast propagating
acoustic pulses in the chamber that could potentially
cause instabilities and lead to rocket malfunction.
A three dimensional, structured, finite volume cell-
centered approach is adopted. In this framework
complex geometries are handled through a multiblock
approach. The multiblock approach also lends itself to
parallel computing. The Navier-Stokes equations are
solved on dynamic meshes whose boundaries adapt to
conform to the propellant surface that deforms due to the
loads imposed on it. Some details of the code are
presented in this section; for further details consult [1].
2.1 Governing Equations
The unsteady, three dimensional, compressible
Navier-Stokes equations on dynamic meshes may be
expressed as
..
t
+Ñ=Ñ+
U
FVS
(1)
where
U
is the set of conserved quantities,
F
is the
convective flux vector,
V
are the viscous fluxes and
S
are the source terms, i.e,
COUPLED SIMULATIONS OF SOLID
ROCKET MOTORS
2
American Institute of Aeronautics and Astronautics
11
1
222
33
3
1
1
2
2
3
3
()
()
,,
()
()
()
0
,.
ii
iii
iii
iii
i
i
i
i
ijij
ug
ugupu
ugup
u
ugupu
Eugpu
E
u
u
u
qu
E
ρ
ρ
ρδρ
ρδ
ρ
ρδρ
ρ
ρ
ρ
τ
ρ
τ
ρ
τ
ρ
τ
ρ
éù
éù
-
êú
êú
êú
êú
-+
êú
êú
êú
êú
== -+
êú
êú
êú
êú
-+
êú
êú
êú
êú
-+
êú
êú
ëû
ëû
éù
é
êú
ê
êú
ê
êú
ê
êú
ê
==-Ñ
êú
ê
êú
ê
êú
ê
êú
ê
+
êú
ë
ëû
UF
VSg .
ù
ú
ú
ú
ú
ú
ú
ú
ú
êú
û
(2)
Here,
,,,,
i
upE
ρ
g
are the density, velocity
components, pressure, energy and grid speeds,
respectively. The equations
( )
222
123
12
p
Euuu
ρ
ρ
γ
=+++
-
(3)
and
pRT
ρ
=
(4)
complete the system. The stress tensor
ij
τ
and heat
flux
i
q
are given by
2
3
j
ik
ijij
jik
u
uu
xxx
τµµδ
æö
÷
ç
÷
ç
=-++
÷
ç
÷
ç
÷
ç
÷
èø
(5)
and
i
i
T
q
x
η
=
. (6)
2.2 Numerical Method of Solution
The above set of differential laws, governing the fluid
motion of a calorically perfect gas, may be written in the
integral form
( )
.
dVUdAdV
t
+--=
òòò
UFVgnW .
(7)
Over a computational cell (control volume) the semi-
discrete form of the previous equations becomes
( ) ( )
.
faces
d
UUAW
dt
+-=
å
gnF (8)
where
F
is the numerical flux function,
is the cell
volume and
A
are its surface areas. The correction to
the fluxes due to mesh movement is .
UA
gn
. In the
coupled rocket simulations, the grid speeds arise due to
the boundary deformations induced by the fluid loads
and as computed by the structures code. For dynamic
mesh computations the geometric conservation law is
another constraint that is satisfied in the computations.
The spatial discretization schemes implemented in
ROCFLO are the central scheme with artificial
dissipation [5] and two second order TVD schemes:
Roe's flux difference splitting scheme [11] and Yee's
symmetric TVD scheme [12]. A number of limiters, i.e.,
minmod, van Leer, van Albada and Superbee, have also
been implemented. Yee's symmetric TVD scheme, along
with one of the more diffusive limiters such as minmod,
have been shown in the literature to perform very well in
rocket chamber type simulations. Consequently this
scheme is generally utilized in computations.
The flow equations are marched in time using an
explicit multistage Runge-Kutta method. For the
unsteady computations of the integrated rocket code, a
two stage method is used as well as global time stepping,
where the marching step size is limited by the smallest
time step of all the cells in the computational domain.
2.3 Parallel Code Performance
ROCFLO is implemented in Fortran90. Fortran90
offers many features useful for parallel programming
over FORTRAN77. Primary of these are the user defined
data types. A computational block may be defined as an
object and contains all data relevant to that block (node
coordinates, face normals, volumes, solutions,
parameters, etc.). This object model facilitates placement
and migration of computational blocks on processors.
The code was initially optimized for scalar performance
both with respect to minimization of operations and also
cache utilization. The scalar performance of the code is
summarized in Table 1. The code executes at about 80
Mflops on a single processor of a Origin2000.
Scheme
central scheme
central + moving grids
2nd upwind scheme
2nd upwind + moving grids
s/node/RK-stg
7
12
10
15
Table 1: Scalar performance of ROCFLO.
The parallel scalability of ROCFLO on several
architectures is depicted in Figure 1. The test problem is
scaled such that as the number of processors is increased,
the total work load for each processor is constant. The
code scales very well on both of the machines. Further
refinements are in progress.
3
American Institute of Aeronautics and Astronautics
Figure 1: ROCFLO parallel scalability.
3. ROCSOLID - The Structures Solver
ROCSOLID, the structural analysis code used in the
coupled simulations, employs a finite element
discretization of the problem domain using unstructured
meshes. Dynamic problems are solved using the implicit
Newmark time integrator [2]. The linear matrix
equations encountered within the Newton iterations at
each time step are solved using a scalable parallel
multigrid solver [8]. The code is written in Fortran90,
and uses MPI to perform interprocessor
communications.
Kp
nonblocking MPI
Figure 2: Communications during Kp calculations.
Examination of the multigrid algorithm demonstrates
that all of the operations can be performed independently
on partitioned domains [10]. In particular, the main
components of the algorithm are matrix-vector
multiplications that can be efficiently implemented
element-by-element. Interprocessor communications are
only required during the matrix-vector multiplications,
scalar products and fine-to-coarse mesh restriction.
Matrix free element computations reduce the storage and
the time requirements of our implementation; for
example, the product
Kp
, where
K
is a stiffness matrix
and
p
is the search direction in conjugate gradient
iteration, can be written as
e
eeTe
ee
dV
æö
÷
ç
÷
ç
÷
ç
==
÷
ç
÷
ç
÷
÷
ç
ç
÷
èø
åå
ò
KpKpBDBp
R
. (9)
Computations can then proceed from right to left.
10
100
1000
10000
100000
1 10 100 1000
SGI O2K
IBM SP2
CRAY T3E
Number of Processors
Mflops
Figure 3: ROCSOLID parallel performance.
Figure 2 shows the communications required by our
distributed memory implementation of the matrix-vector
products. The mesh is partitioned into a number of
domains with equal numbers of elements. The product
Kp
is formed locally on each processor using the
approach outlined in Equation (9); interprocessor
communications are then performed using nonblocking
MPI communications as shown in Figure 2.
Multigrid methods require a hierarchy of increasingly
finer meshes. We use Truegrid to produce a sequence of
nested, uniformly refined hexahedral meshes, which
allows us to model complex parts. Mesh partitioning is
performed on the coarsest mesh using Metis to achieve
perfect load balance between the processors. Uniform
refinement of the coarsest mesh partitions produces the
required partitions on all of the fine meshes. Thus,
perfect element load balance is maintained through the
mesh hierarchy, although the resulting communication
pattern may not be optimum.
Figures 3 and 4 show data that measure the parallel
performance of ROCSOLID. Both sets of data were
obtained by solving a series of scaled problems on three
different parallel computers: a 512 processor Cray T3E,
a 128 processor Origin 2000 and a 64 processor IBM
SP2. The scaled problems were constructed so that the
amount of work for each processor (as measured by the
number of elements assigned to each processor)
remained constant. Figure 3 shows the measured
performance on each of the machines. Although the
4
American Institute of Aeronautics and Astronautics
observed Mflop rates are below the maximum quoted for
the different machines, the observed values are
reasonable for an unstructured mesh solver. The scaled
speed-ups shown in Figure 4 indicate the excellent
parallel performance of ROCSOLID. In particular, the
code runs extremely well on the Cray T3E. The poorer
performance on the Origin is probably attributable to
system processes invading the dedication partition used
to collect these data.
Number of Processors
Speed-Up
1
10
100
1000
1 10 100
1000
SGI O2K
IBM SP2
CRAY T3E
Ideal
Figure 4: ROCSOLID scaled speed-ups.
4. ROCFACE - The Interface Code
The interface code handles mesh association and data
transfer between the fluid and solid meshes across
multiple processors. The mesh association algorithm is
used to determine the geometric relationship between the
two non-matching meshes by locating the closest solid
element for each fluid nodal point on the interface. Our
algorithm traverses the fluid nodes and solid elements
from neighbor to neighbor so that the closest elements
can be located quickly [6]. We perform mesh association
at every time step to track the moving interface. Since
the geometric relationship changes rather slowly
between the two meshes, from the second time step we
search for the closest element of a fluid node starting
from its closest element in the previous time step to
speed up the search.
The result of the mesh association is then used for
motion and load transfer between the fluid and solid
meshes. It is essential to ensure conservation during data
transfer; we are currently using the methods in [4].
Specifically, we transfer displacements and velocities
from solids to fluids by interpolating the values for each
fluid nodal point at its closest point on the solid mesh.
For load transfer, the nodal forces for each solid node is
evaluated as a weighed sum of the fluid nodal forces.
The method uses the same set of coefficients for both
load and motion transfer, and as a consequence,
guarantees global conservation of energy [4].
Since the fluid and solid meshes are distributed across
multiple processors, the interface code must handle
distributed meshes. In our parallel implementation, we
first compute the bounding boxes of the partitions of the
solid mesh and of the blocks of the fluid mesh. These
bounding boxes are compared to provide a quick
estimate of the geometric relationship between the solid
partitions and the fluid blocks. Then the solid partitions
adjacent to a fluid block are shipped to the processor that
owns the fluid block, and are connected together to form
a new mesh. The sequential mesh association algorithm
is then applied on each processor in parallel. As the by-
product of mesh association, a more accurate
communication pattern is obtained which is used to
communicate the physical quantities between processors
to perform data transfer. The interface code is
implemented in C++ using object-oriented techniques,
employing the CGAL library (www.cs.uu.nl/CGAL) for
the geometric primitives and the half-edge data structure
for unstructured meshes.
5. GEN1 - A Multiphysics Code for Rocket
Simulations
The three component codes described above form the
basis of our rocket motor simulation tool. The key to
successfully solving our coupled problem is to capture
the interface physics correctly. Figure 5 shows the
combustion interface between the solid and fluid
domains; the interface moves with velocity
r
&
, and has
an outward unit normal
n
measured positive into the
solid domain. Consideration of conservation of mass and
linear momentum requires that
(
)
(
)
....
ssff
m
ρρ
-=-=
rnvnrnvn
&&
(10)
and
(
)
(
)
()()
fssf
m
-+-=
nn
vvtt0
(11)
respectively. Subscripts
f
and
s
denote the fluid and
solid regions, respectively,
ρ
denotes density,
m
denotes the mass transfer into the fluid,
v
denotes
fluid
solid
Figure 5: Interface geometry.
5
American Institute of Aeronautics and Astronautics
velocity and
()
n
t
denotes tractions measured with
respect to
n
. In order to model solid rockets, we make
some simplifying assumptions regarding the motion of
the fluid-solid interface.
5.1 Stationary Interface
We first consider a stationary interface, where the
interface is constrained to move with the solid, i.e., the
interface regression rate,
r
&
, is equal to the solid
velocity,
s
v
. This assumption allows us to model the
initial burn of the motor (e.g.,
1t
<
sec), during which
the regression of the interface through the solid is small.
In order to model the effect of the mass transfer from the
propellant to the core flow, we allow the interface to
transfer mass at a rate per unit area
m
, where
n
sf
map
ρ
=
, (12)
which is a standard combustion law. Consideration of
the balance of mass and linear momentum produces
..
fs
f
m
ρ
=-+
vnvn
(13)
and
sff
pm
=-
tnv
, (14)
respectively.
5.2 Moving Interface
In a simulation of the full rocket burn, we must
consider a moving interface. Here, the interface will
move through the solid according to the chosen
combustion law. Following the standard combustion law
used for the stationary interface, we have
(
)
.
n
sf
ap
-=
rvn
&
. (15)
The no-slip fluid boundary condition requires that
(
)
.
t
fss
=-
vvvnn
(16)
and balance of mass and linear momentum require
( )
..
n
n
s
fs
f
ap
ap
ρ
ρ
=-++
vnvn
(17)
and
(
)
()() n
sfsfsf
apρ
-
=-+-
nn
ttvv
, (18)
respectively.
5.3 Predictor-Corrector Coupling Algorithms
The interface conditions presented above are enforced
using predictor-corrector cycles that iterate between the
fluid and solid discretizations until self-consistency is
1n
t
n
t
f
t
s
t
11
,
nn
tt
ff
p
++
v
11
,
nn
tt
ss
++
dv
11
,
nn
tt
ff
++
dv
1n
t
s
+
t
n
t
Figure 6: Stationary interface predictor-corrector
algorithm.
obtained within a global time step. The algorithms
follow methods described in the aeroelasticity literature
[3,7], and are outlined in Figures 6 and 7 for the
stationary and moving interfaces, respectively. To
advance the solution from time
n
t
to
1
n
t
+
by advancing
over a global time step
n
t
, we first advance the fluid
solution a number of explicit time steps (e.g., 10). This
produces estimates of the fluid interface pressure and
velocity at time
1
n
t
+
,
1
n
t
f
p
+
,
1
n
t
f
+
v
, respectively. Using
Equations (6) and (10), the tractions acting on the solid
at the interface,
1
n
t
s
+
t
, are computed. These tractions are
used as applied loads over an implicit solid time step
(
sn
tt
=
). For coupling purposes, in the case of the
stationary interface the solids calculation produces
estimates of the interface position and velocity at
1
n
t
+
,
1n
t
n
t
f
t
s
t
n
t
1n
t
f
+
v
1
,
n
t
s
+
rt
1
n
t
s
+
v
11
,,
nn
tt
ff
++
rtv
Figure 7: Moving interface predictor-corrector
algorithm.
6
American Institute of Aeronautics and Astronautics
1
n
t
s
+
d
and
1
n
t
s
+
v
; in the case of the regressing interface, the
solid calculation generates the solid velocity at the
interface
1
n
t
s
+
v
. Using Equations (5) and (9), these
quantities provide the fluid boundary conditions that can
be used to drive the explicit fluids simulation, if
necessary. In the case of the stationary interface they
also prescribe the motion of the moving boundary for the
fluid calculation; otherwise Equation (7) is used.
The procedures shown in Figures 6 and 7 are repeated
until the interface quantities have converged. We
examine the relative change of the nodal velocities,
displacements and forces on the solids side of the
interface. When these quantities are small, we assume
that the interface has converged. The algorithms used in
ROCFACE ensure that conservative operators are used
to transfer quantities across the fluids-solids interface.
0
50
100
150
0 50
100
150
ideal
NCSA O2K
Number of Processors
Speed-Up
Figure 8: GEN1 scaled speed-up.
6. GEN1 Parallel Performance
We have already demonstrated the scalable parallel
performance of the primary GEN1 components codes
ROCFLO and ROCSOLID. The partitioned approach
adopted for the coupling algorithms preserves this
perfomance for GEN1. This is demonstrated in Figure 8,
which shows the scaled speed-up of the coupled code
measured on a 128 processor Origin 2000. Good
scalability is observed, although a reduction in
performance is observed when all 128 processors are
used.
Figure 9 shows the individual time requirements of
ROCSOLID, ROCFLO and ROCFACE measured during
the scaled speed-up runs. Clearly, the time spent in
transferring data across the interface is small compared
to the computation time in the two physics codes. With
our current strategy, twice as much time is spent in
ROCSOLID than in ROCLFO. However, this is partly
due to the use of single precision arithmetic in ROCFLO
and double precision arithmetic in ROCSOLID. Current
research is being directed at investigating the trade-offs
Number of Processors
Time (secs)
0
10
20
30
40
50
60
70
116 32 64 128
Interface
Fluids
Solids
Figure 9: GEN1 division of labor on the Origin 2000.
between the time steps used in the solid and fluid
simulations, accuracy and stability of the coupling
algorithms and computational cost.
6. Space Shuttle Solid Rocket Motor Simulations
Our code is continuing to be developed to simulate a
variety of solid rocket events. As a demonstration of our
capabilities, we recently used a 256 processor
Origin2000 in dedicated mode to simulate the first 0.1
secs of the firing of the space shuttle’s solid rocket
booster. ROCFLO used a discretization of 4,000,000
cells and ROCSOLID used a mesh of 270,000 elements
(the fluid cells were typically ten times smaller in linear
dimension that the solid elements). The fluids time step
was
6
10
-
secs., resulting in a global and solids time step
of
5
10
-
secs. Further details and visualizations produced
from this simulation are available at www.csar.uiuc.edu.
Currently, our coupled simulation capability is focused
on relatively simple models of the various physical
effects in the rocket. In the future, we will augment our
basic models to include features such as thermal effects
in the propellant and case, turbulence on the core flow
and material failure in the grain. Our choice of a
partitioned coupling strategy makes these formidable
tasks possible: experts in these different fields are able to
implement their models within the basic framework
outlined in this paper, using predictor-corrector iterations
to resolve conditions at the combustion interface.
References
[1] Alavilli, P. V. S., Tafti, D. and Najjar, F. 2000. The
development of an advanced solid rocket flow
simulation program ROCFLO. AIAA Paper 2000-
0824, 38
th
AIAA Aerospace Sciences Meeting and
Exhibit, Reno, NV.
[2] Bathe, K. J., 1996. Finite element procedures.
Prentice-Hall.
7
American Institute of Aeronautics and Astronautics
[3] Farhat, C., Lesoinne, M. and Maman, N., 1995.
Mixed explicit/implicit time integration of coupled
aeroelastic problems: three-field formulation,
geometric conservation and distributed solution.
International Journal for Numerical Methods in
Fluids, 21, 807-835.
[4] Farhat, C., Lesoinne, M. and LeTallec, P., 1998.
Load and motion transfer algorithms for
fluid/structure interaction problems with non-
mathcing discrete interfaces. Computer Methods in
Applied Mechanics and Engineering, 157, 95-114.
[5] Jameson, A., Schmidt, W. and Turkel, E., 1981.
Numerical solutions of the Euler equations by finite
volume methods using Runge-Kutta time stepping
schemes. AIAA paper 81-1259.
[6] Jiao, X., Edelsbrunner, H. and Heath, M. T., 1999.
Mesh association: formulation and algorithms. 8
th
International Meshing Roundtable, South Lake
Tahoe, 75-82.
[7] Lohner, R. et al., 1995. Fluid-structure interaction
using a loose coupling algorithm and adaptive
unstructured grid. Computational Fluid Dynamics
Review 1995, John Wiley, New York, 755-776.
[8] Namazifard, A. and Parsons, I. D., 1998. Parallel
multigrid methods for structural mechanics using
Fortran 90 and MPI. Poster presentation at
Supercomputing 98.
[9] Parsons, I. D., Alavilli, P. V. S., Namazifard A.,
Hales, J. and Tafti, D., 1999. Coupled multi-physics
simulations of solid rocket motors. Proceedings of
the PDPTA'99 International Conference, 3101-3107.
[10] Parsons, I. D., 1997. Parallel adaptive multigrid
methods for elasticity, plasticity and eigenvalue
problems. Parallel Solution Methods in
Computational Mechanics, Papadrakakis, M., editor,
Wiley, 143-180.
[11] Roe, P. L., 1981. Approximate Riemann solvers,
parameter vectors, and difference schemes. Journal
of Computational Physics, 40, 263.
[12] Yee, H. C., 1987. Construction of explicit and
implicit symmetric TVD schemes and their
applications. Journal of Computational Physics, 68,
151-179.
... Given that the grain structure is rationally designed, when the comprehensive mechanical properties of propellants are good or the working temperature is not very low, the structural integrity of grain usually can be ensured under the working pressure [3]. Also, the influence from the case stiffness is not obvious, and the case design can meet the requirement of the internal pressure strength will be enough [4][5][6]. As for tactic motors in service at low temperatures, explosions occur from time to time in the ground test when the motor is working [7,8]. ...
Article
Full-text available
To investigate the influence factors of propellant grain integrity under the internal pressure, the cylindrical grain was equivalent to a thick-wall cylinder and its three-dimension stress-strain problem was solved. Under the internal and external pressure, the strain and displacement equations of the inside thick-wall cylinder were expressed, and then, the stress and strain expressions of grain were obtained. On this basis, the hoop strain equations on the inside surface of the cylindrical grain and case were developed. The hoop strain on the inner surface of the grain can be predicted by the hoop strain of the case cylinder via the strain equations, and therefore, the hoop strain in the inner surface can be indirectly monitored in real time during the working process of the motor. The hoop strain in the inner surface of grain can be effectively reduced by increasing the case stiffness or decreasing the m number of the grain.
Conference Paper
A three-dimensional parallel fluid-structure interaction simulation system which appropriate for SRM is presented. A loosely coupled approach is employed for transfer the fluid pressures and the solid surface displacements between the computational fluid dynamic (CFD) software Fluent and the computational structure dynamic (CSD) software Abaqus by MpCCI software. For simulating the propellant burning process in solid rocket motor (SRM), A User Defined Function (UDF) is written and placed in Fluent. The SRM working process is simulated by this fluid-structure interaction system. Because the CFD solutions take much longer time than the CSD solutions, the CFD computation domain is subdivided into sub-domains for parallel computations to speedup the fluid structure interaction solutions. The good parallel efficiency of the coupling system is demonstrated that this system could be used in high performance computation. The results show that this simulation system could be well performed in the SRM fluid-structure interaction problems and important to the preliminary design of SRM.
Conference Paper
Ignition and flame-spread modeling is critical for accurate analysis of the violent starting transients of solid rocket motors. Simulation of ignition transient phenomenon in such motors involves the detailed modeling of the igniter and chamber flow fields, heat transfer to the propellant, etc. A Navier-Stokes flow solver is used for the flow simulations. An efficient conductive heat transfer model is developed, and coupled to the flow solver, in order to predict ignition directly based on fundamental physics. This is unlike other approaches in literature involving empirical data. The Space Shuttle solid rocket booster with a detailed representation of the star-grain segment and igniter at the fore-end, and the nozzle at the aft-end, is simulated. Qualitatively good results are obtained in the simulations. Current simulations are limited primarily by the lack of adequate resolution and near-wall clustering in the meshes employed, with the effect that very long ignition delays are predicted compared to known test data for the RSRM. Further, a study on the effect of turbulence on ignition is performed using the Baldwin-Lomax model on a simplified cylindrical-grain motor. The results are compared to laminar flow solutions, showing significantly faster times to ignition. Future work on the RSRM will address the issue of mesh converged solutions as well as an analysis of the significance of turbulence and radiation to the ignition sequence.
Conference Paper
Simulation of solid rocket motors involves coupling of different physics including the core fluid flow, the structural response of the propellant and case, and the combustion of the propellant. We employ a staggered algorithm for time integration of our coupled system, enabling us to use separate solids and fluids code modules to perform the simulations. We study damage evolution in the propellant grain of the Titan IV SRMU PQM-1 solid rocket motor that come from two different constitutive models that are available in out center’s structural analysis code Rocsolid. The first model includes the effect of porosity on the constitutive response of a linearly viscoelastic solid and the second model uses composite homogenization theory and accounts for nonlinear viscous material response. The results demonstrate the capability of our coupling method and damage accumulation at locations where cracking has been observed to initiate during an experimental firing.
Article
We discuss the manner in which one-dimensional unsteady descriptions can be constructed from multidimensional unsteady simulations of heterogeneous propellant combustion. Spatial averaging of the heat equation within the propellant is used to generate a one-dimensional equation with a number of source terms defined by the multidimensional thermal field and surface corrugations. Each of these terms is evaluated numerically, and those that can be neglected are identified; models are defined and tested for those that cannot. Closure of the one-dimensional description is achieved by relating the mean surface regression rate and the heat flux from the combustion field at the surface to the pressure and the average surface temperature. These relations are in the form of a look-up table generated from the "exact" (multidimensional) simulations. The accuracy of the one-dimensional system is tested by comparing the predictions with those of the exact model. This is done for steady burning rates at various pressures and for the,unsteady burning response to pressure ramps and pressure pulses.
Article
Full-text available
We describe our numerical method for three- dimensional simulations of solid rocket motors in which the internal gas dynamics, the combustion of the propellant, and the structural response are fully coupled. The combustion zone is treated as a thin layer using appropriate jump conditions, and the re- gression rate is determined using a nonlinear dynamic combustion model. An Arbitrary Lagrangian- Eulerian formulation is used in the gas dynamics and structural mechanics modules to follow the regres- sion of the propellant. We demonstrate the parallel scalability of our ALE implementation and its ability to handle significant burn back of the propellant on a model problem with a very high burn rate.
Article
et Ahstract- The Fluid-Structure Interactions (FSI) phenomenon at Solid Rocket Motor (SRM) ignition transient was taken much more attention with the first prequalification motor (PQM-l) of Titan IV SRM exploded during its first full-scale static firing test. In this paper, research actuality and development trend of FSI which are from three parts-ignition gas flow, grain deformation and experiment are summarized at home and abroad. Combined with our national development conditions, the new approach on studying coupled Fluid­ Structure at SRM ignition transient are discussed preliminarily.
Article
A computational framework has been developed for predicting two-dimensional axisymmetric turbulent multi-phase (gas-particle) solid propellant rocket motor core flows. The cornerstone of this numerical scheme is a parallel block-based adaptive mesh refinement (AMR) algorithm. AMR methods are effective in resolving the multiple solution scales typical of such complex fluid flow while minimizing computational expense. The use of body-fitted mesh blocks makes the application of the block-based AMR more amenable to flows with thin boundary layers and permits anisotropic refinement as dictated by initial mesh stretching. The block-based data structure lends itself naturally to domain decomposition and thereby enables efficient and scalable implementations of the algorithm on distributed-memory multi-processor architectures. A mesh adjustment scheme has been devised in which the body-fitted multi-block mesh is locally adjusted to arbitrarily embedded boundaries that are not necessarily aligned with the mesh. Not only does this scheme allow for rapid and robust mesh generation involving complex embedded boundaries, it also enables the solution of unsteady flow problems involving bodies and interfaces moving relative to the flow domain. This allows for the modelling and treatment of the pressure dependent burning of the solid propellant. The level set method is used to treat the evolution of the burning propellant surface. A Godunov-type finite-volume scheme has been developed to accurately predict the interaction between the gas and solid particles injected into the rocket chamber at the combustion interface. Standard fourth-order Runge-Kutta and second-order predictor-corrector time-marching schemes are used for time-accurate temporal discretization. An explicit optimally-smoothing multi-stage time-stepping scheme with multigrid convergence acceleration is used for obtaining steady state solutions. The mathematical characteristics of an Eulerian formulation for the particle-phase required the development of a new solution method for the particle-phase that allows for a more physically realistic solution than was previously attainable. A novel multi-velocity formulation is proposed that can account for crossing particle trajectories by splitting the particle-phase into distinct velocity families which are transported separately. The overall proposed methodology provides a state-of-the-art framework for accurately and efficiently predicting rocket motor core flows.
Conference Paper
Full-text available
During the initial phase of design of solid propellant rocket motors it is necessary to iden-tify and quantitatively estimate deviation of internal ballistics parameters of observed rocket motors types from ideal conditions. In an initial stage of the design of real rocket motors there are differences between the rocket motor theoretical performances and actual performances based on testing of standard ballistic motors. Therefore modern numerical methods were used as a potential tool for the analysis of characteristics of combustion and gas flow in solid propellant rocket motors with specific design. Numerical simulations provide analysis of certain physical processes in rocket mo-tors, optimizing and reducing the cost of development of new rocket systems (minimizing number of models and tests). Mathematical and numerical 3D model, based on equations of mass, momentum and ener-gy conservation, describing transport processes in rocket motors, is used. Numerical simu-lation in CFD package Comet (finite volume method) was con-ducted for real gas flow through the passage channel (for propellant charge gasses), and in the front and along the nozzle. The results of numerical simulations were verified with theoretical solution for the case of quasi-steady combustion process, with available experimental data of other authors and with our own experimental studies.
Article
We describe the parallel implementation of a multigrid method for unstructured finite element discretizations of solid mechanics problems. We focus on a distributed memory programming model and use the MPI library to perform the required interprocessor communications. We present an algebraic framework for our parallel computations, and describe an object-based programming methodology using Fortran90. The performance of the implementation is measured by solving both fixed- and scaled-size problems on three different parallel computers (an SGI Origin2000, an IBM SP2 and a Cray T3E). The code performs well in terms of speedup, parallel efficiency and scalability. However, the floating point performance is considerably below the peak values attributed to these machines. Lazy processors are documented on the Origin that produce reduced performance statistics. The solution of two problems on an SGI Origin2000, an IBM PowerPC SMP and a Linux cluster demonstrate that the algorithm performs well when applied to the unstructured meshes required for practical engineering analysis. Copyright © 2004 John Wiley & Sons, Ltd.
Article
Several numerical schemes for the solution of hyperbolic conservation laws are based on exploiting the information obtained by considering a sequence of Riemann problems. It is argued that in existing schemes much of this information is degraded and that only certain features of the exact solution are worth striving for. It is shown that these features can be obtained by constructing a matrix with a certain "Property U." Matrices having this property are exhibited for the equations of steady and unsteady gasdynamics. In order to construct them, it is found helpful to introduce "parameter vectors" which notably simplify the structure of the conservation laws.
Article
A three-field arbitrary Lagrangian-Eulerian (ALE) finite element/voluem formulation for coupled transient aeroelastic problems is presented. The description includes a rigorous derivation of a geometric conservation law for flow problems with moving boundaries and unstructured deformable meshes. The solution of the coupled governing equations with a mixed explicit (fluid)/implicit (structure) staggered procedure is discussed with particular reference to accuracy, stability, distributed computing, I/O transfers, subcycling and parallel processing. A general and flexible framework for implementing partitioned solution procedures for coupled aeroelastic problems on heterogeneous and/or parallel computational platforms is described. This framework and the explicit/implicit partitioned procedures are demonstrated with the numerical investigation on an iPSC-860 massively parallel processor of the instability of flat panels with infinite aspect ratio in supersonic airstreams.
Article
The prediction of many fluid/structure interaction phenomena requires solving simultaneously the coupled fluid and structural equations of equilibrium with an appropriate set of interface boundary conditions. In this paper, we consider the realistic situation where the fluid and structure subproblems have different resolution requirements and their computational domains have non-matching discrete interfaces, and address the proper discretization of the governing interface boundary conditions. We present and overview new and common algorithms for converting the fluid pressure and stress fields at the fluid/structure interface into a structural load, and for transferring the structural motion to the fluid system. We discuss the merits of these algorithms in terms of conservation properties and solution accuracy, and distinguish between theoretically important and practically significant issues. We validate our claims and illustrate our conclusions with several transient aeroelastic simulations.
Article
The conservation-law form of the inviscid gasdynamic equations has the remarkable property that the nonlinear flux vectors are homogeneous functions of degree one. This property readily permits the splitting of flux vectors into subvectors by similarity transformations so that each subvector has associated with it a specified eigenvalue spectrum. As a consequence of flux vector splitting, new explicit and implicit dissipative finite-difference schemes are developed for first-order hyperbolic systems of equations. Appropriate one-sided spatial differences for each split flux vector are used throughout the computational field even if the flow is locally subsonic. The results of some preliminary numerical computations are included.