the virtual test facility: an infrastructure for shock-driven fluid-structure interaction simulation...

1
The Virtual Test Facility: an Infrastructure for Shock-driven Fluid- Structure Interaction Simulation Adlib finite element solver • Hexahedral solver in 3d • Parallel explicit dynamics • Solid modeling • Fully scalable unstructured parallel meshing • Thermo-mechanical coupling and multi- physics model • Extensive constitutive library – single and polycrystal plasticity – ab-initio equation of state • shock physics, artificial viscosity • Contact • Fracture and fragmentation Dyna3d finite element solver • General-purpose software for complex, real-world problems with mixed elements • Serial version supported for now Finite difference beam solver • Implicit 1d solver for demonstration and verification purposes Available CSD solvers SFC finite element solver • Tetrahedral thin-shell solver in 3d • Subdivision shell finite elements – Stretching and bending resistance – Large deformations • Parallel explicit shell dynamics – Fully scalable communications • Geometric modeling capabilities • Access to a number of constitutive models – Adlib models as well as own implementations • Parallel contact • Fracture and fragmentation with cohesive interface elements Amroc fluid solver framework • Encapsulates dynamic mesh adaptation and parallelization to the fluid solver developer – Numerical scheme only for single block necessary • Available 3d patch solvers: – WENO-TCD LES upwind scheme for turbulence simulations – Riemann-solver-based MUSCL and Wave Propagation schemes for simplified and detailed chemistry • Implementation of Berger-Collela SAMR algorithm coupled to generic ghost-fluid implementation for multiple level sets • Conservative correction for purely Cartesian problems Right: LES of turbulent jet with WENO-TCD patch solver . Fluid-Structure coupling • Coupling of Euler equations for com- pressible flow to Lagrangian structure mechanics • Compatibility conditions between inviscid fluid and solid at a slip interface Continuity of normal velocity u S n = u F n Continuity of normal stresses S nn = -p F No shear stresses S n = S n = 0 • Interpolation operations with solid surface mesh –Mirrored fluid density and velocity values u F into ghost cells –Solid velocity values u S on facets –Fluid pressure values in surface points (nodes or face centroids) Coupling of Eulerian SAMR to a non-adaptive CSD solver Exploit SAMR time step refinement for effective coupling to solid solver Lagrangian simulation is called only at level l c <l max SAMR refines solid boundary at least at level l c – One additional level reserved to resolve ambiguities in GFM (e.g. thin structures) • Nevertheless: Inserting sub-steps accommodates for time step reduction from time- explicit CSD solvers within an SAMR cycle Abstract. The Virtual Test Facility is an infrastructure for the coupled simulation of shock- and detonation-wave-driven fluid- structure interaction problems. The key idea of the VTF is to orchestrate the boundary data exchange between Lagrangian solid mechanics solvers and Eulerian fluid mechanics schemes through a ghost fluid approach in which complex embedded boundaries are implicitly represented with evolving level set functions. The level set information is derived on-the-fly with the Closest-point transform (CPT) algorithm. The VTF software is constructed on top of the block-structured Cartesian SAMR framework Amroc and provides straightforward interfaces to incorporate any unstructured computa- tional solid mechanics (CSD) solver. • Communication strategy –Updated boundary info from solid solver must be received (blue arrow) before regridding operation (gray dots and arrows) –Boundary data is sent to solid (red arrow) when highest level available • Inter-solver communication (point-to-point or globally) managed on-the-fly by Eulerian- Lagrangian-Coupling module (ELC) Ralf Deiterding, Fehmi Cirak, Sean P. Mauch, Daniel I. Meiron California Institute of Technology Center for Dynamic Response of Materials California Institute of Technology Mail-Code 158-79 Pasadena, CA 91125 http:// www.cacr.caltech.edu/asc Reference configuration Deformed configuration cohesive interface Fluid processors Solid processors Update boundary Send boundary location and velocity Receive boundary Update boundary pressures using interpolation Send boundary pressures Receive boundary pressures Apply pressure boundary conditions Stable time step multiplied by N Stabe time step Next time step Efficient non- blocking boundary synchro- nization exchange (ELC) Compute level set via CPT and set ghost fluid cells according to AMR algorithm AMR Fluid solve Solid solve Treatment of lower-dimensional thin-shells • Thin boundary structures require “thickening” • Unsigned distance level set function • Treat cells with 0<<d as ghost fluid cells (gray) • Leaving level set unmodified ensures correctness of r • Refinement criterion based on ensures reliable mesh adaptation • Use face normal in shell element to evaluate in p= p + – p - p + p - Right: Coupling algorithm: data exchange between dedicated fluid and solid processors. F1 Time S1 S5 S3 S7 S2 S6 S4 S8 F2 l=0 l=2 l=l=1 c F5 F3 F6 F4 F7 Fractured thin-shell kinematics used in SFC. Water-hammer-driven plate deformation Piston-induced strong pressure wave in water shock tube impinges on thin copper plate. Fluid Correct pressure wave profile generated by propagating upper tube boundary according to equation of motion for piston Water shock tube of 1.3m length, 64mm diameter Two-component solver, modeling of water with stiffened gas EOS with =7.415, p 1 =296.2 MPa, air with ideal gas EOS with =1.4 No tensile stresses allowed (cavitation threshold set to 0.0 Pa). AMR base level: 350x20x20, 2 additional levels, refinement factors 2, 2 Approx. 1.2 . 10 6 cells used in fluid on average instead of 9 . 10 6 (uniform) Solid - SFC Copper plate of 0.25mm thickness, J2 plasticity model with hardening, rate sensitivity, and thermal softening Shell mesh: 4675 nodes, 8896 elements 8 nodes 3.4 GHz Intel Xeon dual processor, Gigabit Ethernet network, ca. 130h CPU Shock-induced motion of a thin panel Verification and demo simulation Mach-1.21 inflow in air ( =1.4, P 0 =100kPa, 293K) impinges on thin steel panel of 1mm thickness and 50mm length Fluid Two-dimensional 0.4m x 0.08m flow domain with forward facing step geometry, reflective boundaries everywhere except inflow on left side. AMR base mesh 320x64, 2 additional levels with factors 2, 4 Solid – 1d beam solver using Euler-Bernoulli theory 80 finite difference points in beam middle axis Panel situated 1.5cm behind start of step, elastic material 4 nodes 3.4 GHz Intel Xeon dual processor, Gigabit Ethernet network, ca. 54h CPU (7 fluid processors, 1 solid processor) +set_patch() NumericalS cheme +set_patch_boundary() BoundaryConditions +set_patch() InitialC onditions +next_step() +advance_level() +update_level() +regrid() H ypSA M R Solver 1 1 1 1 +restrict_patch() +prolong_patch() LevelTransfer +find_boxes() C lustering +flux_correction() +add_fine_fluxes() +add_coarse_fluxes() Fixup +recreate_patches() G ridFunction dim :int,data_type 1 +VectorO fState 1 +set_new _boxes() +redistribute_hierachy() G ridH ierarchy -follow s distribution 0..* 1 Patch dim :int,data_type 1 0..* Box 1 0..* 0..1 1 Tim eStepC ontroler +evaluate() C riterion +flag_patch() Flagging 0..* 1 1 +Flags 1 0..1 1 1 0..1 1 -dF 1..* 1 1 0..1 1 0..1 1 +fluid_step() -advance_level() -stable_fluid_tim estep() C oupledH ypSA M R Solver +next_step() C oupledSolver 1 1 1 1 +solid_step() -stable_solid_tim estep() C oupledSolidSolver 1 1 +send_interface_data() +receive_interface_data() InterSolverC om m unication 1 1 1 1 Em beddedMovingW alls +cpt() -scan_convert() C losestPointTransform 1 1 +update_solid() SolidSolver 1 1 +calculate_in_patch() Extra-/Interpolation +apply_boundary_conditions() Em beddedB oundaryM ethod +set_patch() LevelS etE valuation EB M H ypSA M R Solver 0..*1 +set_cells_in_patch() EmbeddedBoundaryConditions 1 1 1 -phi 1 0..1 1 1 1 Detonation-driven fracture of thin aluminum tubes Motivation: Validate VTF for complex fluid-structure interaction problem • Interaction of detonation, ductile deformation, fracture Fluid Constant volume burn model with =1.24, P CJ =6.1MPa, D CJ =2402m/s (Right: flow field before specimen) • 40x40x725 cells unigrid Solid - SFC • Material model for cohesive interface: linearly decreasing envelope • Shell mesh: 206,208 nodes • 972h CPU with 33 shell and 21 fluid processors on ALC at LLNL UML class diagram for the VTF. Right half: most important classes in Cartesian Amroc. Left side: Extensions for implementing the generic ghost fluid method and coupling with a CSD solver. VTF software design The VTF is constructed on top of the Amroc class hierarchy in a C++ framework approach. The design acknowledges the greater complexity on the Eulerian side in our coupling approach. Applications use one generic main program that instantiates predetermined objects. Objects can be extensively customized by C++ class derivation. Problem-specific routines (initial conditions, boundary conditions) are provided in F77/90 or C/C++. Right: Schlieren plot of fluid density in the vicinity of the thin steel panel. Snapshots for t=0.51ms, 1.63ms, and 3.02ms (from top to bottom). Vortex shedding from panel tip and beam vibration induced by shock impact. Right: Preliminary simula-tion with plate fracture. The fluid density in the mid-plane visualizes the water splash. The solid mesh displays the velocity in direction of the tube axis. Left: velocity in direction of tube axis in plate and fluid (lower half of plane) and fluid pressure (upper half of plane) 1.62ms after piston impact. Right: plate at end of simulation and after experiment. Conclusions. A flexible C++ framework for fluid-structure interaction has been developed. It uses components in Fortran 77/90 (fluid patch solvers) and C (bulk material models). The approach is tailored to high-speed events (shock waves, detonations) with large material deformation and strongly coupled response. Three- dimensional fluid-structure interaction simulations with arbitrary topology evolutions allowing for fracture and fragmentation are possible. Dynamic mesh adaptation can be used in the fluid to decrease the computational costs significantly. Scalable MPI paralleliza-tion allows the effective utilization of the ASC machines to achieve results in minimal real time. Further information and links to publications can be found under http://www.cacr.caltech.edu/asc .

Post on 21-Dec-2015

219 views

Category:

Documents


4 download

TRANSCRIPT

Page 1: The Virtual Test Facility: an Infrastructure for Shock-driven Fluid-Structure Interaction Simulation Adlib finite element solver Hexahedral solver in 3d

The Virtual Test Facility: an Infrastructure for Shock-driven Fluid-Structure Interaction Simulation

Adlib finite element solver

• Hexahedral solver in 3d• Parallel explicit dynamics• Solid modeling• Fully scalable unstructured parallel

meshing• Thermo-mechanical coupling and multi-

physics model • Extensive constitutive library

– single and polycrystal plasticity– ab-initio equation of state

• shock physics, artificial viscosity• Contact• Fracture and fragmentation

Dyna3d finite element solver

• General-purpose software for complex, real-world problems with mixed elements

• Serial version supported for now

Finite difference beam solver

• Implicit 1d solver for demonstration and verification purposes

Available CSD solvers

SFC finite element solver

• Tetrahedral thin-shell solver in 3d• Subdivision shell finite elements

– Stretching and bending resistance– Large deformations

• Parallel explicit shell dynamics– Fully scalable communications

• Geometric modeling capabilities• Access to a number of constitutive models

– Adlib models as well as own implementations

• Parallel contact• Fracture and fragmentation with cohesive

interface elements

Amroc fluid solver framework• Encapsulates dynamic mesh adaptation and parallelization to

the fluid solver developer– Numerical scheme only for single block necessary

• Available 3d patch solvers:– WENO-TCD LES upwind scheme for turbulence simulations– Riemann-solver-based MUSCL and Wave Propagation

schemes for simplified and detailed chemistry• Implementation of Berger-Collela SAMR algorithm coupled to

generic ghost-fluid implementation for multiple level sets• Conservative correction for purely Cartesian problems

Right: LES of turbulent jet with WENO-TCD patch solver .

Fluid-Structure coupling• Coupling of Euler equations for com-

pressible flow to Lagrangian structure mechanics

• Compatibility conditions between inviscid fluid and solid at a slip interface

Continuity of normal velocity uS

n = uFn

Continuity of normal stresses S

nn = -pF

No shear stresses S

n = Sn = 0

• Interpolation operations with solid surface mesh

–Mirrored fluid density and velocity values uF into ghost cells

–Solid velocity values uS on facets–Fluid pressure values in surface

points (nodes or face centroids)

Coupling of Eulerian SAMR to a non-adaptive CSD solverExploit SAMR time step refinement for effective coupling to solid solver

– Lagrangian simulation is called only at level lc <lmax

– SAMR refines solid boundary at least at level lc– One additional level reserved to resolve ambiguities in GFM (e.g. thin structures)

• Nevertheless: Inserting sub-steps accommodates for time step reduction from time-explicit CSD solvers within an SAMR cycle

Abstract. The Virtual Test Facility is an infrastructure for the coupled simulation of shock- and detonation-wave-driven fluid-structure interaction problems. The key idea of the VTF is to orchestrate the boundary data exchange between Lagrangian solid mechanics solvers and Eulerian fluid mechanics schemes through a ghost fluid approach in which complex embedded boundaries are implicitly represented with evolving level set functions. The level set information is derived on-the-fly with the Closest-point transform (CPT) algorithm. The VTF software is constructed on top of the block-structured Cartesian SAMR framework Amroc and provides straightforward interfaces to incorporate any unstructured computa-tional solid mechanics (CSD) solver.

• Communication strategy–Updated boundary info from solid solver must be received

(blue arrow) before regridding operation (gray dots and arrows)

–Boundary data is sent to solid (red arrow) when highest level available

• Inter-solver communication (point-to-point or globally) managed on-the-fly by Eulerian-Lagrangian-Coupling module (ELC)

Ralf Deiterding, Fehmi Cirak, Sean P. Mauch, Daniel I. MeironCalifornia Institute of Technology

Center for Dynamic Response of MaterialsCalifornia Institute of TechnologyMail-Code 158-79Pasadena, CA 91125http://www.cacr.caltech.edu/asc

Reference configuration Deformed configurationcohesive interface

Fluid processorsFluid processors Solid processorsSolid processors

Update boundaryUpdate boundary

Send boundarylocation and

velocity

Send boundarylocation and

velocity

Receive boundary Receive boundary

Update boundary pressures

using interpolation

Update boundary pressures

using interpolation

Send boundary pressures

Send boundary pressures

Receive boundary pressures

Receive boundary pressures

Apply pressure boundary conditions

Apply pressure boundary conditions

Stable time step multiplied by NStable time step multiplied by NStabe time stepStabe time step Nexttime step

Nexttime step

Efficientnon-

blocking boundary synchro-nization

exchange(ELC)

Efficientnon-

blocking boundary synchro-nization

exchange(ELC)

Compute level set via CPT and set ghost fluid cells according

to AMR algorithm

Compute level set via CPT and set ghost fluid cells according

to AMR algorithm

AMR Fluid solveAMR Fluid solve

Solid solveSolid solve

Treatment of lower-dimensional thin-shells• Thin boundary structures require “thickening” • Unsigned distance level set function • Treat cells with 0<<d as ghost fluid cells (gray)• Leaving level set unmodified ensures correctness of r• Refinement criterion based on ensures reliable mesh adaptation• Use face normal in shell element to evaluate in p= p+– p-

p+

p-

Right: Coupling algorithm: data exchange between dedicated fluid and solid processors.

F1

Time

S1 S5S3 S7S2 S6S4 S8

F2

l=0

l=2

l=l =1c

F5

F3 F6F4 F7

Fractured thin-shell kinematics used in SFC.

Water-hammer-driven plate deformationPiston-induced strong pressure wave in water shock tube impinges on thin copper plate.Fluid• Correct pressure wave profile generated by propagating upper tube boundary according

to equation of motion for piston• Water shock tube of 1.3m length, 64mm diameter• Two-component solver, modeling of water with stiffened gas EOS with =7.415, p1=296.2

MPa, air with ideal gas EOS with =1.4• No tensile stresses allowed (cavitation threshold set to 0.0 Pa).• AMR base level: 350x20x20, 2 additional levels, refinement factors 2, 2• Approx. 1.2.106 cells used in fluid on average instead of 9.106 (uniform)

Solid - SFC• Copper plate of 0.25mm thickness, J2 plasticity model with hardening, rate sensitivity,

and thermal softening • Shell mesh: 4675 nodes, 8896 elements • 8 nodes 3.4 GHz Intel Xeon dual processor, Gigabit Ethernet network, ca. 130h CPU

Shock-induced motion of a thin panel• Verification and demo simulation• Mach-1.21 inflow in air (=1.4, P0=100kPa, 293K) impinges on thin steel

panel of 1mm thickness and 50mm lengthFluid• Two-dimensional 0.4m x 0.08m flow domain with forward facing step

geometry, reflective boundaries everywhere except inflow on left side.• AMR base mesh 320x64, 2 additional levels with factors 2, 4Solid – 1d beam solver using Euler-Bernoulli theory• 80 finite difference points in beam middle axis• Panel situated 1.5cm behind start of step, elastic material• 4 nodes 3.4 GHz Intel Xeon dual processor, Gigabit Ethernet network,

ca. 54h CPU (7 fluid processors, 1 solid processor)

+set_patch()

NumericalScheme

+set_patch_boundary()

BoundaryConditions

+set_patch()

InitialConditions

+next_step()+advance_level()+update_level()+regrid()

HypSAMRSolver

1

1

1

1+restrict_patch()+prolong_patch()

LevelTransfer

+find_boxes()

Clustering

+flux_correction()+add_fine_fluxes()+add_coarse_fluxes()

Fixup

+recreate_patches()

GridFunction

dim:int, data_type

1

+VectorOfState1

+set_new_boxes()+redistribute_hierachy()

GridHierarchy

-follows distribution0..*

1

Patch

dim:int, data_type

1 0..*

Box1 0..*

0..1

1

TimeStepControler

+evaluate()

Criterion

+flag_patch()

Flagging

0..*1

1 +Flags

1

0..1

1

1

0..1

1

-dF

1..*

1

1

0..1

10..1

1

+fluid_step()-advance_level()-stable_fluid_timestep()

CoupledHypSAMRSolver

+next_step()

CoupledSolver

1

1

11

+solid_step()-stable_solid_timestep()

CoupledSolidSolver

1

1

+send_interface_data()+receive_interface_data()

InterSolverCommunication

11

1

1

EmbeddedMovingWalls+cpt()-scan_convert()

ClosestPointTransform

11

+update_solid()

SolidSolver

11

+calculate_in_patch()

Extra-/Interpolation

+apply_boundary_conditions()

EmbeddedBoundaryMethod

+set_patch()

LevelSetEvaluation

EBMHypSAMRSolver0..*1

+set_cells_in_patch()

EmbeddedBoundaryConditions

1

1

1

-phi

10..1 1

1

1Detonation-driven fracture of thin aluminum tubesMotivation: Validate VTF for complex fluid-structure interaction problem• Interaction of detonation, ductile deformation, fracture

Fluid

• Constant volume burn model with =1.24, PCJ =6.1MPa,

DCJ=2402m/s (Right: flow field before specimen)

• 40x40x725 cells unigrid

Solid - SFC• Material model for cohesive interface: linearly

decreasing envelope• Shell mesh: 206,208 nodes• 972h CPU with 33 shell and 21 fluid processors on ALC at LLNL

UML class diagram for the VTF. Right half: most important classes in Cartesian Amroc. Left side: Extensions for implementing the generic ghost fluid method and coupling with a CSD solver.

VTF software designThe VTF is constructed on top of the Amroc class hierarchy in a C++ framework approach. • The design acknowledges the greater complexity on the Eulerian side in our coupling approach.• Applications use one generic main program that instantiates predetermined objects. • Objects can be extensively customized by C++ class derivation.• Problem-specific routines (initial conditions, boundary conditions) are provided in F77/90 or C/C++.

Right: Schlieren plot of fluid density in the vicinity of the thin steel panel. Snapshots for t=0.51ms, 1.63ms, and 3.02ms (from top to bottom). Vortex shedding from panel tip and beam vibration induced by shock impact.

Right: Preliminary simula-tion with plate fracture. The fluid density in the mid-plane visualizes the water splash. The solid mesh displays the velocity in direction of the tube axis.

Left: velocity in direction of tube axis in plate and fluid (lower half of plane) and fluid pressure (upper half of plane) 1.62ms after piston impact. Right: plate at end of simulation and after experiment.

Conclusions. A flexible C++ framework for fluid-structure interaction has been developed. It uses components in Fortran 77/90 (fluid patch solvers) and C (bulk material models). The approach is tailored to high-speed events (shock waves, detonations) with large material deformation and strongly coupled response. Three-dimensional fluid-structure interaction simulations with arbitrary topology evolutions allowing for fracture and fragmentation are possible. Dynamic mesh adaptation can be used in the fluid to decrease the computational costs significantly. Scalable MPI paralleliza-tion allows the effective utilization of the ASC machines to achieve results in minimal real time. Further information and links to publications can be found under http://www.cacr.caltech.edu/asc.