A Finite Particle Approach for the Simulation of Multiphase Flows

Size: px
Start display at page:

Download "A Finite Particle Approach for the Simulation of Multiphase Flows"

Transcription

1 ILASS-Americas 29th Annual Conference on Liquid Atomization and Spray Systems, Atlanta, GA, May 2017 A Finite Particle Approach for the Simulation of Multiphase Flows E.A. Wenzel and S.C. Garrick Department of Mechanical Engineering University of Minnesota Minneapolis, MN USA Abstract The simulation of multiphase flows presents challenges related to accuracy and affordability, particularly for practitioners in industrial settings where computational time is a significant constraint. In response to the need for improved multiphase models, we present a coupled Eulerian-Lagrangian multiphase methodology called the Lagrangian volume of fluid. In this method, Lagrangian phase-identifying particles seeded throughout the computational domain define the local phase, interface geometry, and surface tension force, while the Navier-Stokes equations are solved on an Eulerian mesh. The finite particle method is used to compute the interfacial geometry and surface tension on the Lagrangian particles as a function of their volume of fluid values and spatial distribution. Unlike other methods, the approach is free of remeshing and retains identical Lagrangian domain mass conservation (independent of resolution). Breakup and coalescence occur without explicit modeling, allowing for the capture of primary and secondary atomization. We present the method and apply it to the simulation of multiphase mixing layers and the capillary breakup of droplets to illustrate physical realizability and to demonstrate its sensitivity to numerical parameters including particle number density. Eulerian mass conservation errors are shown to be less than 0.02% for temporal mixing layers undergoing sheet breakup. Conservation errors in laminar capillary breakup are greater, ranging between 1.5% and 2.5%, which is attributable to interpolation errors near merging characteristics. The inherent Lagrangian domain mass conservation and sub-grid scale resolution provided by the phase-identifying particles makes the approach a promising foundation for large eddy simulation. Corresponding Author: wenz0081@umn.edu

2 Introduction Successful control of sprays requires a thorough understanding of primary atomization, but spray dynamics in general and primary atomization in particular are still not fully understood. Experimental techniques have difficulty examining the dense, three-dimensional, highly turbulent zone where primary atomization occurs. Numerical simulation offers the ability to elucidate the underlying processes, but further developments are required to improve fidelity and computational affordability. The Lagrangian volume of fluid (LVOF) method is a coupled Eulerian-Lagrangian simulation approach that has been designed to achieve superior mass conservation and is poised for extension to large eddy simulation (LES). These features address both shortcomings in the current state of the art: affordability and accuracy. In the LVOF method, Lagrangian particles are seeded coincident with an Eulerian mesh and carry a phase-identifying variable called the volume of fluid. These particles are associated with a volume and a mass. The surface tension corresponding to the particle field is computed in the framework of the continuum body force (CBF) [1] via the finite particle method (FPM) [2]. The particles communicate the local phase and surface tension to the Eulerian mesh, and the Eulerian mesh communicates the local velocity to the particles. Because the FPM maintains first order consistency for disorganized particle fields, the Lagrangian remeshing required by other schemes [3] is not required, which allows for identical Lagrangian domain mass conservation. Forthcoming work has demonstrated superior Eulerian mass conservation via the single vortex problem and the dynamic accuracy has been shown to be comparable with the point-set method [4] for a two-dimensional oscillating droplet. The method is more expensive than other direct numerical simulation approaches, but extension to large eddy simulation will dramatically reduce the expense and fully leverage the multiscale nature of the method. This paper presents the first application of the LVOF-FPM method to more general, three dimensional flows with sheet and capillary breakup. The intent of the simulations is to demonstrate mass conservation behavior in nontrivial flows. We also seek to determine the sensitivity of performance on the particle number density. With these considerations, the layout of the paper is as follows: the mathematical structure of the method is briefly presented; temporal mixing layers are then simulated with Weber numbers of 45 and 90, with the results discussed from the perspective of breakup dynamics and mass conservation; next, the sensitivity of capillary breakup to Lagrangian particle number density is qualitatively evaluated and discussed; lastly, conclusions are made and future work is discussed. Methodology The system is initialized by seeding the domain with LVOF particles carrying a volume V i, such that the sum of the particle volumes equals the volume of the system. The subscript i refers to a particular Lagrangian element. Particles seeded in one phase carry a VOF value φ i = 0 and in the other phase φ i = 1. The surface tension is computed as a function of the Lagrangian elements in the context of the continuum body force model [1], F i = δ i σ i κ iˆn i, (1) where σ i is the surface tension coefficient, κ i is the interfacial curvature, and ˆn i = n i / n i is the inward pointing unit normal vector. The interface delta function δ i is defined as δ i = n i. The normal vector and curvature are computed from a smooth definition of the interface called the color function c i. We consider standard expressions for the normal vector n i = c i (2) and curvature where κ i = c ih i c i T c i 2 Trace (H i ) c i 3, (3) H i = ( c i ). (4) The color function c i is obtained from the Lagrangian VOF φ i via the FPM. The FPM relates the VOF φ i to the color function c i by constructing a weighted Taylor series associating nearby particles. The weighting is determined by a sampling basis ζ defined by the spatial derivatives of a compact weight function W of nonzero extent r e [2], ζ = W x W y W z x 2 y 2 z 2 x y x z y z. (5) 2

3 The basis ζ is used to construct a linear system for each Lagrangian element i within r e of the interface by sampling its N p neighbors within the nonzero extent of ζ, N p j=1 (φ j φ i ) ζ k V j = c i x α 2 c i x α x β N p j=1 N p ( x α j x α ) i ζ k V j + j=1 1 2 (xα j x α i )(x β j xβ i )ζk V j, (6) where the free index k assumes values 1 through 9. The notation in Eq. (6) is taken from [2], where Greek superscripts denote spatial dimensionality with implied summation. Solving the system of equations defined by Eq. (6) returns c i / x α and 2 c i / x α x β. The normal vectors and curvature are computed with these derivatives according to Eq. (2) and Eq. (3). Lagrangian methods for computing curvature tend to be error prone far from the interface (where the normal vector magnitude is small), so a cutoff method similar to that implemented in [1] is used here, { n i, n i > ɛ, δ i = (7) 0, n i ɛ. The cutoff value is selected to be ɛ = 0.05 where is the Eulerian mesh spacing. After performing the cutoff correction to the curvature field, the Lagrangian surface tension is computed according to Eq. (1) on N a particles in each interfacial Eulerian cell. Interfacial cells are defined as those with particles carrying non-zero normal vector magnitudes. The particle surface tension vectors F i are transferred to the Eulerian grid by a volume-averaging operation, Na F s i=1 = F iv i Na i=1 V, (8) i where F s is the Eulerian surface tension. The Eulerian mean volume of fluid (used to inform fluid properties) is similarly computed, φ = Na i=1 φ iv i Na i=1 V. (9) i The total number of particles in an Eulerian cell is defined as the particle number density N pc. It is not necessary for N a = N pc. Selecting N a < N pc is referred to as under-sampling and can be performed to reduce computational time. The particle positions x i are updated according to Dx i Dt = up i (10) in conjunction with the Eulerian time integration scheme. The particle velocity vector u p i is obtained from the Eulerian velocity, N g u p i = W ( x g x i, r ev )u g V g, (11) g=1 where N g is the number of Eulerian grid cells within r ev of particle i, u g is the Eulerian velocity at cell g, and V g is the volume of cell g. Governing equations In all of the simulations presented we solve the compressible Navier-Stokes equations. The system is made approximately incompressible by implementing a stiffened equation of state for the pressure P [5, 2], ( ( ) β ρ P = B 1), (12) ρ o where B = 100/β, β = 7, ρ o = 1, and ρ is the density. The Eulerian system includes conservation of mass, ρ + (ρu) = 0, (13) t and conservation of momentum, t (ρu) + (ρu u + P I) = τ + Fs, (14) where τ is the viscous stress tensor. The Eulerian equations are solved with a predictor-corrector finite-difference scheme with second order accuracy [6]. The following simulations use a quartic weight to define both the sampling basis ζ, and the weight function used for the velocity transfer in Eq. (11), W (R, r e ) = { α d ( 3R 4 + 8R 3 6R ), 0 R 1, 0, R > 1, (15) where R = x j x i /r e and α d = 105/16πr 3 e in three dimensions [7]. Case W e Re r e N pc Table 1. Parameters for the temporal mixing layers. 3

4 where m o is the initial mass and m t is the instantaneous mass obtained by integrating the Eulerian VOF φ over the entire domain. This is a conservation measure for the phase with φ i = 1. Numerical parameters The computational domain is shown in Fig. 1. The top and bottom of the domain are initialized as different fluids, { 1 y i 0, φ i (y) = (18) 0 y i > 0, Figure 1. Initial condition and geometry for the temporal mixing layers. Temporal mixing layers Three-dimensional temporal mixing layers demonstrate sheet breakup and provide a platform to explore mass conservation. Mixing layers are characterized by the counterflow of two fluid streams with a relative velocity γ = 2U o and an initial vorticity thickness δ ωo. Instability at the interface produces vortices that grow, pair, and merge [8, 9, 10, 11, 12]. These dynamics are modified when the two streams are composed of different fluids with an interfacial tension. In this section we explore these dynamics for two different Weber numbers defined by W e = ρδ ω o U 2 o σ, (16) where ρ is the fluid density and σ is the surface tension coefficient. Other expressions for the Weber number are often used, but we use Eq. (16) to ensure the same scaling appears in the Weber and Reynolds numbers. The purpose of this demonstration is two-fold: first, we seek to demonstrate qualitatively the ability of the method to capture sheet breakup and present Weber number-dependent dynamics; second, we wish to examine mass conservation behavior in a nontrivial flow configuration. The change in mass is presented as a signed percent change m c = 100 (m t /m o 1), (17) with the top fluid moving to the right and the bottom fluid moving to the left (transitioning over a thickness of δ ωo ). Perturbations are added to the initial velocity field to expedite the growth instabilities to reduce the simulation time [13, 9, 10, 14]. The wavelength of the initial instability is set to λ = πδ ωo. Both phases have equal fluid properties and the flow is defined to have a Reynolds number of Re = U o δ ωo /ν = 400, where ν is the kinematic viscosity. Weber numbers of W e = 90 and W e = 45 are considered. These simulation parameters are summarized in Table 1. Time is nondimensionalized as t = U o t/δ ωo. The domain size is 2πδ ωo 2πδ ωo πδ ωo and is covered by a uniform grid comprised of computational nodes. The boundary conditions in the cross-stream direction are zero-derivative and the stream-wise direction is periodic. Each Eulerian cell is initialized with N pc = 8 particles and the influence radius for ζ is chosen to be r e = 3. The particles are seeded on a uniform cartesian mesh and then perturbed by a small random number. The surface tension is computed with N a = 1 and the particle velocities are computed with r ev = 2. Results An exhaustive discussion of the sheet breakup dynamic is beyond the scope of this brief presentation. Instead, we discuss two instantaneous fields produced slightly after the sheet breakup event and then proceed to the discussion of mass conservation. The instantaneous fields appear in Fig. 2 for case 1 and case 2. Figure 2 panel (a) shows the case 1 mixing layer at t = Ligaments have formed from the merging of ruptured holes in the thin sheet. Some of the ligaments have already undergone capillary breakup and have produced satellite droplets. The same flow is shown at a slightly later time of t = 11.5 in Fig. 2 panel (b). At this later time, many more droplets have been produced and some of the ligaments that did not rupture have receded into the bulk. These 4

5 (a) (b) (c) (d) Figure 2. Comparison of the case 1 and case 2 temporal mixing layers at two times shortly after sheet breakup: (a) case 1 at t? = 10.5; (b) case 1 at t? = 11.5; (c) case 2 at t? = 10.5; (d) case 2 at t? = breakup dynamics are a function of Weber number, as made apparent by comparing case 1 with case 2 in panels (c) and (d). The behavior of case 2 is similar to case 1, aside from clear differences due to the change in Weber number. At time t? = 10.5 in panel (c), the case 2 mixing layer also presents a number of ligaments resulting from a sheet breakup event, but there are fewer, larger ligaments than in case 1. At the later time of t? = 11.5 in panel (d), the droplets resulting from capillary breakup of the ligaments are considerably larger on average and fewer in number than for case 1. This is consistent with the lower Weber number corresponding to stronger surface tension. The Eulerian mass conservation behavior of case 1 and case 2 is presented in Fig. 3. Both cases show an initial increase of 0.06% followed by scatter of less than 0.015% until t? = 12. The initial increase is likely due to a relaxation of particles near the lower boundary into cells that did not initially hold particles, which would artificially increase the volume of φ = 1 cells by a small amount; this is not considered to be characteristic of the method. The case 1 simulation was continued to a time of 5

6 t = 16 (nearly three flow through times) and at this time m c = %. These results demonstrate superior mass conservation, especially considering the complexity of the flow and the large increase in interfacial area due to breakup and stretching. One must also note that the Lagrangian mass has gone unchanged. Each Lagrangian particle maintains its initial mass for all time. m c Case 1 Case 2 Weber number and Reynolds number scalings are the same as the previous section. For each case W e = 8 and Re = 100. In all four cases the particles are placed in a pseudorandom fashion (as was done for the temporal mixing layer cases). The particle volumes for cases I III are globally uniform (all particles in the domain have the same volume and mass). In case IV the particle volume and mass are set inversely proportional to the local particle number density, computed by sampling the local particle field with W and r e = 2. Case W e Re r e N pc r ev I II III IV Table 2. cases. Parameters for the capillary breakup t Figure 3. Percent change in mass for the temporal mixing layer cases. Capillary breakup We proceed to examine the dependency of capillary breakup on the Lagrangian particle number density N pc. Particle number density determines how well the initial geometry is resolved, it affects the accuracy of the Lagrangian surface tension, and it determines the minimum resolvable sub-grid scale features. As a secondary test we also present a single case where r ev is increased and the particle volume initialization is performed differently from the other cases. The general magnitude of influence these parameters have on the solution is examined by suspending a spherical droplet of radius r o = 0.75δ ωo in the center of the mixing layer used in the previous section. The domain size, Eulerian mesh, and influence radius used in ζ are all adopted from the previous section. Again, N a = 1, and the perturbed initial condition is used, but this time the instability wavelength is set to the entire length of the domain λ = 2πδ ωo. The parametric definitions for four test cases (cases I, II, III, and IV ) appear in Table 2. The Results We do not present the full evolution of the droplet field, but consider only the period encompassing the breakup event. We are interested in the differences between the results, rather than the individual results themselves. This period is provided in Fig. 4 for cases I III. Case I appears on the left, case II is in the center, and case III appears on the right. The first image in each series corresponds to t 5.7, where we observe the droplet has been deformed into an elongated shape with a nodule on each end connected by a ligament. The case III droplet filament appears more smooth than the other two cases, perhaps suggesting the other cases have insufficient particle resolution. At the next time level the ligament has thinned at the edges for all three cases. The case III droplet is shown at a slightly later time than the other two cases because the thinning progresses more slowly. The third time level shows the production of an oscillatory satellite droplet, which becomes a steady sphere by the fourth time level. The three results are similar but not identical. Case III, which has the highest particle number density of N pc = 24, undergoes a longer breakup process: the ligament separates from the two nodules at a later time. This increased thinning time results in a slightly smaller satellite drop than cases I and II. In general, the dynamic performance does not appear to be a strong function of N pc. The mass conservation behavior, again evalu- 6

7 (a) t*=5.718 (e) t*=5.718 (i) t*=5.719 (b) t*=6.259 (f) t*=6.258 (j) t*=6.531 (c) t*=6.523 (g) t*=6.519 (k) t*=6.795 (d) t*=7.866 (h) t*=7.865 (l) t*=7.871 Figure 4. Comparison of the droplet interface for the capillary breakup tests: (a)-(d) case I; (e)-(h) case II; (i)-(l) case III. ated by m?c, appears in Fig. 5. Unlike the temporal mixing layer, there is notable Eulerian mass loss for the droplet stretching problem. By t? = 8, cases I III have lost approximately 2.5% of the initial Eulerian mass, while case IV has lost approximately 1.5%. The mass loss is effectively independent of particle number density. It is presently unknown if the improvement in case IV is due to the increase in rev or the difference in initial condition. This is an area of future work. The degradation of Eulerian conservation in this configuration (as compared to the temporal mixing layer) is due to the challenge of interpolating velocities near merging characteristics [15]. This geometry is particularly challenging because it is laminar and characteristics merge at both ends of the droplet for the entire simulation. The interpolation errors result in particles being transported from the center of the droplet to both ends where they remain for the duration of the simulation. This is a problem for laminar flows but is essentially nonexistent in turbulent flows as demonstrated by the temporal mixing layer problems. It should be noted that the Lagrangian domain mass is still available, even when errors arise in the Eulerian field. Summary and Conclusions We have presented a finite particle methodbased Lagrangian volume of fluid method (LVOFFPM). This coupled Eulerian-Lagrangian approach computes the interfacial tension and local phase on Lagrangian particles via the finite particle method and then transfers them to an Eulerian solver for solution of the Navier-Stokes equations. Use of the FPM is advantageous because it eliminates the need for Lagrangian remeshing required by other methods [3], and therefore allows for identical Lagrangian domain mass conservation. The mathematical framework of the method was briefly presented, followed by the simulation of a series of three-dimensional flows undergoing different breakup mechanisms. We first considered sheet breakup as a function of Weber number in temporal mixing layers, followed by capillary breakup as a function of particle number density. Eulerian conservation errors in the temporal mixing layers undergoing sheet breakup were approximately 0.015%. Expectedly, the droplets pro7

8 m c Case I Case II Case III Case IV t References [1] J. P. Morris. Int. J. Numer. Meth. Fl., 33(3): , [2] M. B. Liu, W. P. Xie, and G. R. Liu. Appl. Math. Model., 29(12): , [3] S. E. Hieber and P. Koumoutsakos. J. Comp. Phys., 210(1): , November [4] D. J. Torres and J. U. Brackbill. J. Comp. Phys., 165: , [5] J. J. Monaghan. J. Comp. Phys., 159: , [6] C. A. Kennedy and M. H. Carpenter. Appl. Num. Math., 14: , [7] L.B. Lucy. Astron. J., 82: , Figure 5. Percent change in mass for the capillary breakup cases. duced in the W e = 45 mixing layer were larger and fewer in number than the droplets produced in the W e = 90 mixing layer. Conservation errors in the capillary breakup test cases were greater than for the mixing layers, with losses ranging from 1.5% to 2.5%. These errors were independent of particle number density N pc, but dependent on either r ev or the particle initialization. Future work must determine which of these parameters influenced the result. In general, these conservation errors are due to interpolation errors near merging characteristics, which should not be a prominent concern for turbulent flows. The capillary breakup dynamic in general was observed to be a relatively weak function of N pc. The LVOF-FPM is a promising simulation tool because of its conservation properties, its sub-grid scale phase resolution, and the Lagrangian nature of the multiphase description. These properties make the LVOF-FPM robust for direct numerical simulation, and also make it a strong candidate for large eddy simulation. The Lagrangian description of phase allows for direct extensions of the LVOF-FPM to existing multiphase LES formulations. It is also possible to develop new LES formulations to leverage the properties of the LVOF. The development of LES extensions is an immediate area of future work. [8] P. E. Dimotakis. AIAA J., 24: , [9] R. W. Metcalfe, S. A. Orszag, M. E. Brachet, S. Menon, and J. J. Riley. J. Fluid Mech., 184: , [10] M. M. Rogers and R. D. Moser. 7th Symp. on Turbulent Shear Flows, Stanford, CA, [11] S. Modem and S. C. Garrick. J. Visualization, 6(3): , [12] G. Wang and S. C. Garrick. J. Aerosol Sci., 37(4): , [13] R. T. Pierrehumbert and S. E. Widnall. J. Fluid Mech., 114:59 82, [14] S. A. Ragab and J. L. Wu. Phys. Fluids A, 1(6): , [15] D. Enright, R. Fedkiw, J. Ferziger, and I. Mitchell. J. Comp. Phys., 183(1):83 116, Acknowledgements All computational resources were provided by the Minnesota Supercomputing Institute. URL: 8

Droplet collisions using a Level Set method: comparisons between simulation and experiments

Droplet collisions using a Level Set method: comparisons between simulation and experiments Computational Methods in Multiphase Flow III 63 Droplet collisions using a Level Set method: comparisons between simulation and experiments S. Tanguy, T. Ménard & A. Berlemont CNRS-UMR6614-CORIA, Rouen

More information

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Masanori Hashiguchi 1 1 Keisoku Engineering System Co., Ltd. 1-9-5 Uchikanda, Chiyoda-ku,

More information

A 3D VOF model in cylindrical coordinates

A 3D VOF model in cylindrical coordinates A 3D VOF model in cylindrical coordinates Marmar Mehrabadi and Markus Bussmann Department of Mechanical and Industrial Engineering, University of Toronto Recently, volume of fluid (VOF) methods have improved

More information

Phase-field simulation of two-phase micro-flows in a Hele-Shaw cell

Phase-field simulation of two-phase micro-flows in a Hele-Shaw cell Computational Methods in Multiphase Flow III 7 Phase-field simulation of two-phase micro-flows in a Hele-Shaw cell Y. Sun & C. Beckermann Department of Mechanical and Industrial Engineering, University

More information

Overview of Traditional Surface Tracking Methods

Overview of Traditional Surface Tracking Methods Liquid Simulation With Mesh-Based Surface Tracking Overview of Traditional Surface Tracking Methods Matthias Müller Introduction Research lead of NVIDIA PhysX team PhysX GPU acc. Game physics engine www.nvidia.com\physx

More information

Moving Interface Problems: Methods & Applications Tutorial Lecture II

Moving Interface Problems: Methods & Applications Tutorial Lecture II Moving Interface Problems: Methods & Applications Tutorial Lecture II Grétar Tryggvason Worcester Polytechnic Institute Moving Interface Problems and Applications in Fluid Dynamics Singapore National University,

More information

Drop Impact Simulation with a Velocity-Dependent Contact Angle

Drop Impact Simulation with a Velocity-Dependent Contact Angle ILASS Americas 19th Annual Conference on Liquid Atomization and Spray Systems, Toronto, Canada, May 2006 Drop Impact Simulation with a Velocity-Dependent Contact Angle S. Afkhami and M. Bussmann Department

More information

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Eulerian Grid Methods The methods covered so far in this course use an Eulerian grid: Prescribed coordinates In `lab frame' Fluid elements flow

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

FEM techniques for interfacial flows

FEM techniques for interfacial flows FEM techniques for interfacial flows How to avoid the explicit reconstruction of interfaces Stefan Turek, Shu-Ren Hysing (ture@featflow.de) Institute for Applied Mathematics University of Dortmund Int.

More information

Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow

Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow Vinh The Nguyen University of Massachusetts Dartmouth Computational Science Training

More information

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4 UMEÅ UNIVERSITY Department of Physics Claude Dion Olexii Iukhymenko May 15, 2015 Strömningslära Fluid Dynamics (5FY144) Computer laboratories using COMSOL v4.4!! Report requirements Computer labs must

More information

Prim ary break-up: DNS of liquid jet to improve atomization m odelling

Prim ary break-up: DNS of liquid jet to improve atomization m odelling Computational Methods in Multiphase Flow III 343 Prim ary break-up: DNS of liquid jet to improve atomization m odelling T. Ménard, P. A. Beau, S. Tanguy, F. X. Demoulin & A. Berlemont CNRS-UMR6614-CORIA,

More information

The Transient Modeling of Bubble Pinch-Off Using an ALE Moving Mesh

The Transient Modeling of Bubble Pinch-Off Using an ALE Moving Mesh Excerpt from the Proceedings of the COMSOL Conference 2010 Boston The Transient Modeling of Bubble Pinch-Off Using an ALE Moving Mesh Christopher J. Forster, Marc K. Smith * School of Mechanical Engineering,

More information

Numerical Simulation of Coastal Wave Processes with the Use of Smoothed Particle Hydrodynamics (SPH) Method

Numerical Simulation of Coastal Wave Processes with the Use of Smoothed Particle Hydrodynamics (SPH) Method Aristotle University of Thessaloniki Faculty of Engineering Department of Civil Engineering Division of Hydraulics and Environmental Engineering Laboratory of Maritime Engineering Christos V. Makris Dipl.

More information

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes L. Jofre, O. Lehmkuhl, R. Borrell, J. Castro and A. Oliva Corresponding author: cttc@cttc.upc.edu Centre Tecnològic

More information

Lecture 1.1 Introduction to Fluid Dynamics

Lecture 1.1 Introduction to Fluid Dynamics Lecture 1.1 Introduction to Fluid Dynamics 1 Introduction A thorough study of the laws of fluid mechanics is necessary to understand the fluid motion within the turbomachinery components. In this introductory

More information

Characteristic Aspects of SPH Solutions

Characteristic Aspects of SPH Solutions Characteristic Aspects of SPH Solutions for Free Surface Problems: Source and Possible Treatment of High Frequency Numerical Oscillations of Local Loads. A. Colagrossi*, D. Le Touzé & G.Colicchio* *INSEAN

More information

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications Published in Lecture Notes in Computational Science and Engineering Vol. 103, Proceedings of ENUMATH 2013, pp. 755-762, Springer, 2014 Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

More information

(LSS Erlangen, Simon Bogner, Ulrich Rüde, Thomas Pohl, Nils Thürey in collaboration with many more

(LSS Erlangen, Simon Bogner, Ulrich Rüde, Thomas Pohl, Nils Thürey in collaboration with many more Parallel Free-Surface Extension of the Lattice-Boltzmann Method A Lattice-Boltzmann Approach for Simulation of Two-Phase Flows Stefan Donath (LSS Erlangen, stefan.donath@informatik.uni-erlangen.de) Simon

More information

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM)

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) Computational Methods and Experimental Measurements XVII 235 Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) K. Rehman Department of Mechanical Engineering,

More information

Effect of initial turbulence intensity and velocity profile on liquid jets for IFE beamline protection

Effect of initial turbulence intensity and velocity profile on liquid jets for IFE beamline protection Effect of initial turbulence intensity and velocity profile on liquid jets for IFE beamline protection A. Konkachbaev, N.B. Morley and M. A. Abdou Mechanical and Aerospace Engineering Department, UCLA

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models

Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models Numerical Study of Turbulent Flow over Backward-Facing Step with Different Turbulence Models D. G. Jehad *,a, G. A. Hashim b, A. K. Zarzoor c and C. S. Nor Azwadi d Department of Thermo-Fluids, Faculty

More information

SPH: Towards the simulation of wave-body interactions in extreme seas

SPH: Towards the simulation of wave-body interactions in extreme seas SPH: Towards the simulation of wave-body interactions in extreme seas Guillaume Oger, Mathieu Doring, Bertrand Alessandrini, and Pierre Ferrant Fluid Mechanics Laboratory (CNRS UMR6598) Ecole Centrale

More information

Modeling External Compressible Flow

Modeling External Compressible Flow Tutorial 3. Modeling External Compressible Flow Introduction The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a nonzero angle of attack. You will use the Spalart-Allmaras

More information

Gradient Free Design of Microfluidic Structures on a GPU Cluster

Gradient Free Design of Microfluidic Structures on a GPU Cluster Gradient Free Design of Microfluidic Structures on a GPU Cluster Austen Duffy - Florida State University SIAM Conference on Computational Science and Engineering March 2, 2011 Acknowledgements This work

More information

CGT 581 G Fluids. Overview. Some terms. Some terms

CGT 581 G Fluids. Overview. Some terms. Some terms CGT 581 G Fluids Bedřich Beneš, Ph.D. Purdue University Department of Computer Graphics Technology Overview Some terms Incompressible Navier-Stokes Boundary conditions Lagrange vs. Euler Eulerian approaches

More information

LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS

LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS 14 th European Conference on Mixing Warszawa, 10-13 September 2012 LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS Felix Muggli a, Laurent Chatagny a, Jonas Lätt b a Sulzer Markets & Technology

More information

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes Numerical Analysis of Shock Tube Problem by using TVD and Schemes Dr. Mukkarum Husain, Dr. M. Nauman Qureshi, Syed Zaid Hasany IST Karachi, Email: mrmukkarum@yahoo.com Abstract Computational Fluid Dynamics

More information

Chapter 1 - Basic Equations

Chapter 1 - Basic Equations 2.20 Marine Hydrodynamics, Fall 2017 Lecture 2 Copyright c 2017 MIT - Department of Mechanical Engineering, All rights reserved. 2.20 Marine Hydrodynamics Lecture 2 Chapter 1 - Basic Equations 1.1 Description

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Keywords: flows past a cylinder; detached-eddy-simulations; Spalart-Allmaras model; flow visualizations

Keywords: flows past a cylinder; detached-eddy-simulations; Spalart-Allmaras model; flow visualizations A TURBOLENT FLOW PAST A CYLINDER *Vít HONZEJK, **Karel FRAŇA *Technical University of Liberec Studentská 2, 461 17, Liberec, Czech Republic Phone:+ 420 485 353434 Email: vit.honzejk@seznam.cz **Technical

More information

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

More information

Technical Report TR

Technical Report TR Technical Report TR-2015-09 Boundary condition enforcing methods for smoothed particle hydrodynamics Arman Pazouki 1, Baofang Song 2, Dan Negrut 1 1 University of Wisconsin-Madison, Madison, WI, 53706-1572,

More information

INTERACTION BETWEEN TURBULENT DYNAMICAL PROCESSES AND STATISTICS IN DEFORMED AIR-LIQUID INTERFACES, VIA DNS

INTERACTION BETWEEN TURBULENT DYNAMICAL PROCESSES AND STATISTICS IN DEFORMED AIR-LIQUID INTERFACES, VIA DNS INTERACTION BETWEEN TURBULENT DYNAMICAL PROCESSES AND STATISTICS IN DEFORMED AIR-LIQUID INTERFACES, VIA DNS Yoshinobu Yamamoto Department of Nuclear Engineering, Kyoto University Yoshida Sakyo Kyoto, 66-85,

More information

Simulation of Droplet Impingement on a Solid Surface by the Level Set Method

Simulation of Droplet Impingement on a Solid Surface by the Level Set Method Simulation of Droplet Impingement on a Solid Surface by the Level Set Method Junling Hu *1, Ruoxu Jia 1, Kai-tak Wan 2, Xingguo Xiong 3 1 Department of Mechanical Engineering, University of Bridgeport,

More information

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion James F. Price Woods Hole Oceanographic Institution Woods Hole, MA, 02543 July 31, 2006 Summary: This essay

More information

A TSTT integrated FronTier code and its applications in computational fluid physics

A TSTT integrated FronTier code and its applications in computational fluid physics Institute of Physics Publishing Journal of Physics: Conference Series 16 (2005) 471 475 doi:10.1088/1742-6596/16/1/064 SciDAC 2005 A TSTT integrated FronTier code and its applications in computational

More information

LES Analysis on Shock-Vortex Ring Interaction

LES Analysis on Shock-Vortex Ring Interaction LES Analysis on Shock-Vortex Ring Interaction Yong Yang Jie Tang Chaoqun Liu Technical Report 2015-08 http://www.uta.edu/math/preprint/ LES Analysis on Shock-Vortex Ring Interaction Yong Yang 1, Jie Tang

More information

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA.

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA. 12 th International LS-DYNA Users Conference FSI/ALE(1) LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA Part 1 Facundo Del

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Copyright c 2007 ICCES ICCES, vol.4, no.1, pp.11-18, 2007 Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Kazuhiko Kakuda 1, Tomohiro Aiso 1 and Shinichiro Miura

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

The Spalart Allmaras turbulence model

The Spalart Allmaras turbulence model The Spalart Allmaras turbulence model The main equation The Spallart Allmaras turbulence model is a one equation model designed especially for aerospace applications; it solves a modelled transport equation

More information

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION TODD F. DUPONT AND YINGJIE LIU Abstract. We propose a method that significantly

More information

Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement

Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement Lian Shen Department of Mechanical Engineering

More information

KEY STAR TECHNOLOGIES: DISPERSED MULTIPHASE FLOW AND LIQUID FILM MODELLING DAVID GOSMAN EXEC VP TECHNOLOGY, CD-adapco

KEY STAR TECHNOLOGIES: DISPERSED MULTIPHASE FLOW AND LIQUID FILM MODELLING DAVID GOSMAN EXEC VP TECHNOLOGY, CD-adapco KEY STAR TECHNOLOGIES: DISPERSED MULTIPHASE FLOW AND LIQUID FILM MODELLING DAVID GOSMAN EXEC VP TECHNOLOGY, CD-adapco INTRODUCTION KEY METHODOLOGIES AVAILABLE IN STAR-CCM+ AND STAR-CD 1. Lagrangian modelling

More information

Streamlining Aircraft Icing Simulations. D. Snyder, M. Elmore

Streamlining Aircraft Icing Simulations. D. Snyder, M. Elmore Streamlining Aircraft Icing Simulations D. Snyder, M. Elmore Industry Analysis Needs / Trends Fidelity Aircraft Ice Protection Systems-Level Modeling Optimization Background Ice accretion can critically

More information

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Decheng Wan 1 and Stefan Turek 2 Institute of Applied Mathematics LS III, University of Dortmund,

More information

Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data

Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data Continued Investigation of Small-Scale Air-Sea Coupled Dynamics Using CBLAST Data Dick K.P. Yue Center for Ocean Engineering Department of Mechanical Engineering Massachusetts Institute of Technology Cambridge,

More information

Developing LES Models for IC Engine Simulations. June 14-15, 2017 Madison, WI

Developing LES Models for IC Engine Simulations. June 14-15, 2017 Madison, WI Developing LES Models for IC Engine Simulations June 14-15, 2017 Madison, WI 1 2 RANS vs LES Both approaches use the same equation: u i u i u j 1 P 1 u i t x x x x j i j T j The only difference is turbulent

More information

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions Milovan Perić Contents The need to couple STAR-CCM+ with other theoretical or numerical solutions Coupling approaches: surface and volume

More information

Large Eddy Simulation of Flow over a Backward Facing Step using Fire Dynamics Simulator (FDS)

Large Eddy Simulation of Flow over a Backward Facing Step using Fire Dynamics Simulator (FDS) The 14 th Asian Congress of Fluid Mechanics - 14ACFM October 15-19, 2013; Hanoi and Halong, Vietnam Large Eddy Simulation of Flow over a Backward Facing Step using Fire Dynamics Simulator (FDS) Md. Mahfuz

More information

Surface Tension Approximation in Semi-Lagrangian Level Set Based Fluid Simulations for Computer Graphics

Surface Tension Approximation in Semi-Lagrangian Level Set Based Fluid Simulations for Computer Graphics Surface Tension Approximation in Semi-Lagrangian Level Set Based Fluid Simulations for Computer Graphics Israel Pineda and Oubong Gwun Chonbuk National University israel_pineda_arias@yahoo.com, obgwun@jbnu.ac.kr

More information

A Multiscale Nested Modeling Framework to Simulate the Interaction of Surface Gravity Waves with Nonlinear Internal Gravity Waves

A Multiscale Nested Modeling Framework to Simulate the Interaction of Surface Gravity Waves with Nonlinear Internal Gravity Waves DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. A Multiscale Nested Modeling Framework to Simulate the Interaction of Surface Gravity Waves with Nonlinear Internal Gravity

More information

Development of Hybrid Fluid Jet / Float Polishing Process

Development of Hybrid Fluid Jet / Float Polishing Process COMSOL Conference - Tokyo 2013 Development of Hybrid Fluid Jet / Float Polishing Process A. Beaucamp, Y. Namba Dept. of Mechanical Engineering, Chubu University, Japan Zeeko LTD, United Kingdom Research

More information

Chapter 2 Water and Bubbles

Chapter 2 Water and Bubbles Chapter 2 Water and Bubbles 2.1 Animation of Bubbles in Liquid Abstract This section introduces a new fluid animation technique in which liquid and gas interact with each other, using the example of bubbles

More information

Introduction to the immersed boundary method

Introduction to the immersed boundary method Introduction to the immersed boundary method Motivation. Hydrodynamics and boundary conditions The incompressible Navier-Stokes equations, ( ) u ρ + (u )u = p + ρν 2 u + f, () t are partial differential

More information

QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD

QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD QUASI-3D SOLVER OF MEANDERING RIVER FLOWS BY CIP-SOROBAN SCHEME IN CYLINDRICAL COORDINATES WITH SUPPORT OF BOUNDARY FITTED COORDINATE METHOD Keisuke Yoshida, Tadaharu Ishikawa Dr. Eng., Tokyo Institute

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

Numerical simulation of primary atomization of a sheared liquid sheet. Part 2: Comparison with experimental results

Numerical simulation of primary atomization of a sheared liquid sheet. Part 2: Comparison with experimental results Numerical simulation of primary atomization of a sheared liquid sheet. Part 2: Comparison with experimental results P. Villedieu, G. Blanchard, D. Zuzio To cite this version: P. Villedieu, G. Blanchard,

More information

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Latif Bouhadji ASL-AQFlow Inc., Sidney, British Columbia, Canada Email: lbouhadji@aslenv.com ABSTRACT Turbulent flows over a spillway

More information

SPLASH, VORTICES AND TURBULENT SHEARS IN PARTIAL DAM-BREAK FLOWS SPLASH MODEL OF WAVE-BREAKING AND OVERTOPPING

SPLASH, VORTICES AND TURBULENT SHEARS IN PARTIAL DAM-BREAK FLOWS SPLASH MODEL OF WAVE-BREAKING AND OVERTOPPING SPLASH, VORTICES AND TURBULENT SHEARS IN PARTIAL DAM-BREAK FLOWS SPLASH MODEL OF WAVE-BREAKING AND OVERTOPPING Yasunori Watanabe 1, Shunichi Sato 2, Yasuo Niida 3, Ichiro Kimura 4, Hiroshi Yokota 5, Haruhi

More information

Example 13 - Shock Tube

Example 13 - Shock Tube Example 13 - Shock Tube Summary This famous experiment is interesting for observing the shock-wave propagation. Moreover, this case uses the representation of perfect gas and compares the different formulations:

More information

Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows

Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows Copyright of figures and other materials in the paper belong to original authors. Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows Xiaowei He et al. ACM SIGGRAPH 2015

More information

Modeling Evaporating Liquid Spray

Modeling Evaporating Liquid Spray Tutorial 16. Modeling Evaporating Liquid Spray Introduction In this tutorial, FLUENT s air-blast atomizer model is used to predict the behavior of an evaporating methanol spray. Initially, the air flow

More information

Conservative Level Set/Ghost Fluid Method for Simulating Primary Atomization

Conservative Level Set/Ghost Fluid Method for Simulating Primary Atomization ILASS Americas 20th Annual Conference on Liquid Atomization and Spray Systems, Chicago, IL, May 2007 Conservative Level Set/Ghost Fluid Method for Simulating Primary Atomization O. Desjardins, V. Moureau,

More information

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Reports of Research Institute for Applied Mechanics, Kyushu University, No.150 (60-70) March 2016 Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Report 2: For the Case

More information

A Deterministic Viscous Vortex Method for Grid-free CFD with Moving Boundary Conditions

A Deterministic Viscous Vortex Method for Grid-free CFD with Moving Boundary Conditions A Deterministic Viscous Vortex Method for Grid-free CFD with Moving Boundary Conditions M.W. PITMAN, A.D. LUCEY Department of Mechanical Engineering Curtin University of Technology GPO Box U1987, Perth,

More information

Using the Eulerian Multiphase Model for Granular Flow

Using the Eulerian Multiphase Model for Granular Flow Tutorial 21. Using the Eulerian Multiphase Model for Granular Flow Introduction Mixing tanks are used to maintain solid particles or droplets of heavy fluids in suspension. Mixing may be required to enhance

More information

A Geometric Approach to Animating Thin Surface Features in SPH Water

A Geometric Approach to Animating Thin Surface Features in SPH Water A Geometric Approach to Animating Thin Surface Features in SPH Water Taekwon Jang et al. Computer Animation and Social Agents 2013 (CASA) Jong-Hyun Kim 2013. 11.08 Abstract We propose a geometric approach

More information

Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique

Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique C.W. Hirt and J.E. Richardson, Flow Science, Inc., 1257 40th, Los Alamos, NM 87544 and Ken S. Chen, Sandia

More information

Using a Single Rotating Reference Frame

Using a Single Rotating Reference Frame Tutorial 9. Using a Single Rotating Reference Frame Introduction This tutorial considers the flow within a 2D, axisymmetric, co-rotating disk cavity system. Understanding the behavior of such flows is

More information

Least Square Curvature Calculation Method for VOF Schemes

Least Square Curvature Calculation Method for VOF Schemes ILASS Americas 28th Annual Conference on Liquid Atomization and Spray Systems, Dearborn, MI, May 2016 Least Square Curvature Calculation Method for VOF Schemes E. Cauble, M. Owkes Department of Mechanical

More information

Modeling Evaporating Liquid Spray

Modeling Evaporating Liquid Spray Tutorial 17. Modeling Evaporating Liquid Spray Introduction In this tutorial, the air-blast atomizer model in ANSYS FLUENT is used to predict the behavior of an evaporating methanol spray. Initially, the

More information

CFD MODELING FOR PNEUMATIC CONVEYING

CFD MODELING FOR PNEUMATIC CONVEYING CFD MODELING FOR PNEUMATIC CONVEYING Arvind Kumar 1, D.R. Kaushal 2, Navneet Kumar 3 1 Associate Professor YMCAUST, Faridabad 2 Associate Professor, IIT, Delhi 3 Research Scholar IIT, Delhi e-mail: arvindeem@yahoo.co.in

More information

CFD Simulation for Stratified Oil-Water Two-Phase Flow in a Horizontal Pipe

CFD Simulation for Stratified Oil-Water Two-Phase Flow in a Horizontal Pipe CFD Simulation for Stratified Oil-Water Two-Phase Flow in a Horizontal Pipe Adib Zulhilmi Mohd Alias, a, Jaswar Koto, a,b,* and Yasser Mohamed Ahmed, a a) Department of Aeronautics, Automotive and Ocean

More information

Stream Function-Vorticity CFD Solver MAE 6263

Stream Function-Vorticity CFD Solver MAE 6263 Stream Function-Vorticity CFD Solver MAE 66 Charles O Neill April, 00 Abstract A finite difference CFD solver was developed for transient, two-dimensional Cartesian viscous flows. Flow parameters are solved

More information

Tutorial 17. Using the Mixture and Eulerian Multiphase Models

Tutorial 17. Using the Mixture and Eulerian Multiphase Models Tutorial 17. Using the Mixture and Eulerian Multiphase Models Introduction: This tutorial examines the flow of water and air in a tee junction. First you will solve the problem using the less computationally-intensive

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Interpolation error in DNS simulations of turbulence: consequences for particle tracking

Interpolation error in DNS simulations of turbulence: consequences for particle tracking Journal of Physics: Conference Series Interpolation error in DNS simulations of turbulence: consequences for particle tracking To cite this article: M A T van Hinsberg et al 2011 J. Phys.: Conf. Ser. 318

More information

Air Assisted Atomization in Spiral Type Nozzles

Air Assisted Atomization in Spiral Type Nozzles ILASS Americas, 25 th Annual Conference on Liquid Atomization and Spray Systems, Pittsburgh, PA, May 2013 Air Assisted Atomization in Spiral Type Nozzles W. Kalata *, K. J. Brown, and R. J. Schick Spray

More information

PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON. Pawe l Wróblewski, Krzysztof Boryczko

PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON. Pawe l Wróblewski, Krzysztof Boryczko Computing and Informatics, Vol. 28, 2009, 139 150 PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON Pawe l Wróblewski, Krzysztof Boryczko Department of Computer

More information

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software

Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Reports of Research Institute for Applied Mechanics, Kyushu University No.150 (71 83) March 2016 Reproducibility of Complex Turbulent Flow Using Commercially-Available CFD Software Report 3: For the Case

More information

Rotating Moving Boundary Analysis Using ANSYS 5.7

Rotating Moving Boundary Analysis Using ANSYS 5.7 Abstract Rotating Moving Boundary Analysis Using ANSYS 5.7 Qin Yin Fan CYBERNET SYSTEMS CO., LTD. Rich Lange ANSYS Inc. As subroutines in commercial software, APDL (ANSYS Parametric Design Language) provides

More information

Interaction between turbulent flow and free surfaces

Interaction between turbulent flow and free surfaces Center or Turbulence Research Annual Research Bries 2002 301 Interaction between turbulent low and ree suraces By Y.-N. Young, F. E. Ham, AND N. N. Mansour 1. Motivation and objectives Fluids with interaces

More information

Meshless Modeling, Animating, and Simulating Point-Based Geometry

Meshless Modeling, Animating, and Simulating Point-Based Geometry Meshless Modeling, Animating, and Simulating Point-Based Geometry Xiaohu Guo SUNY @ Stony Brook Email: xguo@cs.sunysb.edu http://www.cs.sunysb.edu/~xguo Graphics Primitives - Points The emergence of points

More information

Commutative filters for LES on unstructured meshes

Commutative filters for LES on unstructured meshes Center for Turbulence Research Annual Research Briefs 1999 389 Commutative filters for LES on unstructured meshes By Alison L. Marsden AND Oleg V. Vasilyev 1 Motivation and objectives Application of large

More information

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last Parallel Implementation of Gas-Kinetic BGK Scheme on Unstructured Hybrid Grids Murat Ilgaz Defense Industries Research and Development Institute, Ankara, 626, Turkey and Ismail H. Tuncer Middle East Technical

More information

A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION

A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION N.K.-R. Kevlahan 1, O.V. Vasilyev 2, D. Goldstein 2, and A. Jay 1,3 kevlahan@mcmaster.ca 1 Department of Mathematics & Statistics,

More information

Two-Phase flows on massively parallel multi-gpu clusters

Two-Phase flows on massively parallel multi-gpu clusters Two-Phase flows on massively parallel multi-gpu clusters Peter Zaspel Michael Griebel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität Bonn Workshop Programming of Heterogeneous

More information

Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement

Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. Quantifying the Dynamic Ocean Surface Using Underwater Radiometric Measurement Lian Shen Department of Mechanical Engineering

More information

Dynamic Computational Modeling of the Glass Container Forming Process

Dynamic Computational Modeling of the Glass Container Forming Process Dynamic Computational Modeling of the Glass Container Forming Process Matthew Hyre 1, Ryan Taylor, and Morgan Harris Virginia Military Institute, Lexington, Virginia, USA Abstract Recent advances in numerical

More information

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Jakub Šístek, Pavel Burda, Jaroslav Novotný Department of echnical Mathematics, Czech echnical University in Prague, Faculty

More information

Simulation of Turbulent Particulate Flow on HPC Systems

Simulation of Turbulent Particulate Flow on HPC Systems Simulation of Turbulent Particulate Flow on HPC Systems Konstantin Fröhlich, Lennart Schneiders, Matthias Meinke, Wolfgang Schröder k.froehlich@aia.rwth-aachen.de Institute of Aerodynamics RWTH Aachen

More information

Calculate a solution using the pressure-based coupled solver.

Calculate a solution using the pressure-based coupled solver. Tutorial 19. Modeling Cavitation Introduction This tutorial examines the pressure-driven cavitating flow of water through a sharpedged orifice. This is a typical configuration in fuel injectors, and brings

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

This is an author-deposited version published in : Eprints ID : 19938

This is an author-deposited version published in :   Eprints ID : 19938 Open Archive TOULOUSE Archive Ouverte (OATAO) OATAO is an open access repository that collects the work of Toulouse researchers and makes it freely available over the web where possible. This is an author-deposited

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

More information