Coupling of VOF-Based Solver with LPT for Simulation of Cavitating Flows

Size: px
Start display at page:

Download "Coupling of VOF-Based Solver with LPT for Simulation of Cavitating Flows"

Transcription

1 Coupling of VOF-Based Solver with LPT for Simulation of Cavitating Flows Ebrahim Ghahramani Mechanics and Maritime Sciences, Chalmers University of Technology, Gothenburg, Sweden Ebrahim Ghahramani CHALMERS / 56

2 Cavitating Flows 1 Introduction Cavitating Flows Multi-scale solver 2 Multiphase Flow Methods Homogeneous mixture method Lagrangian Particle Tracking 3 Tutorial Adding LPT library to the solver Inject a bubble Implementing Rayleigh-Plesset equation Ebrahim Ghahramani CHALMERS / 56

3 Cavitating Flows Cavitation A common phenomenon in industrial hydraulic systems Cavitation erosion: the result of violent collapses of the flowing micro-bubbles on very short time scales Cavitating flows include an extensive range of cavity structures with different length scales From micro bubbles to large sheet cavities that may fully cover the surface of a hydraulic device, e.g. a hydrofoil Ebrahim Ghahramani CHALMERS / 56

4 Cavitating Flows Numerical Models Eulerian models Limited to modeling of structures larger than the computational cell Unable to resolve cavitation nuclei and bubbles Lagrangian models Unable to model large-scale non-spherical structures A hybrid multi-scale approach Ebrahim Ghahramani CHALMERS / 56

5 Multi-scale solver 1 Introduction Cavitating Flows Multi-scale solver 2 Multiphase Flow Methods 3 Tutorial Ebrahim Ghahramani CHALMERS / 56

6 Multi-scale solver Background Multi-scale solvers are popular in other applications as well; e.g. atomizing gas-liquid flows Aurélia Vallier developed a LPT-VOF solver before (OSCFD course 2011) The solver was developed by coupling of interfoam solver with Lagrangian library Today, we are going to develop a similar solver by adding the Lagrangian library to interphasechangefoam solver to make it more suitable for cavitating flows Ebrahim Ghahramani CHALMERS / 56

7 Multi-scale solver Large cavity structures are resolved by Eulerian models based on Volume of Fluid (VOF) approach Small sub-grid structures are treated as Lagrangian bubbles using the Lagrangian Particle Tracking (LPT) method Aim: To couple interphasechangefoam solver with the Lagrangian library Improving the lagrangian Library to consider bubble size variation Ebrahim Ghahramani CHALMERS / 56

8 1 Introduction 2 Multiphase Flow Methods Homogeneous mixture method Lagrangian Particle Tracking 3 Tutorial Ebrahim Ghahramani CHALMERS / 56

9 Homogeneous mixture method Eulerian Model Transport equation based method is utilized here Multiphase fluid is treated as a single fluid mixture with average properties such as density and viscosity ρ m = αρ l + (1 α)ρ v µ m = αµ l + (1 α)µ v α: liquid volume fraction Mass transfer between the phases is defined by explicit source terms Continuity equation ṁ: rate of mass transfer u i x i = ( 1 ρ l 1 ρ v )ṁ Ebrahim Ghahramani CHALMERS / 56

10 Homogeneous mixture method Navier-Stokes equation (ρ m u i ) t + (ρ mu i u j ) x j = τ ij x j + ρ m g i + S st S st : surface tension force α is obtained by solving a scalar transport equation α t + (αu i) = ṁ x i ρ l ṁ is obtained from semi-empirical cavitation models Ebrahim Ghahramani CHALMERS / 56

11 Homogeneous mixture method Homogeneous mixture method in OpenFOAM interphasechangefoam solver similar to interfoam but with mass transfer between the two phase ls $WM_PROJECT_DIR/applications/solvers/multiphase/interPhaseChangeFoam interphasechangefoam.c alphacontrols.h alphaeqn.h alphaeqnsubcycle.h createfields.h peqn.h UEqn.H interphasechangedymfoam Make phasechangetwophasemixtures Ebrahim Ghahramani CHALMERS / 56

12 Homogeneous mixture method vi createfields.h Info<< "Creating phasechangetwophasemixture\n" << endl; autoptr<phasechangetwophasemixture> mixture = phasechangetwophasemixture::new(u, phi); volscalarfield& alpha1(mixture->alpha1()); volscalarfield& alpha2(mixture->alpha2()); const dimensionedscalar& rho1 = mixture->rho1(); const dimensionedscalar& rho2 = mixture->rho2(); const dimensionedscalar& psat = mixture->psat(); phasechangetwophasemixture is a class to correct the mixture viscosity and return the source term of the continuity and volume fraction (α) equations. Ebrahim Ghahramani CHALMERS / 56

13 Homogeneous mixture method ls phasechangetwophasemixtures phasechangetwophasemixture lninclude Make SchnerrSauer Merkle Kunz The source terms are calculated using a cavitation model. Available models in OF are SchnerrSauer, Merkle and Kunz models A new class is defined for each model which inherits phasechangetwophasemixture class. Ebrahim Ghahramani CHALMERS / 56

14 Homogeneous mixture method vi createfields.h Info<< "Creating phasechangetwophasemixture\n" << endl; autoptr<phasechangetwophasemixture> mixture = phasechangetwophasemixture::new(u, phi); volscalarfield& alpha1(mixture->alpha1()); volscalarfield& alpha2(mixture->alpha2()); const dimensionedscalar& rho1 = mixture->rho1(); const dimensionedscalar& rho2 = mixture->rho2(); const dimensionedscalar& psat = mixture->psat(); alpha1 & alpha2 are the volume fractions of phases 1 & 2 rho1 & rho2 are the densities psat is the saturation pressure of the fluid; used to calculate mass transfer rate. The properties of each phase as well as the saturation pressure should defined by user as an input in the transportproperties dictionary Ebrahim Ghahramani CHALMERS / 56

15 Homogeneous mixture method vapour transport equation α t + (αu i) = ṁ +α u i α u i x i ρ l x i x i u i = ( 1 1 )ṁ x i ρ l ρ v α t + (αu i) = α u i + ( 1 α( 1 1 ))ṁ x i x i ρ l ρ l ρ v V = ( 1 ρ l α( 1 ρ l 1 ρ v ))ṁ V = α V v + (1 α) V c This is the actual term calculated by phasechangetwophasemixture Ebrahim Ghahramani CHALMERS / 56

16 Homogeneous mixture method vi alphaeqn.h Pair<tmp<volScalarField>> vdotalphal = mixture->vdotalphal(); const volscalarfield& vdotcalphal = vdotalphal[0](); const volscalarfield& vdotvalphal = vdotalphal[1](); const volscalarfield vdotvmcalphal(vdotvalphal - vdotcalphal); tmp<surfacescalarfield> talphaphi; if (MULESCorr) { fvscalarmatrix alpha1eqn ( fv::eulerddtscheme<scalar>(mesh).fvmddt(alpha1) + fv::gaussconvectionscheme<scalar> ( mesh, phi, upwind<scalar>(mesh, phi) ).fvmdiv(phi, alpha1) - fvm::sp(divu, alpha1) == fvm::sp(vdotvmcalphal, alpha1) + vdotcalphal ); Ebrahim Ghahramani CHALMERS / 56

17 Homogeneous mixture method vi peqn.h Pair<tmp<volScalarField>> vdotp = mixture->vdotp(); const volscalarfield& vdotcp = vdotp[0](); const volscalarfield& vdotvp = vdotp[1](); while (pimple.correctnonorthogonal()) { fvscalarmatrix p_rgheqn ( fvc::div(phihbya) - fvm::laplacian(rauf, p_rgh) - (vdotvp - vdotcp)*(mixture->psat() - rho*gh) + fvm::sp(vdotvp - vdotcp, p_rgh) ); Ebrahim Ghahramani CHALMERS / 56

18 Homogeneous mixture method vi UEqn.H if (pimple.momentumpredictor()) { solve ( UEqn == fvc::reconstruct ( ( interface.surfacetensionforce() - ghf*fvc::sngrad(rho) - fvc::sngrad(p_rgh) ) * mesh.magsf() ) ); } Ebrahim Ghahramani CHALMERS / 56

19 Lagrangian Particle Tracking 1 Introduction 2 Multiphase Flow Methods Homogeneous mixture method Lagrangian Particle Tracking 3 Tutorial Ebrahim Ghahramani CHALMERS / 56

20 Lagrangian Particle Tracking Discrete bubble method Tracking individual particles (bubbles) Particle p: x p, d p, u p,i and ρ p particle equation of motion m p du p,i dt dx p,i = u p,i dt (u f,i u p,i ) = m p τ p + (ρ p ρ f )g i τ p = 4 ρ p d 2 p 3 ρ f C D u f,i u p,i C D : Particle drag coefficient Ebrahim Ghahramani CHALMERS / 56

21 Lagrangian Particle Tracking Rayleigh-Plesset equation Variation of bubble radius in incompressible flows R(t) R(t) + 3 2Ṙ2 (t) = P B P l ρ l P B is the bubble pressure P B = P v + P g0 ( R0 R(t) Ṙ(t) 4ν l R(t) 2σ st ρ l R(t) ) 3k P g0 equilibrium pressure of dissolved gas and R 0 Equilibrium radius Equilibrium State R 0 3γ + 2σ st P 0 P v R 0 3γ 1 + R3γ P 0 P v ( P v 2σ ) st R P l = 0 Ebrahim Ghahramani CHALMERS / 56

22 Lagrangian Particle Tracking LPT in OpenFOAM ls $WM_PROJECT_DIR/src/lagrangian/solidParticle/ solidparticle.c solidparticlecloud.h solidparticle.h solidparticleio.c solidparticlecloud.c solidparticlecloudi.h solidparticlei.h lninclude Make Ebrahim Ghahramani CHALMERS / 56

23 Lagrangian Particle Tracking LPT in OpenFOAM solidparticlecloud: a class that contains a cloud of solid particles and track them in the flow field Subclass of Cloud<solidParticle> class Cloud is a Base cloud calls templated on particle type. Subclass of cloud class A cloud is a collection of lagrangian particles. Cloud has some general functions for tracking a collection of particles solidparticle : Subclass of the particle with additional member data and functions to track each particle Ebrahim Ghahramani CHALMERS / 56

24 Lagrangian Particle Tracking LPT in OpenFOAM In solidparticle class a new particle (object) is created Particles are tracked using the move function. ls solidparticle.h //- Construct from components inline solidparticle ( const polymesh& mesh, const vector& position, const label celli, const label tetfacei, const label tetpti, const scalar d, const vector& U );... //- Move bool move(trackingdata&, const scalar); Ebrahim Ghahramani CHALMERS / 56

25 Lagrangian Particle Tracking LPT in OpenFOAM In the move function the particle equations of motion are solved m p du p,i dt dx p,i = u p,i dt (u f,i u p,i ) = m p τ p + (ρ p ρ f )g i So, 2 types of arguments are needed 1 Equation time step: the "const scalar" in the argument list 2 Flow field data, e.g. u f, p, ρ, etc The flow field data are passed to move function via an object of the trackingdata class. The class is defined in the solidparticle class with the follwoing constructor: Ebrahim Ghahramani CHALMERS / 56

26 Lagrangian Particle Tracking LPT in OpenFOAM ls solidparticle.h inline trackingdata ( solidparticlecloud& spc, const interpolationcellpoint<scalar>& rhointerp, const interpolationcellpoint<vector>& UInterp, const interpolationcellpoint<scalar>& nuinterp, const vector& g ); The constructor arguments are some interpolationcellpoint to interpolate flow values at arbitrary points, a vector that refers to gravity vector (g), and a solidparticlecloud object (spc). Ebrahim Ghahramani CHALMERS / 56

27 Lagrangian Particle Tracking LPT in OpenFOAM ls $WM_PROJECT_DIR/src/lagrangian/solidParticle/ solidparticle.c solidparticlecloud.h solidparticle.h solidparticleio.c solidparticlecloud.c solidparticlecloudi.h solidparticlei.h lninclude Make Ebrahim Ghahramani CHALMERS / 56

28 Lagrangian Particle Tracking LPT in OpenFOAM A solidparticlecloud object is a container for particles ls solidparticlecloud.h //- Construct given mesh solidparticlecloud ( const fvmesh&, const word& cloudname = "defaultcloud", bool readfields = true ); An object is constructed in the Eulerian solver to have access to fvmesh solidparticlecloud has a different move function to pass flow data to particle group and track individual particles Ebrahim Ghahramani CHALMERS / 56

29 Lagrangian Particle Tracking LPT in OpenFOAM ls solidparticlecloud.c void Foam::solidParticleCloud::move(const dimensionedvector& g) { const volscalarfield& rho = mesh_.lookupobject<const volscalarfield>("rho"); const volvectorfield& U = mesh_.lookupobject<const volvectorfield>("u"); const volscalarfield& nu = mesh_.lookupobject<const volscalarfield>("nu"); interpolationcellpoint<scalar> rhointerp(rho); interpolationcellpoint<vector> UInterp(U); interpolationcellpoint<scalar> nuinterp(nu); solidparticle::trackingdata td(*this, rhointerp, UInterp, nuinterp, g.value()); } Cloud<solidParticle>::move(td, mesh_.time().deltatvalue()); Cloud<solidParticle>::move includes a loop over all particles which calls solidparticle::move function to track particles individually Ebrahim Ghahramani CHALMERS / 56

30 Lagrangian Particle Tracking LPT in OpenFOAM In summary, to create and track solidparticle in a solver: 1 A solidparticlecloud object should be created in the solver 2 Arbitrary number of particles (solidparticle object) are added to the solidparticlecloud object 3 The flow data are passed to the particles by creating a trackingdata object in the solidparticlecloud move function 4 Individual particles are tracked by calling the Cloud<solidParticle>::move in solidparticlecloud::move Ebrahim Ghahramani CHALMERS / 56

31 1 Introduction 2 Multiphase Flow Methods 3 Tutorial Adding LPT library to the solver Inject a bubble Implementing Rayleigh-Plesset equation Ebrahim Ghahramani CHALMERS / 56

32 Adding LPT library to the solver Solver directory cd $WM_PROJECT_USER_DIR/applications mkdir myhybridsolver cd myhybridsolver cp -r $WM_PROJECT_DIR/applications/solvers/multiphase /interphasechangefoam/*. cp $WM_PROJECT_DIR/src/lagrangian/solidParticle/*. Ebrahim Ghahramani CHALMERS / 56

33 Adding LPT library to the solver vi Make/files interphasechangefoam.c solidparticle.c solidparticleio.c solidparticlecloud.c EXE = $(FOAM_USER_APPBIN)/myHybridSolver vi Make/options -I$(LIB_SRC)/lagrangian/basic/lnInclude -I$(LIB_SRC)/finiteVolume/lnInclude -lfinitevolume -llagrangian -lsolidparticle Ebrahim Ghahramani CHALMERS / 56

34 Adding LPT library to the solver main function vi interphasechangefoam.c #include "phasechangetwophasemixture.h" #include "solidparticlecloud.h" solidparticlecloud bubbles(mesh); turbulence->validate(); bubbles.move(g); Info<< "Cloud size= "<< bubbles.size() <<endl; runtime.write(); Ebrahim Ghahramani CHALMERS / 56

35 Adding LPT library to the solver Compile the solver wmake Ebrahim Ghahramani CHALMERS / 56

36 Inject a bubble 1 Introduction 2 Multiphase Flow Methods 3 Tutorial Adding LPT library to the solver Inject a bubble Implementing Rayleigh-Plesset equation Ebrahim Ghahramani CHALMERS / 56

37 Inject a bubble Adding LPT library to interphasechangefoam Goal: Inject A buble B. We will give in a dictionary (particleproperties): position (posb) diameter (db) velocity (UB) time when injection starts and ends. And the constructor needs to know position vector cell lable diameter velocity vi solidparticle.h //- Construct from components inline solidparticle ( const polymesh& mesh, const vector& position, const label celli, const label tetfacei, const label tetpti, const scalar d, const vector& U ); Ebrahim Ghahramani CHALMERS / 56

38 Inject a bubble vi solidparticlecloud.h scalar mu_; vector posb_; scalar db_; vector UB_; scalar tinjstart_; scalar tinjend_; void move(const dimensionedvector& g); //- Inject particles according to the dictionnary particleproperties void inject(solidparticle::trackingdata &td); Ebrahim Ghahramani CHALMERS / 56

39 Inject a bubble vi solidparticlecloud.c mu_(dimensionedscalar(particleproperties_.lookup("mu")).value()), posb_(dimensionedvector(particleproperties_.lookup("posb")).value()), db_(dimensionedscalar(particleproperties_.lookup("db")).value()), UB_(dimensionedVector(particleProperties_.lookup("UB")).value()), tinjstart_(dimensionedscalar(particleproperties_.lookup("tinjstart")).value()), tinjend_(dimensionedscalar(particleproperties_.lookup("tinjend")).value()) Cloud< solidparticle>::move(td); if(mesh_.time().value()> td.cloud().tinjstart_ && mesh_.time().value()< td.cloud().tinjend_) {this->inject(td);} Ebrahim Ghahramani CHALMERS / 56

40 Inject a bubble vi solidparticlecloud.c void Foam::solidParticleCloud::inject(solidParticle::trackingData &td) { label celli = -1; label tetfacei = -1; label tetpti = -1; mesh_.findcellfacept(td.cloud().posb_, celli, tetfacei, tetpti); if(celli > 0){ solidparticle* ptr1 = new solidparticle(mesh_, td.cloud().posb_, celli, tetfacei, tetpti,td.cloud().db_, td.cloud().ub_); Cloud<solidParticle>::addParticle(ptr1); } } // ************************************************************************* // Ebrahim Ghahramani CHALMERS / 56

41 Inject a bubble Compile the solver wmake Go to the test case directory : cd $WM_PROJECT_USER_DIR/run/testCase Have a look at the injector dictionary vi constant/particleproperties rhop rhop [ ] ; e e [ ] 0.2; mu mu [ ] 0.05; posb posb [ ] ( ); db db [ ] ; UB UB [ ] (0 0 0); tinjstart tinjstart [ ] 0.075; tinjend tinjend [ ] 0.085; psat psat [ ] 2340; sigma sigma [ ] 0.07; gamma gamma [ ] 1.4; Ebrahim Ghahramani CHALMERS / 56

42 Inject a bubble Run the solver myhybridsolver > log& Have a look at the log file to check if particles were injected. Load the results in paraview touch testcase.foam paraview File Open testcase.foam Visualize the bubble: Mesh regions: lagrangian/defaultcloud Glyph: Type Sphere, Mode Scalar,Scalar d, Edit Set Scalar Factor 100 Ebrahim Ghahramani CHALMERS / 56

43 Implementing Rayleigh-Plesset equation 1 Introduction 2 Multiphase Flow Methods 3 Tutorial Adding LPT library to the solver Inject a bubble Implementing Rayleigh-Plesset equation Ebrahim Ghahramani CHALMERS / 56

44 Implementing Rayleigh-Plesset equation Rayleigh-Plesset equation Variation of bubble radius in incompressible flows R(t) R(t) + 3 2Ṙ2 (t) = P B P l ρ l P B is the bubble pressure For simplicity P B = P v + P g0 ( R0 R(t) P g0 = 0 R 0 = R t=0 Ṙ t=0 = 0 Ṙ(t) 4ν l R(t) 2σ st ρ l R(t) ) 3k Ebrahim Ghahramani CHALMERS / 56

45 Implementing Rayleigh-Plesset equation New member data In solidparticle class Description bubble radius temporal derivative of bubble radius equilibrium radius dissolved gas pressure equilibrium dissolved gas pressure bubble inside pressure a numerical variable in solving the equation a numerical variable in solving the equation In the solver R_ Rdt_ R0_ pg_ pg0_ pb_ F0Old_ F1Old_ Ebrahim Ghahramani CHALMERS / 56

46 Implementing Rayleigh-Plesset equation New member data In solidparticlecloud class Description liquid saturation pressure liquid surface tension coefficient In the solver psat_ sigma_ In trackingdata class Description interpolator for surrounding pressure In the solver pinterp_ Ebrahim Ghahramani CHALMERS / 56

47 Implementing Rayleigh-Plesset equation vi solidparticle.h vector U_; scalar R_; // -radius scalar Rdt_; // -r_dot scalar R0_; // initial equilibrium radius scalar pb_; // bubble inside pressure scalar pg0_; // dissolved gas pressure at equilibrium scalar pg_; // dissolved gas pressure scalar F0Old_; scalar F1Old_; Ebrahim Ghahramani CHALMERS / 56

48 Implementing Rayleigh-Plesset equation vi solidparticle.h const interpolationcellpoint<scalar>& nuinterp_; const interpolationcellpoint<scalar>& pinterp_; const interpolationcellpoint<scalar>& nuinterp, const interpolationcellpoint<scalar>& pinterp, inline const interpolationcellpoint<scalar>& nuinterp() const; inline const interpolationcellpoint<scalar>& pinterp() const; bool move(trackingdata&, const scalar); void initialequilibriumcondition(); Ebrahim Ghahramani CHALMERS / 56

49 Implementing Rayleigh-Plesset equation vi solidparticlei.h const interpolationcellpoint<scalar>& nuinterp, const interpolationcellpoint<scalar>& pinterp, nuinterp_(nuinterp), pinterp_(pinterp), inline const Foam::interpolationCellPoint<Foam::scalar>& Foam::solidParticle::trackingData::pInterp() const { return pinterp_; } // ************************************************************************* // Ebrahim Ghahramani CHALMERS / 56

50 Implementing Rayleigh-Plesset equation vi solidparticle.c scalar nuc = td.nuinterp().interpolate(cpw); scalar pc = td.pinterp().interpolate(cpw); U_ = (U_ + dt*(dc*uc + (1.0 - rhoc/rhop)*td.g()))/(1.0 + dt*dc); #include "RP_Solver.H" // ODE solution algorithm for R-P equation void Foam::solidParticle::initialEquilibriumCondition(){ Rdt_ = 0.0; R_ = 0.5*d_; R0_ = R_; pg0_ = 0.0; pg_ = 0.0; } // ************************************************************************* // Ebrahim Ghahramani CHALMERS / 56

51 Implementing Rayleigh-Plesset equation vi solidparticlecloud.h scalar tinjend_; scalar psat_; // saturation pressure scalar sigma_; // surface tenstion inline scalar mu() const; inline scalar psat() const; inline scalar sigma() const; Ebrahim Ghahramani CHALMERS / 56

52 Implementing Rayleigh-Plesset equation vi solidparticlecloudi.h inline Foam::scalar Foam::solidParticleCloud::pSat() const { return psat_; } inline Foam::scalar Foam::solidParticleCloud::sigma() const { return sigma_; } // ************************************************************************* // Ebrahim Ghahramani CHALMERS / 56

53 Implementing Rayleigh-Plesset equation vi solidparticlecloud.c tinjend_(dimensionedscalar(particleproperties_.lookup("tinjend")).value()), psat_(dimensionedscalar(particleproperties_.lookup("psat")).value()), sigma_(dimensionedscalar(particleproperties_.lookup("sigma")).value()) const volscalarfield& nu = mesh_.lookupobject<const volscalarfield>("nu"); const volscalarfield& p = mesh_.lookupobject<const volscalarfield>("p"); interpolationcellpoint<scalar> nuinterp(nu); interpolationcellpoint<scalar> pinterp(p); td(*this, rhointerp, UInterp, nuinterp, pinterp, g.value()); ptr1->initialequilibriumcondition() Cloud<solidParticle>::addParticle(ptr1); Ebrahim Ghahramani CHALMERS / 56

54 Implementing Rayleigh-Plesset equation Compile the solver wmake Go to the test case directory : cd $WM_PROJECT_USER_DIR/run/testCase Have a look at the injector dictionary vi constant/particleproperties rhop rhop [ ] ; e e [ ] 0.2; mu mu [ ] 0.05; posb posb [ ] ( ); db db [ ] ; UB UB [ ] (0 0 0); tinjstart tinjstart [ ] 0.075; tinjend tinjend [ ] 0.085; psat psat [ ] 2340; sigma sigma [ ] 0.07; gamma gamma [ ] 1.4; Ebrahim Ghahramani CHALMERS / 56

55 Implementing Rayleigh-Plesset equation Run the solver myhybridsolver > log& Have a look at the log file to check if particles were injected. Load the results in paraview touch testcase.foam paraview File Open testcase.foam Visualize the bubble: Mesh regions: lagrangian/defaultcloud Glyph: Type Sphere, Mode Scalar,Scalar d, Edit Set Scalar Factor 0.5 Ebrahim Ghahramani CHALMERS / 56

56 Implementing Rayleigh-Plesset equation Problem description Channel dimension: 10m*1m Inlet pressure: 2.2 kpa Outlet pressure: 1.5 kpa Bubble initial diameter: 4 mm Ebrahim Ghahramani CHALMERS / 56

57 Implementing Rayleigh-Plesset equation Result Ebrahim Ghahramani CHALMERS / 56

CFD with OpenSource software

CFD with OpenSource software CFD with OpenSource software A course at Chalmers University of Technology Taught by HÅKAN NILSSON Project work: intersettlingfoam Developed for OpenFOAM-2.2.0 Author: Pedram Ramin Peer reviewed by: Olivier

More information

Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend

Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend Mohammad Hossein Arabnejad Mechanics and Maritime Sciences/Marine Technology, Chalmers University of Technology,

More information

Flow boiling implementation with OpenFoam

Flow boiling implementation with OpenFoam Flow boiling implementation with OpenFoam Qingming Liu KTH,Department of Energy contents Introduction Background Physical and mathmatic models Implementation on OpenFoam Transport model Solvers Boundary

More information

Introduction. Haukur Elvar Hafsteinsson. OpenFOAM - Porous Media 1. The Governing Equations. The Class. The solver. Porous media as a flow control

Introduction. Haukur Elvar Hafsteinsson. OpenFOAM - Porous Media 1. The Governing Equations. The Class. The solver. Porous media as a flow control Introduction The Governing Equations The Class The solver Porous media as a flow control Porous media in cylindrical coordinates Available at the course home page: http://www.tfd.chalmers.se/ hani/kurser/os_cfd_2008/

More information

How to implement your own turbulence model (1/3)

How to implement your own turbulence model (1/3) How to implement your own turbulence model 1/3) The implementations of the turbulence models are located in $FOAM_SRC/turbulenceModels Copy the source of the turbulence model that is most similar to what

More information

CFD with OpenSource software A course at Chalmers University of Technology Taught by HÅKAN NILSSON. Project work: intersettlingfoam

CFD with OpenSource software A course at Chalmers University of Technology Taught by HÅKAN NILSSON. Project work: intersettlingfoam Taught by HÅKAN NILSSON Project work: intersettlingfoa Developed for OpenFOAM-2.2.0 Author: Pedra Rain Deceber, 2013 2/21/2014 1 Presentation Outline: The objective of this presentation Introduction to

More information

viscousheatingsolver Martin Becker

viscousheatingsolver Martin Becker viscousheatingsolver Adding temperature transport and viscous heating to simplefoam Solver and Test Case Martin Becker martin_becker@dhcae-tools.de 11/09/2012 Abstract The modifications of the simplefoam

More information

Magnetic induction and electric potential solvers for incompressible MHD flows

Magnetic induction and electric potential solvers for incompressible MHD flows Magnetic induction and electric potential solvers for incompressible MHD flows Alessandro Tassone DIAEE - Nuclear Section, Sapienza Università di Roma, Rome, Italy 05/12/2016 Alessandro Tassone CMHD Solvers

More information

Lecture 2: Fundamentals 2/3: Navier-Stokes Equation + Basics of Discretization

Lecture 2: Fundamentals 2/3: Navier-Stokes Equation + Basics of Discretization Lecture 2: Fundamentals 2/3: Navier-Stokes Equation Basics of Discretization V.Vuorinen Aalto University School of Engineering CFD Course, Spring 2018 January 15th 2018, Otaniemi ville.vuorinen@aalto.fi

More information

Description of poroussimplefoam and adding the Brinkmann model to the porous models Developed for OpenFOAM-2.2.x

Description of poroussimplefoam and adding the Brinkmann model to the porous models Developed for OpenFOAM-2.2.x CFD with OpenSource Software A course at Chalmers University of Technology Taught by Hakan Nilsson Project work: Description of poroussimplefoam and adding the Brinkmann model to the porous models Developed

More information

Implementing Vortex Lattice Representation of Propeller Sections

Implementing Vortex Lattice Representation of Propeller Sections CFD with OpenSource Software 2014 Implementing Vortex Lattice Representation of Propeller Sections Developed for OpenFOAM-2.3.x Surya Kiran Peravali Chalmers University of Technology, Gothenburg, Sweden.

More information

How to implement your own turbulence model(1/3)

How to implement your own turbulence model(1/3) How to implement your own turbulence model(1/3) The implementations of the turbulence models are located in $FOAM_SRC/turbulenceModels Copythesourceoftheturbulencemodelthatismostsimilartowhatyouwanttodo.Inthis

More information

The implementation of Two-equation SGS turbulence model and Wall damping function

The implementation of Two-equation SGS turbulence model and Wall damping function The implementation of Two-equation SGS turbulence model and Wall damping function Yeru Shang Thermo-fluid Mechanics Research Centre, The University of Sussex, Brighton, UK 2017-11-21 Yeru Shang The implementation

More information

Computations of unsteady cavitating flow on wing profiles using a volume fraction method and mass transfer models

Computations of unsteady cavitating flow on wing profiles using a volume fraction method and mass transfer models Computations of unsteady cavitating flow on wing profiles using a volume fraction method and mass transfer models Tobias Huuva *, Aurelia Cure, Göran Bark * and Håkan Nilsson * Chalmers University of Technology,

More information

Rhie-Chow interpolation in OpenFOAM 1

Rhie-Chow interpolation in OpenFOAM 1 Rhie-Chow interpolation in OpenFOAM 1 Fabian Peng Kärrholm Department of Applied Mechanics Chalmers Univesity of Technology Göteborg, Sweden, 2006 1 Appendix from Numerical Modelling of Diesel Spray Injection

More information

High-level programming in OpenFOAM and a first glance at C++

High-level programming in OpenFOAM and a first glance at C++ High-level programming in OpenFOAM and a first glance at C++ Håkan Nilsson, Chalmers / Applied Mechanics / Fluid Dynamics 1 Solving PDEs with OpenFOAM The PDEs we wish to solve involve derivatives of tensor

More information

Porous Media in OpenFOAM

Porous Media in OpenFOAM Chalmers Spring 2009 Porous Media in OpenFOAM Haukur Elvar Hafsteinsson Introduction This tutorial gives a detailed description of how to do simulations with porous media in OpenFOAM-1.5. The porous media

More information

High-level programming in OpenFOAM and a first glance at C++

High-level programming in OpenFOAM and a first glance at C++ High-level programming in OpenFOAM and a first glance at C++ Håkan Nilsson, Chalmers / Mechanics and Maritime Sciences / Fluid Dynamics 1 Solving PDEs with OpenFOAM The PDEs we wish to solve involve derivatives

More information

Description and validation of the rotordisksource class for propeller performance estimation

Description and validation of the rotordisksource class for propeller performance estimation Description and validation of the rotordisksource class for propeller performance estimation Alexandre Capitao Patrao Department of Mechanics and Maritime Sciences Division of Fluid Dynamics Chalmers University

More information

Lagrangian Particle Tracking

Lagrangian Particle Tracking FD with OpenFOAM software Lagrangian article Tracking Jelena Andric December 2009, Gothenburg About multiphase flows great importance can occur even more frequently than single phase flows correct formulation

More information

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch Transport equation cavitation models in an unstructured flow solver Kilian Claramunt, Charles Hirsch SHF Conference on hydraulic machines and cavitation / air in water pipes June 5-6, 2013, Grenoble, France

More information

MODELLING OF MULTIPHASE FLOWS

MODELLING OF MULTIPHASE FLOWS MODELLING OF MULTIPHASE FLOWS FROM MICRO-SCALE TO MACRO-SCALE Department of Applied Mechanics, University of Technology, Gothenburg, Sweden. Siamuf Seminar October 2006 OUTLINE 1 GROUP PHILOSOPHY 2 PROJECTS

More information

Numerical Modelling of Twin-screw Pumps Based on Computational Fluid Dynamics

Numerical Modelling of Twin-screw Pumps Based on Computational Fluid Dynamics Numerical Modelling of Twin-screw Pumps Based on Computational Fluid Dynamics 6-8 th March 2017 Dr Sham Rane, Professor Ahmed Kovačević, Dr Di Yan, Professor Qian Tang, Centre for Compressor Technology,

More information

OpenFOAM Course Final Assignment: Tutorial for Natural Convection Boundary Layer

OpenFOAM Course Final Assignment: Tutorial for Natural Convection Boundary Layer OpenFOAM Course Final Assignment: Tutorial for Natural Convection Boundary Layer Abolfazl Shiri 751028-2051 1 Introduction The aim of this project is to simulate the natural convection boundary layer along

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

Force analysis of underwater object with supercavitation evolution

Force analysis of underwater object with supercavitation evolution Indian Journal of Geo-Marine Sciences Vol. 42(8), December 2013, pp. 957-963 Force analysis of underwater object with supercavitation evolution B C Khoo 1,2,3* & J G Zheng 1,3 1 Department of Mechanical

More information

Solving PDEs with OpenFOAM

Solving PDEs with OpenFOAM Solving PDEs with OpenFOAM ThePDEswewishtosolveinvolvederivativesoftensorfieldswith respect to time and space ThePDEsmustbediscretizedintimeandspacebeforewesolve them WewillstartbyhavingalookatalgebraoftensorsinOpenFOAM

More information

Modifying buoyantpimplefoam for the Simulation of Solid-Liquid Phase Change with Temperature-dependent Thermophysical Properties

Modifying buoyantpimplefoam for the Simulation of Solid-Liquid Phase Change with Temperature-dependent Thermophysical Properties Cite as: Hummel, D.: Modifying buoyantpimplefoam for the Simulation of Solid-Liquid Phase Change with Temperature-dependent Thermophysical Properties. In Proceedings of CFD with OpenSource Software, 2017,

More information

CFD modelling of multiphase flows

CFD modelling of multiphase flows 1 Lecture CFD-3 CFD modelling of multiphase flows Simon Lo CD-adapco Trident House, Basil Hill Road Didcot, OX11 7HJ, UK simon.lo@cd-adapco.com 2 VOF Free surface flows LMP Droplet flows Liquid film DEM

More information

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk D. Fuster, and S. Popinet Sorbonne Universités, UPMC Univ Paris 6, CNRS, UMR 79 Institut Jean Le Rond d Alembert,

More information

Implementation of Turbulent Viscosity from EARSM for Two Equation Turbulence Model

Implementation of Turbulent Viscosity from EARSM for Two Equation Turbulence Model CFD with OpenSource software A course at Chalmers University of Technology Taught by Håkan Nilsson Project work: Implementation of Turbulent Viscosity from EARSM for Two Equation Turbulence Model Developed

More information

Solving PDEs with OpenFOAM

Solving PDEs with OpenFOAM Solving PDEs with OpenFOAM ThePDEswewishtosolveinvolvederivativesoftensorfieldswith respect to time and space The PDEs must be discretized in time and space before we solve them We will start by having

More information

VIRTUE / WP4 Delft Twisted Foil in steady flow Simulation with EOLE

VIRTUE / WP4 Delft Twisted Foil in steady flow Simulation with EOLE 6 th Framework Programme "Sustainable development, global change and ecosystems" Project No. 516201 / WP4 Delft Twisted Foil in steady flow Simulation with EOLE Workshop Oct. 17-18, 2007 R. Marcer Principia

More information

Computational Analysis of an Imploding Gas:

Computational Analysis of an Imploding Gas: 1/ 31 Direct Numerical Simulation of Navier-Stokes Equations Stephen Voelkel University of Notre Dame October 19, 2011 2/ 31 Acknowledges Christopher M. Romick, Ph.D. Student, U. Notre Dame Dr. Joseph

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Description of reactingtwophaseeulerfoam solver with a focus on mass transfer modeling terms

Description of reactingtwophaseeulerfoam solver with a focus on mass transfer modeling terms Description of reactingtwophaseeulerfoam solver with a focus on mass transfer modeling terms Submitted by: Thummala Phanindra Prasad, Environmental Engineering Department, Anadolu University of Technology,

More information

Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics. Derivation of Rayleigh and Rayleigh-Plesset Equations:

Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics. Derivation of Rayleigh and Rayleigh-Plesset Equations: Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics Derivation of Rayleigh and Rayleigh-Plesset Equations: Let us derive the Rayleigh-Plesset Equation as the Rayleigh equation can

More information

Master thesis of Behrang Mohajer Matr

Master thesis of Behrang Mohajer Matr Politecnico di Milano Energy Department Master program of Energy Engineering for an Environmentally Sustainably World Development of a CFD solver for simulating the cavitating nitrogen flow inside a cutting

More information

A multiscale framework for lubrication analysis of bearings with textured surface

A multiscale framework for lubrication analysis of bearings with textured surface A multiscale framework for lubrication analysis of bearings with textured surface *Leiming Gao 1), Gregory de Boer 2) and Rob Hewson 3) 1), 3) Aeronautics Department, Imperial College London, London, SW7

More information

Tutorial XiFoam. Applied Mechanics Department Chalmers University of Technology. CFD with OpenSource software, assignment 3

Tutorial XiFoam. Applied Mechanics Department Chalmers University of Technology. CFD with OpenSource software, assignment 3 Applied Mechanics Department Chalmers University of Technology CFD with OpenSource software, assignment 3 Tutorial XiFoam Version: OpenFOAM-1.7.x Author: Ehsan Yasari Peer reviewed by: Josef Runsten Jelena

More information

Description of AdjointShapeOptimizationFoam and how to implement new cost functions

Description of AdjointShapeOptimizationFoam and how to implement new cost functions Description of AdjointShapeOptimizationFoam and how to implement new cost functions A project work in the course CFD with OpenSource software, taught by Håkan Nilsson. Chalmers University of Technology,

More information

Relationship between Cavitation Incipient and NPSH Characteristic for Inverter Drive Centrifugal Pumps

Relationship between Cavitation Incipient and NPSH Characteristic for Inverter Drive Centrifugal Pumps 1) 논문 Original Paper DOI: http://dx.doi.org/10.5293/kfma.2015.18.6.076 ISSN (Print): 2287-9706 Relationship between Cavitation Incipient and NPSH Characteristic for Inverter Drive Centrifugal Pumps Md

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

Nonlinear shape evolution of immiscible two-phase interface

Nonlinear shape evolution of immiscible two-phase interface Nonlinear shape evolution of immiscible two-phase interface Francesco Capuano 1,2,*, Gennaro Coppola 1, Luigi de Luca 1 1 Dipartimento di Ingegneria Industriale (DII), Università di Napoli Federico II,

More information

An Assessment of CFD Cavitation Models Using Bubble Growth Theory and Bubble Transport Modeling

An Assessment of CFD Cavitation Models Using Bubble Growth Theory and Bubble Transport Modeling An Assessment of CFD Cavitation Models Using Bubble Growth Theory and Bubble Transport Modeling Michael P. Kinzel 1 *, Robert F. Kunz, Jules W. Lindau 1 SYMPOSIA ON ROTATING MACHINERY ISROMAC 017 International

More information

Modeling Complex Flows! Direct Numerical Simulations! Computational Fluid Dynamics!

Modeling Complex Flows! Direct Numerical Simulations! Computational Fluid Dynamics! http://www.nd.edu/~gtryggva/cfd-course/! Modeling Complex Flows! Grétar Tryggvason! Spring 2011! Direct Numerical Simulations! In direct numerical simulations the full unsteady Navier-Stokes equations

More information

Target Simulations. Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu

Target Simulations. Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu Muon Collider/Neutrino Factory Collaboration Meeting May 26 28, CERN, Geneva U.S. Department of Energy Target Simulations Roman Samulyak in collaboration with Y. Prykarpatskyy, T. Lu Center for Data Intensive

More information

Direct Numerical Simulations of Gas-Liquid Flows

Direct Numerical Simulations of Gas-Liquid Flows Direct Numerical Simulations of Gas-Liquid Flows 1 Gretar Tryggvason*; 1 Jiacai Lu; 2 Ming Ma 1 Johns Hopkins University, Baltimore, MD, USA; 2 University of Notre Dame, Notre Dame, IN, USA Introduction

More information

Coupled calculations in OpenFOAM -

Coupled calculations in OpenFOAM - Coupled calculations in OpenFOAM - Multiphysics handling, structures and solvers, Gothenburg Region OpenFOAM User Group Meeting Klas Jareteg Chalmers University of Technology November 14, 2012 Outline

More information

OpenFOAM selected solver

OpenFOAM selected solver OpenFOAM selected solver Roberto Pieri - SCS Italy 16-18 June 2014 Introduction to Navier-Stokes equations and RANS Turbulence modelling Numeric discretization Navier-Stokes equations Convective term {}}{

More information

Create a DES turbulence model from komegasst RANS model. 8 th OFWS training by D. Chrisk Revised by Y. Takagi Open CAE

Create a DES turbulence model from komegasst RANS model. 8 th OFWS training by D. Chrisk Revised by Y. Takagi Open CAE Create a DES turbulence model from komegasst RANS model 8 th OFWS training by D. Chrisk Revised by Y. Takagi Open CAE seminar@kansai, 2013.7.6 1 Turbulent flow simulapon DNS LES RANS Modeling No Subgrid

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Investigation of Cavitation Bubble Cloud with discrete Lagrangian Tracking

Investigation of Cavitation Bubble Cloud with discrete Lagrangian Tracking Investigation of Cavitation Bubble Cloud with discrete Lagrangian Tracking Xiuxiu Lyu, Xiangyu Hu, Nikolaus A. Adams Chair of Aerodynamics and Fluid Mechanics, Department of Mechanical Engineering, Technical

More information

Experimental and Numerical Investigation of Two- Phase Flow through Enlarging Singularity

Experimental and Numerical Investigation of Two- Phase Flow through Enlarging Singularity Purdue University Purdue e-pubs International Refrigeration and Air Conditioning Conference School of Mechanical Engineering 212 Experimental and Numerical Investigation of Two- Phase Flow through Enlarging

More information

Simulating the effect of in-nozzle cavitation on liquid atomisation using a three-phase model

Simulating the effect of in-nozzle cavitation on liquid atomisation using a three-phase model Simulating the effect of in-nozzle cavitation on liquid atomisation using a three-phase model M.G. Mithun*,1, P. Koukouvnis 1, I. K. Karathanassis 1, M. Gavaises 1 1 City, University of London, UK Abstract

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Physics-Based Animation

Physics-Based Animation CSCI 5980/8980: Special Topics in Computer Science Physics-Based Animation 13 Fluid simulation with grids October 20, 2015 Today Presentation schedule Fluid simulation with grids Course feedback survey

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

Cavitation modeling for steady-state CFD simulations

Cavitation modeling for steady-state CFD simulations IOP Conference Series: Earth and Environmental Science PAPER OPEN ACCESS Cavitation modeling for steady-state CFD simulations To cite this article: L. Hanimann et al 2016 IOP Conf. Ser.: Earth Environ.

More information

Hybrid RANS/LES simulations of a cavitating flow in Venturi

Hybrid RANS/LES simulations of a cavitating flow in Venturi Hybrid RANS/LES simulations of a cavitating flow in Venturi TSFP-8, 28-31 August 2013 - Poitiers - France Jean Decaix jean.decaix@hevs.ch University of Applied Sciences, Western Switzerland Eric Goncalves

More information

RANS COMPUTATIONS OF A CAVITATING VORTEX ROPE AT FULL LOAD

RANS COMPUTATIONS OF A CAVITATING VORTEX ROPE AT FULL LOAD 6 th IAHR International Meeting of the Workgroup on Cavitation and Dynamic Problems in Hydraulic Machinery and Systems, September 9-11, 2015, Ljubljana, Slovenia RANS COMPUTATIONS OF A CAVITATING VORTEX

More information

PORE-SCALE SIMULATION OF MASS TRANSFER ACROSS IMMISCIBLE INTERFACES

PORE-SCALE SIMULATION OF MASS TRANSFER ACROSS IMMISCIBLE INTERFACES PORE-SCALE SIMULATION OF MASS TRANSFER ACROSS IMMISCIBLE INTERFACES A report submitted to the department of Energy Resources Engineering of Stanford University in partial fulfillment of the requirements

More information

Improvement of lagrangian approach for multiphase flow

Improvement of lagrangian approach for multiphase flow Matteo Nobile Improvement of lagrangian approach for multiphase flow 2014/12/1-2 1/40 Improvement of lagrangian approach for multiphase flow (Project for the course CFD with OpenSource Software, 2014 )

More information

Adding electric conduction and Joule heating to chtmultiregionfoam Niklas Järvstråt

Adding electric conduction and Joule heating to chtmultiregionfoam Niklas Järvstråt CFD with open source software, assignment 3: Adding electric conduction and Joule heating to chtmultiregionfoam Niklas Järvstråt Reviewed by Arash Eslamdoost 1 Table of contents 1.Physical background and

More information

NUMERICAL SIMULATION OF TRANSIENT SLURRY-CAVITATED MULTIPHASE FLOWS

NUMERICAL SIMULATION OF TRANSIENT SLURRY-CAVITATED MULTIPHASE FLOWS ISTP-1, 005, PRAGUE 1 TH INTERNATIONAL SYMPOSIUM ON TRANSPO PHENOMENA NUMERICAL SIMULATION OF TRANSIENT SLURRY-CAVITATED MULTIPHASE FLOWS Yang-Yao Niu and Yee-Ming Lin Institute of Mechanical and Aerospace

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

C C C C 2 C 2 C 2 C + u + v + (w + w P ) = D t x y z X. (1a) y 2 + D Z. z 2

C C C C 2 C 2 C 2 C + u + v + (w + w P ) = D t x y z X. (1a) y 2 + D Z. z 2 This chapter provides an introduction to the transport of particles that are either more dense (e.g. mineral sediment) or less dense (e.g. bubbles) than the fluid. A method of estimating the settling velocity

More information

CYDAR User Manual Two-phase flow module with chemical EOR

CYDAR User Manual Two-phase flow module with chemical EOR CYDAR User Manual Two-phase flow module with chemical EOR 1 CYDAR - Two-phase flow module with chemical EOR CYDAR USER MANUAL TWO-PHASE FLOW MODULE WITH CHEMICAL EOR... 1 CYDAR - TWO-PHASE FLOW MODULE

More information

Cavitation Control on Hydrofoils

Cavitation Control on Hydrofoils Proceedings of the International Conference on Heat Transfer and Fluid Flow Prague, Czech Republic, August 11-12, 2014 Paper No. 181 Cavitation Control on Hydrofoils Mohammad Mortezazadeh, Ali Katal, Khodayar

More information

NUMERICAL SIMULATION OF THREE DIMENSIONAL GAS-PARTICLE FLOW IN A SPIRAL CYCLONE

NUMERICAL SIMULATION OF THREE DIMENSIONAL GAS-PARTICLE FLOW IN A SPIRAL CYCLONE Applied Mathematics and Mechanics (English Edition), 2006, 27(2):247 253 c Editorial Committee of Appl. Math. Mech., ISSN 0253-4827 NUMERICAL SIMULATION OF THREE DIMENSIONAL GAS-PARTICLE FLOW IN A SPIRAL

More information

CFD with OpenSource software. Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend

CFD with OpenSource software. Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend Cite as: Arabnejad, M. H.: Implementation of HLLC-AUSM low-mach scheme in a density-based compressible solver in FOAM-extend. In Proceedings of CFD with OpenSource Software, 2016, Edited by Nilsson. H.,

More information

A solver for Boussinesq shallow water equations

A solver for Boussinesq shallow water equations A solver for Boussinesq shallow water equations Dimitrios Koukounas Department of Mechanics and Maritime sciences Chalmers University of Technology, Gothenburg, Sweden 2017-11-23 Dimitrios Koukounas Beamer

More information

chinaxiv: v1

chinaxiv: v1 Journal of Thermal Science Vol.6, No.1 (017) 18 4 DOI: 10.1007/s11630-017-0904-0 Article ID: 1003-169(017)01-0018-07 Numerical Study of Unsteady Flows with Cavitation in a High-Speed Micro Centrifugal

More information

Height function interface reconstruction algorithm for the simulation of boiling flows

Height function interface reconstruction algorithm for the simulation of boiling flows Computational Methods in Multiphase Flow VI 69 Height function interface reconstruction algorithm for the simulation of boiling flows M. Magnini & B. Pulvirenti Dipartimento di Ingegneria Energetica, Nucleare

More information

CAVITATION PREDICTION IN A KAPLAN TURBINE USING STANDARD AND OPTIMIZED MODEL PARAMETERS

CAVITATION PREDICTION IN A KAPLAN TURBINE USING STANDARD AND OPTIMIZED MODEL PARAMETERS 6 th IAHR International Meeting of the Workgroup on Cavitation and Dynamic Problems in Hydraulic Machinery and Systems, September 9-11, 2015, Ljubljana, Slovenia CAVITATION PREDICTION IN A KAPLAN TURBINE

More information

CFD in COMSOL Multiphysics

CFD in COMSOL Multiphysics CFD in COMSOL Multiphysics Mats Nigam Copyright 2016 COMSOL. Any of the images, text, and equations here may be copied and modified for your own internal use. All trademarks are the property of their respective

More information

A suite of boundary conditions for the simulation of atmospheric ows using a modied RANS/k ε closure

A suite of boundary conditions for the simulation of atmospheric ows using a modied RANS/k ε closure 6th OpenFOAM Workshop Penn State, State College, USA A suite of boundary conditions for the simulation of atmospheric ows using a modied RANS/k ε closure J. Sumner, C. Masson École de technologie supérieure

More information

A Fast Lumped Parameter Approach for the Prediction of Cavitation in Gerotor Pumps

A Fast Lumped Parameter Approach for the Prediction of Cavitation in Gerotor Pumps Georgia Institute of Technology Marquette University Milwaukee School of Engineering North Carolina A&T State University Purdue University University of California, Merced University of Illinois, Urbana-Champaign

More information

SHARP INTERFACE CAVITATION MODELING USING VOLUME-OF-FLUID AND LEVEL SET METHODS

SHARP INTERFACE CAVITATION MODELING USING VOLUME-OF-FLUID AND LEVEL SET METHODS Proceedings of the ASME 2013 Fluids Engineering Summer Meeting FEDSM2013 July 7-11, 2013, Incline Village, Nevada, USA FEDSM2013-16479 SHARP INTERFACE CAVITATION MODELING USING VOLUME-OF-FLUID AND LEVEL

More information

NUMERICAL INVESTIGATION OF PERFORMANCE OF KAPLAN TURBINE WITH DRAFT TUBE

NUMERICAL INVESTIGATION OF PERFORMANCE OF KAPLAN TURBINE WITH DRAFT TUBE NUMERICAL INVESTIGATION OF PERFORMANCE OF KAPLAN TURBINE WITH DRAFT TUBE Mohamed Adel and Nabil H. Mostafa ABSTRACT Mechanical Power Engineering Department, Engineering Faculty Zagazig University, Zagazig,

More information

The effect of momentum flux ratio and turbulence model on the numerical prediction of atomization characteristics of air assisted liquid jets

The effect of momentum flux ratio and turbulence model on the numerical prediction of atomization characteristics of air assisted liquid jets ILASS Americas, 26 th Annual Conference on Liquid Atomization and Spray Systems, Portland, OR, May 204 The effect of momentum flux ratio and turbulence model on the numerical prediction of atomization

More information

Presentation for the course «CFD with OpenSource Software» Alexey Vdovin Chalmers University of Technology

Presentation for the course «CFD with OpenSource Software» Alexey Vdovin Chalmers University of Technology Presentation for the course «CFD with OpenSource Software» Alexey Vdovin Chalmers University of Technology Agenda(1) Introduction Addition of the radiation heat transfer to the solver Radiation models

More information

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Outline DEM overview DEM capabilities in STAR-CCM+ Particle types and injectors Contact physics Coupling to fluid flow

More information

Document downloaded from:

Document downloaded from: Document downloaded from: http://hdl.handle.net/10251/67555 This paper must be cited as: Payri González, F.; Payri, R.; Salvador Rubio, FJ.; Martínez López, J. (2012). A contribution to the understanding

More information

Chapter 5 Control Volume Approach and Continuity Equation

Chapter 5 Control Volume Approach and Continuity Equation Chapter 5 Control Volume Approach and Continuity Equation Lagrangian and Eulerian Approach To evaluate the pressure and velocities at arbitrary locations in a flow field. The flow into a sudden contraction,

More information

Bejo Duka Ergys Rexhepi. Department of Physics, Faculty of Natural Sciences, UNIVERSITY OF TIRANA

Bejo Duka Ergys Rexhepi. Department of Physics, Faculty of Natural Sciences, UNIVERSITY OF TIRANA Bejo Duka Ergys Rexhepi Department of Physics, Faculty of Natural Sciences, UNIVERSITY OF TIRANA constant surface temperature received much attention because of the theoretical interest and the wide engineering

More information

Vortex cavitation and oscillation in a doublesuction

Vortex cavitation and oscillation in a doublesuction IOP Conference Series: Earth and Environmental Science Vortex cavitation and oscillation in a doublesuction volute pump To cite this article: T Sato et al 2010 IOP Conf. Ser.: Earth Environ. Sci. 12 012019

More information

Stratified scavenging in two-stroke engines using OpenFOAM

Stratified scavenging in two-stroke engines using OpenFOAM Stratified scavenging in two-stroke engines using OpenFOAM Håkan Nilsson, Chalmers / Applied Mechanics / Fluid Dynamics 1 Acknowledgements I would like to thank Associate Professor Håkan Nilsson at the

More information

Modelling of phase change for Two-Phase Refrigerant Flow inside Capillary Tube under Adiabatic Conditions

Modelling of phase change for Two-Phase Refrigerant Flow inside Capillary Tube under Adiabatic Conditions International Journal of Current Engineering and Technology E-ISSN 2277 4106, P-ISSN 2347 5161 2016 INPRESSCO, All Rights Reserved Available at http://inpressco.com/category/ijcet Research Article Modelling

More information

Development of a consistent and conservative Eulerian - Eulerian algorithm for multiphase flows

Development of a consistent and conservative Eulerian - Eulerian algorithm for multiphase flows Development of a consistent and conservative Eulerian - Eulerian algorithm for multiphase flows Ana Cubero Alberto Sanchez-Insa Norberto Fueyo Numerical Fluid Dynamics Group University of Zaragoza Spain

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Modeling of Humidification in Comsol Multiphysics 4.4

Modeling of Humidification in Comsol Multiphysics 4.4 Modeling of Humidification in Comsol Multiphysics 4.4 Indrajit Wadgaonkar *1 and Suresh Arikapudi 1 1 Tata Motors Ltd. Pimpri, Pune, India, 411018. *Corresponding author: Indrajit Wadgaonkar, Tata Motors

More information

Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and Boundary Condition

Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and Boundary Condition ILASS-Americas 25th Annual Conference on Liquid Atomization and Spray Systems, Pittsburgh, PA, May 23 Detailed Numerical Simulation of Liquid Jet in Cross Flow Atomization: Impact of Nozzle Geometry and

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Modelling of single bubble-dynamics and thermal effects

Modelling of single bubble-dynamics and thermal effects Journal of Physics: Conference Series PAPER OPEN ACCESS Modelling of single bubble-dynamics and thermal effects To cite this article: D Papoulias and M Gavaises 205 J. Phys.: Conf. Ser. 656 02098 View

More information

Study of an Expanding, Spherical Gas Bubble in a Liquid under Gravity when the Centre Moves in a Vertical Plane

Study of an Expanding, Spherical Gas Bubble in a Liquid under Gravity when the Centre Moves in a Vertical Plane Int. J. Contemp. Math. Sciences, Vol. 5, 2010, no. 22, 1065-1075 Study of an Expanding, Spherical Gas Bubble in a Liquid under Gravity when the Centre Moves in a Vertical Plane G. S. Tuteja 1, Dinesh Khattar

More information

Part IV: Numerical schemes for the phase-filed model

Part IV: Numerical schemes for the phase-filed model Part IV: Numerical schemes for the phase-filed model Jie Shen Department of Mathematics Purdue University IMS, Singapore July 29-3, 29 The complete set of governing equations Find u, p, (φ, ξ) such that

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

A Coupled VOF-Eulerian Multiphase CFD Model To Simulate Breaking Wave Impacts On Offshore Structures

A Coupled VOF-Eulerian Multiphase CFD Model To Simulate Breaking Wave Impacts On Offshore Structures A Coupled VOF-Eulerian Multiphase CFD Model To Simulate Breaking Wave Impacts On Offshore Structures Pietro Danilo Tomaselli Ph.d. student Section for Fluid Mechanics, Coastal and Maritime Engineering

More information

Measuring microbubble clustering in turbulent flow

Measuring microbubble clustering in turbulent flow Slide 1 Measuring microbubble clustering in turbulent flow Enrico Calzavarini University of Twente The Netherlands In collaboration with T. H van den Berg, S. Luther, F. Toschi, D. Lohse Slide 2 Motivation

More information