about (computational) fsiptf.unze.ba/wp/wp-content/uploads/2019/04/06a-is_g... · 2019-04-11 ·...

30
Introduction Governing equations Solution method Some results/benchmarking Workshop About (computational) FSI Fluid-structure interaction (FSI) - ”a class of problems with mutual dependence between the fluid and structural mechanics parts.”[CFSI, 2013] Difficult to use analytical methods due to highly nonlinear and time-dependent nature of the problem. Very few analytical analytical solutions available (using significant simplifying assumptions). Significant developments/advances in computational methods. A. Karaˇ c, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 1 / 30

Upload: others

Post on 15-Apr-2020

1 views

Category:

Documents


0 download

TRANSCRIPT

Page 1: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

About (computational) FSI

Fluid-structure interaction (FSI) - ”a class of problems with mutual dependencebetween the fluid and structural mechanics parts.”[CFSI, 2013]

Difficult to use analytical methods due to highly nonlinear and time-dependentnature of the problem.

Very few analytical analytical solutions available (using significant simplifyingassumptions).

Significant developments/advances in computational methods.

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 1 / 30

Page 2: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Problems and applications

Google/Images: fluid + structure + interaction!!!

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 2 / 30

Page 3: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Problems and applications

Can be found almost everywhere:resistance of fluid-filled plastic bottles (FSI + fracture),blood flow through arteries (atherosclerosis, aneurysms, bifurcations, . . . )impact resistance of internal organs (lungs),pipe fracture analysis,aircraft wing flattering,deflection of turbine blades,parachute dynamics,airbag inflation,. . .industry, bioengineering, space research, . . .

r

v

v =0

r

v1

?p =p0

H

a) b) c)

, �����7%)G��&�� � ���������������#�$������� �������� �!��������!������ ������%���

��

����

Imperial CollegeOF SCIENCE, TECHNOLOGY AND MEDICINE

Alveoli

(70-350 m)

Alveolar wall

(5 m thick)

Str

ess

Strain

Bulk

Damage

Scale bridging

10% 20%

30% 38%

Image sources: [Karac, 2003, Kanyanta, 2011, Kelly, 2009, Quinn, 2011, Parsa, 2012, Alakija, 2005]A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 3 / 30

Page 4: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Coupling procedures

Approaches to solve FSI problems:

a) separate analysis (partitioned) method / hybrid method (FV-FE, FV-BE, ...)

b) single analysis (partitioned) method (FE-FE, FV-FV, FD-FD)

c) single fluid-structure domain (FE, FV, FD)

Fluid

domain

Analysis

method I

Interface

program

Solid

domain

Analysis

method II

Fluid

domain

Analysis

method

Solid

domain

Fluid

Analysis

method Solid

domain

+

a) b) c)

Breakthrough for (cell-centred) FV-based FSI procedures – (solid) stress analysis usingFV methodology [Demirdzic et.al., 1988].

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 4 / 30

Page 5: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Transport equation

Standard (differential) form:

∂φ

∂t︸︷︷︸temporal derivative

+ ∇ · (vφ)︸ ︷︷ ︸convection term

−∇ · (Γφ∇φ)︸ ︷︷ ︸diffusion term

= Qφ︸︷︷︸source term

(1)

Integral form:∫V

∂φ

∂tdV +

∮S

n · (vφ) dS =

∮S

n · (Γφ∇φ) dS +

∫V

Qφ dV (2)

Parallel unstructured finite-volume method for fluid-structure interaction – asecond-order strongly coupled partitioned solution procedure in OpenFOAM[Tukovic et.al., 2018]:

fluid domain – incompressible fluid model

solid domain – St. Venant-Kirchhoff material model

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 5 / 30

Page 6: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Fluid equations (incompressible fluid model)

Mass and linear momentum conservation laws∮S

n · v dS = 0 (3)

d

dt

∫V

v dV +

∮S

n · (v − vs)v dS

=

∮S

n · (ν∇v) dS − 1

ρ

∫V

∇p dV

(4)

Geometric (space) conservation law

d

dt

∫V

dV −∮S

n · vs dS = 0 (5)

Arbitrary Lagrangian-Eulerian (ALE) formulation.

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 6 / 30

Page 7: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solid equations (St. Venant-Kirchhoff model)

The deformation of the solid can be described by the linear momentum conservationlaw in the total Lagrangian form [Tukovic et.al., 2018]:∫

V0

ρ0∂

∂t

(∂u

∂t

)dV =

∫S0

n ·(

Σ · FT)

dS +

∫V0

ρ0b dV (6)

Σ = 2µE + λ tr (E) I – the second Piola-Kirchhoff stress tensor

E = 12

[∇u + (∇u)T +∇u · (∇u)T

]– Green-Lagrange strain tensor

F = I + (∇u)T – deformation gradient tensor

σ = 1det F

F · Σ · FT - Cauchy stress tensor

ρ0

∫V0

∂t

(∂u

∂t

)dV −

∮S0

n · (2µ+ λ)∇u dS =

∮S0

n · q dS + ρ0

∫V0

b dV (7)

q = µ(∇u)T + λ tr (∇u) I− (µ+ λ)∇u

+ µ∇u · (∇u)T +1

2λ tr [∇u · (∇u)T]I + Σ · ∇u

(8)

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 7 / 30

Page 8: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Conditions at the FSI interface

The fluid and solid models are coupled by:

kinematic conditions – velocity and displacements must be continuous acrossthe interface

vf ,i = vs,i (9)

uf ,i = us,i (10)

dynamic conditions – forces at the interface are in equilibrium

ni · σf ,i = ni · σs,i (11)

σf ,i = −pI + τ = −pI + µ[∇v +∇vT

](12)

Dirichlet-Neumann procedure at the interface:

fluid solved for a given velocity/displacement (+moving mesh)

solid solved for a given traction

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 8 / 30

Page 9: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Managing data transfer

Meshing strategies:

identical meshing (and identical indexing)

arbitrary meshing

Interpolation procedures for arbitrary meshing:

Face-interpolation procedure for the interpolation from the boundary cell facesof the fluid side of the interface to the boundary cell faces of the solid side of theinterface – performed using the Generalised Grid Interface (GGI) interpolation

Vertex-interpolation procedure for the interpolation of the vertex-displacementfield from the solid side of the interface to the vertices of the fluid side of theinterface.

Polygonal faces at the solid side of the interface are decomposed intotriangles using an additional central point (centroid of the polygonal face).Vertices at the fluid side of the interface are projected to the nearesttriangle at the solid side of the interface.Displacement values at the projection points are calculated by linearinterpolation using known displacements at the triangle vertices.

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 9 / 30

Page 10: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

FSI loop

Iterative procedure (residual calculation for displacements):

{r}ki = {u}ks,i − {u}kf ,i (13)

FSI schemes:

Gauss-Seidel iteration schemes

{u}k+1f ,i = {u}kf ,i + ωk+1{r}ki (14)

fixed relaxationconvergence acceleration with Aitken relaxation

interface quasi-Newton with approximation for the inverse of the Jacobian froma least-square model (IQN-LS)

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 10 / 30

Page 11: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solution algorithm

Fluid–structure interaction iterative solution procedure

1: Switch to the next time step.2: Predict interface displacement and calculate initial interface residual.3: Start the FSI strongly coupled iterative procedure.4: Switch to the next iteration.5: Calculate the vertex-displacements of the fluid side of the interface.6: Solve mesh motion equation.7: Move the fluid mesh.8: Solve the fluid model.9: Transfer the face-centre forces from the fluid to the solid side of the interface.10: Solve the structural model.11: Transfer the vertex-displacements from the solid to the fluid side of the interface.12: Calculate interface residual at the fluid side of the interface.13: if converged then14: Go to next time step (line 1)15: else16: Go to next iteration (line 4)17: end if

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 11 / 30

Page 12: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Parallelisation

Solver is parallelised using domain decomposition approach.

FLUID

SOLID

PROC-0

PROC-1PROC-0 PROC-1

(a) Fluid and solid domains decomposedindependently into two sub-domains.

FLUID

SOLID

PROC-0

PROC-0

(b) Fluid and solid sub-domainson processor 0.

PROC-1PROC-1

FLUID

SOLID

(c) Fluid and solid sub-domainson processor 1.

i

b

i1

i0

i5

i4

i3

i2

b4 b3

b1

b2b0

PROC-0 PROC-1

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 12 / 30

Page 13: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

OpenFOAM software

The Extend Project (foam-extend [foam-extend, 2018] andOpenFOAMr [OpenFOAM, 2018] releases)

pre-processing: blockMesh utility + third-party with conversion (e.g. cfMesh,STAR-CD/PROSTAR, GAMBIT, I-DEAS, CFX)solving

basic (laplacianFoam, PODSolver, potentialDyMFoam, sixDOFSolver. . . )combustion (dieselFoam, engineFoam, fireFoam, . . . )compressible (sonicFoam, dbnsTurbFoam, sonicLiquidFoam, . . . )coupled (conjugateHeatFoam, MRFPorousFoam, . . . )discreteMethods (molecularDynamics, dsmc)DNS (dnsFoam)electromagnetics (electrostaticFoam, mhdFoam)engine (icoDyMEngineFoam, turbDyMEngineFoam, sonicTurbDyMEngineFoam)equationReaderDemofinancial (financialFoam)finiteArea (liquidFilmFoam, surfactantFoam)heatTranfser (boussinesqBuoyantFoam, boussinesqBuoyantPisoFoam, chtMultiRegionFoam, . . . )immersedBoundary (icoDyMIbFoam, porousSimpleIbFoam, . . . )incompressible (icoFoam, pisoFoam, porousSimpleFoam, . . . )lagrangian (coalChemistryFoam, reactingParcelFoam, . . . )multiphase (cavitatingFoam, bubbleFoam, settlingFoam, interFoam, twoLiquidMixingFoam, . . . )multiSolver (multiSolverDemo)solidMechanics [deprecatedSolvers (icoFsiFoam, stressedFoam, . . . ), elasticAcpSolidFoam,viscoElasticSolidFoam, elasticOrthoSolidFoam, . . . ]surfaceTracking (bubbleInterTrackFoam, interTrackFoam, . . . )viscoElastic (viscoelasticFluidFoam)

post-processing: third-party (e.g. ParaView, EnSight)

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 13 / 30

Page 14: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solvers

foam-extend-4.0 for solid/FSI analysis

solidMechanics – standard solvers for solid and FSI simulations

extend-bazaar (foam-extend-4.0/extend-bazaar) – self-contained solvers forsolid, fluid and fluid-structure interaction (Sorry!!!)

solvers – (extend-bazaar/FluidStructureInteraction/)src/solvers

fluidFoamsolidFoam (+ thermalSolidFoam)fsiFoam (+ ampFsiFoam + weakFsiFoam)

(F, S, FSI) models & libraries –(extend-bazaar/FluidStructureInteraction/)src/fluidStructureInteraction

fluidSolvers: icoFluid, consistentIcoFluid, . . . + boundary conditionssolidSolvers: unsTotalLagrangianSolid,unsIncrTotalLagrangianSolid, . . . + boundary conditionsfluidSolidInteraction

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 14 / 30

Page 15: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solvers: fluid solver (PISO)

∮S

n · v dS = 0 (15)

d

dt

∫V

v dV +

∮S

n · (v − vs)v dS =

∮S

n · (ν∇v) dS − 1

ρ

∫V

∇p dV (16)

fvVectorMatrix UEqn

(

fvm::ddt(U_)

+ fvm::div(phi_, U_)

- fvm::laplacian(nu_, U_)

);

solve(UEqn == -gradp_);

volScalarField rAU = 1.0/UEqn.A();

surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU));

fvScalarMatrix pEqn

(

fvm::laplacian

(

rAUf, p_, "laplacian((1|A(U)),p)"

)

== fvc::div(phi_)

);

pEqn.solve();

gradp_ = fvc::grad(p_);

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 15 / 30

Page 16: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solvers: solid solver

ρ0

∫V0

∂t

(∂u

∂t

)dV −

∮S0

n · (2µ+ λ)∇u dS =

∮S0

n · q dS + ρ0

∫V0

g dV (17)

q = µ(∇u)T + λ tr (∇u) I− (µ+ λ)∇u (18)

fvVectorMatrix DEqn

(

rho_*fvm::d2dt2(D_)

== fvm::laplacian(2*muf_ + lambdaf_, D_, "laplacian(DD,D)")

+ fvc::div

(

mesh().Sf()

& (

- (muf_ + lambdaf_)*gradDf_

+ muf_*gradDf_.T() + lambdaf_*(I*tr(gradDf_))

)

)

+ rho_*g

);

solverPerf = DEqn.solve();

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 16 / 30

Page 17: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Solvers: FSI solver

for (runTime++; !runTime.end(); runTime++)

{

fsi.initializeFields();

fsi.updateInterpolator();

scalar residualNorm = 0;

if (fsi.predictor())

{

fsi.updateForce();

fsi.stress().evolve();

residualNorm = fsi.updateResidual();

}

do

{

fsi.outerCorr()++;

fsi.updateDisplacement();

fsi.moveFluidMesh();

fsi.flow().evolve();

fsi.updateForce();

fsi.stress().evolve();

}

while

(

(fsi.updateResidual() > fsi.outerCorrTolerance())

&& (fsi.outerCorr() < fsi.nOuterCorr())

);

fsi.flow().updateFields();

fsi.stress().updateTotalFields();

runTime.write();

Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"

<< " ClockTime = " << runTime.elapsedClockTime() << " s"

<< nl << endl;

}

}

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 17 / 30

Page 18: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Stress analysis: plate with hole

Spatial domain

y

b

a b

tx

x

txE, ν

0.01 0.1

Average cell size, m

1e-08

1e-07

1e-06

1e-05

Cel

l dis

pla

cem

ent

erro

r, m

Present modelJ-WD-M

2nd

order

0.01 0.1

Average cell size, m

0.1

1

10

100

1000

10000

Max

imum

str

ess

erro

r, P

a

σxx

σxx

, D-M

σxx

, J-W

σxy

σxy

, D-M

σxy

, J-W

σyy

σyy

, D-M

σyy

, J-W

1st

order

2nd order

Comparisons with [Demirdzic, Muzaferija, 1995, Jasak, Weller, 2000]

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 18 / 30

Page 19: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Hron–Turek case

0.41

2.5 (0,0)

0.35

C(0.2,0.2)

0.05 A(0.6,0.2)

0.35

0.02

FSI2 FSI3

ρf , kg/m3 1000 1000

νf ,m2/s 0.001 0.001

u,m/s 1 2

ρs, kg/m3 10000 1000

Es,Pa 1.4× 106 5.6× 106

νs 0.4 0.4

(a) Deformed mesh. (b) Pressure field in fluid and equivalentstress field in solid.

ux × 10−3 [m] uy × 10−3 [m]

FSI2Benchmark −14.58± 12.44[3.8] 1.23± 80.6[2.0]Calculated −14.26± 12.34[3.9] 1.22± 80.2[1.95]

FSI3Benchmark −2.69± 2.53[10.9] 1.48± 34.38[5.3]Calculated −2.72± 2.58[11.07] 1.67± 33.84[5.53]

Fx [N] Fy [N]

FSI2Benchmark 208.83± 73.75[3.8] 0.88± 234.2[2.0]Calculated 211.34± 75.59[3.9] 1.23± 238.35[1.95]

FSI3Benchmark 457.3± 22.66[10.9] 2.22± 149.78[5.3]Calculated 459.18± 24.86[11.07] 1.59± 155.9[5.53]

Comparisons with [Turek, Hron, 2006]

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 19 / 30

Page 20: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Channel flow over elastic plate case

0 0.001 0.002 0.003 0.004 0.005

∆t, s

0.00099

0.000995

0.001

0.001005

0.00101

0.001015

0.00102

ux,

m

0.001 0.01

∆t, s

0.0001

0.001

0.01

Rel

ativ

e er

ror

2nd order s

lope

ux [m] uy [m] Fx [N] Fy [N]

Calculated 5.93× 10−5 2.40× 10−5 1.31 0.1055Benchmark 5.95× 10−5 - 1.33 -

Comparisons with [Richter, 2012]

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 20 / 30

Page 21: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Elastic tube flow case

0 0.01 0.02 0.03 0.04 0.05

Distance along axis, m

-400

-200

0

200

400

600

800

1000

1200

1400

1600

Pre

ssu

re,

Pa

0.002 s0.004 s0.006 s0.008 s0.01 s

0 2 4 6 8 10 12 14 16 18

Number of processors

0

2

4

6

8

10

12

14

16

18

20

Par

alle

l sp

eed-u

p

FSIFluidSolidLinear speed-up

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 21 / 30

Page 22: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

(Solid) Stress analysis

Basic case structure – case dictionaries:

zero-time dictionary (D, pointD): boundaryand initial conditions

system dictionaries

controlDict: case controls (time,write, . . . )fvSolution: solver parametersfvSchemes: discretisation schemes(time, gradient, laplacian, . . . )

constant dictionaries

solidProperties: model properties ⇒solverrheologyProperties: material modelpolyMesh/blockMeshDict: meshdictionary for blockMesh

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 22 / 30

Page 23: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

(Solid) Stress analysis

Case study: Axial loading (run/stressAnalysis/axial)

F=500 kN (100MPa)

L=1m

h=100mm

Rectangular cross section: width b=50mm

Material: steel (E=200GPa, =0.3, =7854 kg/m3)

Boundary and initial conditions (zero-time dictionary: D)

Stress-free (tractionDisplacement BC)

Front and back empty (plain stress or strain condition)

Specified traction

(tractionDisplacement BC)

Fixed

(fixedDisplacement BC)

Case 1: Simple steady-state axial loadingCase 2: Dynamic axial loading – stress wave propagation

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 23 / 30

Page 24: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

(Solid) Stress analysis

Case study: (Force) Bending (run/stressAnalysis/bending)

F=2.5 kN (500 kPa) L=1m

h=100mm

Rectangular cross section: width b=50mm

Material: polymer (E=2GPa, =0.35, =1200 kg/m3)

Case 3: Simple steady-state bendingCase 4: Dynamic bending – oscillations/vibrations

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 24 / 30

Page 25: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Fluid-structure interaction problems

Basic case(s) structure:

two separate cases/directories

’master’ domain: fluid (solid part to belinked)

FSI control parameters and interface set-up(fluid/constant/fsiProperties)

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 25 / 30

Page 26: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Fluid-structure interaction problems

Case 1: Flapping console

h=0.6m

L=5m

H=1m width b=25mm, depth a=200 mm

l=1m

FLUID

SOLID

INFLOW

FSI interface

– p

Boundary conditions

F: Outlet BC

p – fixed

v – zero gradient

mesh – fixed

F: Wall BC

p – extrapolated

v – fixed

mesh – fixed

F:Inlet BC

p – extrapolated

v – time-varying parabolic

F: Fluid FSI

p – extrapolated

v – moving wall velocity

mesh – fixed

S: Solid FSI

D - traction

F: Wall BC

p – extrapolated

v – fixed

mesh – slip

S: Fixed BC

D – fixed value

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 26 / 30

Page 27: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

Fluid-structure interaction problems

Case 2: Tapared tube

D=14mm

d=10mm

L=100mm

Tube wall thikness

t=0.3 mm

INFLOW FSI interface

Boundary conditions

Inlet BC

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 27 / 30

Page 28: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

References I

Yuri Bazilevs, Kenji Takizawa, Tayfun E. Tezduyar (2013),

Computational fluid-structure intaraction. A John Wiley and Sons, Ltd, Publication.

Karac, A. (2003)

Drop Impact of Polyethylene Containers. PhD thesis, Imperial College London.

Kanyanta, V. (2009)

Towards Early Diagnosis of Atherosclerosis: Accurate Prediction of Wall Shear Stress. PhD thesis,University College Dublin.

Kelly, S. (2009)

Thrombus Growth and Its Influence on the Stress Distribution in Patient-based Abdominal Aortic AneurysmModels. PhD thesis, University College Dublin.

Quinn, N. (2011)

Towards Early Diagnosis of Atherosclerosis: A Combined Experimental and Numerical Investigation into theDeformation of Mock Arterial Models. PhD thesis, University College Dublin.

Parsa, H.K. (2012)

The Development of a Novel Surrogate Lung Material for the Quantitative Prediction of Impact Trauma inHuman Lungs. PhD thesis, University College Dublin.

Alakija, O.

Modelling Visceral Injuries due to High Rate Impacts to Human Lungs. Imperial College London

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 28 / 30

Page 29: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

References II

Tukovic, Z, Karac, A., Cardiff, P., Jasak, H., Ivankovic, A. (2018),

Parallel unstructured finite-volume method for fluid-structure interaction in OpenFOAM. Accepted forpublication in FAMENA.

Demirdzic, I., Martinovic, D., Ivankovic, A (1988),

Numericka simulacija termodeformacionih procesa u zavarenom komadu. Zavarivanje, 31:209-219.

Extend-Project (2018)

The foam-extend. https://sourceforge.net/projects/foam-extend/.

OpenCFD Ltd, ESI Group (2018)

OpenFOAMr, the open source CFD toolbox. http://www.openfoam.com.

Demirdzic, I. and Muzaferija, S. (1995),

Numerical method for coupled fluid flow, heat transfer and stress analysis using unstructured moving mesheswith cells of arbitrary topology. Computer methods in applied mechanics and engineering, 125:235-255.

Jasak, H. and Weller, H. G (2000),

Application of the finite volume method and unstructured meshes to linear elasticity. International journalfor numerical methods in engineering, 48:267-287.

Turek, S. and Hron, J.,

Proposal for Numerical Benchmarking of Fluid-Structure Interaction between an Elastic Object and LaminarIncompressible Flow. in Bungartz, Hans-Joachim and Schfer (eds), Michael: Fluid-Structure Interaction,Vol.53 of Lecture Notes in Computational Science and Engineering,Springer Berlin Heidelberg, 371-385.

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 29 / 30

Page 30: About (computational) FSIptf.unze.ba/wp/wp-content/uploads/2019/04/06a-IS_G... · 2019-04-11 · IntroductionGoverning equationsSolution methodSome results/benchmarkingWorkshop About

Introduction Governing equations Solution method Some results/benchmarking Workshop

References III

Richter, Th.,

Goal-oriented error estimation for fluid-structure interaction problems. Computer Methods in AppliedMechanics and Engineering, 223-224:28-42.

A. Karac, PTF-UNZE FSI in OpenFOAM CIII-RS-1012-03-1718-M-108907 30 / 30