You are on page 1of 52

Numerical Investigation of Bubble Formations

on Nozzles

7th Indo-German Winter Academy 2008 - IIT Madras (Chennai)


a
Christoph Strohmeyer

Friedrich-Alexander University Erlangen-Nuremberg

December 16th 2008

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 1 / 52
Table of Contents

1 Motivation

2 Numerical Methods in Comparison

3 Equations and Boundary Conditions

4 The CLSVOF-Method

5 Bubble Formation on Nozzles

6 Perspectives

7 Bibliography

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 2 / 52
Motivation

Motivation

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 3 / 52
Motivation

Bubbles - so what?
Industrial processes involving a liquid and a gas phase are manifold:
Boiling during energy generation
Fermentation in bio-technology, coating of materials, physical
separation processes
Chemical reactions in gas-fluid-reactors
In particular we are interested in bubbly flows:
Heat exchanger
Bubble columns, where gas and liquid phase are
exposed to each other, to stimulate e.g. chemical
processes over the interface
It is decisive for the efficiency to generate small
bubbles in order to maximize the ratio of interface and
gas volume
Micro bubbles for medical issues (gentle contrast
medium)
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 4 / 52
Motivation

Why Should We Simulate It?

Besides the traditional arguments for computer simulations in general, like


lower costs, faster execution,
broad application spectrum, more data,
there are some specific reasons why computer simulations in the context of
bubbles on nozzles make sense:
The small lengthscales of the process handicap experiments
An accurate simulation can provide more profound insights in
correlation of parameters and e.g. bubble size

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 5 / 52
Numerical Methods in Comparison

Numerical Methods in
Comparison
Moving Discretization Grids
Static Discretization Grids

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 6 / 52
Numerical Methods in Comparison Moving Discretization Grids

Moving Discretization Drids

In order to categorize different numerical schemes for two phase flows, we


can distinguish two main branches:
Moving Discretization Grids
Every fluid has its own domain and discretization grid
Grids are coupled with jump conditions on the boundaries
The boundary of every domain is the interface between the fluids
Grids move and deform with time
Appropriate for (almost) stationary flows
Application difficult if large changes in topology occur
Fusion or breaking of bubbles may even prohibit convergence

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 7 / 52
Numerical Methods in Comparison Static Discretization Grids

Static Discretization Grids

The other important class has only one static discretization grid, that does
not move or deform with time.
Static Siscretization Grids
Allow strong deformations in the topology of the fluids
Only one set of equations for both fluids, which are solved on this
grid (momentum-, mass-, energy-conservation)
Changes in topology can often be handled by the algorithms without
additional implementations
Interface of the fluids moves in grid and has to be stored additionally
Two main different ways to store interface: Front-Tracking and
Front-Capturing methods

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 8 / 52
Numerical Methods in Comparison Static Discretization Grids

Front-Tracking Methods

This type of method is known as explicit method, because the


interface is known explicitly
Realized by markers, particles without mass, placed homogeneous in
one of the two fluids, which are transported passively with flow
Problems occur, if through shearing strain the local density of the
markers decreases significantly
To avoid this problem, new markers have to be inserted near
interface, but storage-requirements are very high (especially in 3D)
Algorithmically complex: out of markers on surface an interface mesh
has to be generated dynamically in each step
With certain adaptions this method is very accurate

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 9 / 52
Numerical Methods in Comparison Static Discretization Grids

Front-Capturing Methods

Position of fluid interface only known implicitly, characterized by an


indicator function
Interface has to be approximated in the so-called interface
reconstruction step
Errors in approximation of interface and its curvature can lead to
non-physical flows at the interface, known as parasitic currents
To validate the reconstruction, scenarios at equilibrium state are
considered: parasitic currents can even break a stable interface
Within Front-Capturing methods mainly two different approaches can
be distinguished:
The Level-Set (LS) and the Volume-of-Fluid (VOF) method

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 10 / 52
Numerical Methods in Comparison Static Discretization Grids

The Level-Set Method

In this method the scalar indicator function is a signed distance measure to


the interface. The contour line of the value zero marks the fluid interface.
Disadvantages
As the indicator function is moved in the flow via the
transport-equation, it loses its property as exact distance measure to
the interface mass conservation not guaranteed
It has to be reinitialized, by solving another PDE until distance
isolines realign equally

Advantages
Conceptually easy method with smooth indicator function
Algorithmically simple

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 11 / 52
Numerical Methods in Comparison Static Discretization Grids

The Volume-of-Fluid Method

In this method the indicator function is the scalar value of the fraction of
liquid in each discretization cell.
Disadvantages
Indicator function is non-smooth
Geometric interface reconstruction step necessary

Advantages
Mass conservation easily possible via geometrical considerations
No reinitialization necessary

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 12 / 52
Numerical Methods in Comparison Static Discretization Grids

The Combined Level-Set and Volume-of-Fluid Method

The CLSVOF-Method is now an almost obvious step: The LS-method and


the VOF-method are combined to pull out the advantages of both and to
reduce error-proneness in the scheme.
Advantages
It uses both indicator functions:
The distance measure function because of its smoothness, which
allows to calculate curvature and normal vectors easy and accurate
The fluid level function because it allows mass conservation
Unfortunately, in many cases an increase of advantages is not for free:
Disadvantages
Higher computational effort because of the treatment (transport,
reinitialization, reconstruction) of two indicator functions

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 13 / 52
Equations and Boundary Conditions

Equations and Boundary


Conditions
Classification and Basic Equations
Jump Conditions
Boundary Conditions

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 14 / 52
Equations and Boundary Conditions Classification and Basic Equations

Classification and Assumptions


We want to simulate a two-phase flow and therefore we need assumptions
for our fluids, so that we can model the problem.
Assumptions
The two fluids do not mix
The fluids show newtonian behavior
The flow is isothermal and incompressible
Density, viscosity and surface tension are constant

Since we consider bubbles in a fluid, we denote all variables and physical


quantities with a subscript g for gas and subscript f for the fluid in which
the bubbles move. The surface tension has no subscript.
For i = g , f
i denotes the simulation domain, ui denotes the velocity vector, pi the
pressure, i the density and i the viscosity
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 15 / 52
Equations and Boundary Conditions Classification and Basic Equations

Basic equations
With these assumptions we do not need to consider the equation for
energy-conservation. Both fluids are modeled with the following basic
equations:
For i = g , f
ui = 0, in i
 
ui
i + ui ui = pi i + i g + Kv , in i
t
Where i denotes the molecular-dependent momentum exchange, g the
gravity vector and Kv are additional volume forces (e.g. due to electric
fields).

Moreover the molecular-dependent momentum exchange tensor is given by


 
i = i ui + uT
i

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 16 / 52
Equations and Boundary Conditions Jump Conditions

Coupling Conditions at the Interface gf

We consider a material interface between the fluids where no mass


exchange due to evaporation or condensation
The two separate systems of partial differential equations for each
fluid (i = g , f ) have to be related
The jumps in the physical quantities across the fluid interface have to
be modeled physically
Those jumps are denoted by [](x) = (x)g (x)f , x gf and
express how much quantities change across gf

Kinematic Coupling Conditions


The velocity has to be continuous across gf :

[u] = uf ug = 0, on gf

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 17 / 52
Equations and Boundary Conditions Jump Conditions

Coupling Conditions at the Interface gf


The dynamic coupling conditions consist of the balance of forces at the
interface in normal and tangential direction.
n is the normal vector on gf that points into the fluid
n, t1 and t2 build an orthonormal system (in the 3D-case)
is the averaged curvature and Ks are additional surface forces

Dynamic Coupling Conditions


In normal direction:
[p] = n [ ] n + + Ks n, on gf
There exists a jump in the pressure due to viscous forces,
surface-tension and other surface forces
In tangential direction (for l = 1, 2):
tl [ ] n + Ks tl = 0, on gf
The projection onto the surface of the stress vector n has a jump
because of other surface forces
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 18 / 52
Equations and Boundary Conditions Jump Conditions

Equations for an Implicit Given Interface gf


If the interface is given implicitly by a signed distance measure = (x, t)
as in the Level-Set-Methods, then the interface is located at points where

= 0.

As the interface is moved by the velocity


component that is normal to it, we have
the following transport equation:


+ u = 0.
t
Further, we have:


n= , () = n.
kk

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 19 / 52
Equations and Boundary Conditions Boundary Conditions

Boundary Conditions on
We consider a radial symmetric scenario with regard to the center of the
nozzle, which will be basically modeled as circular hole in a plate.

Rd is the radius of the


nozzle
is the contact angle of the
bubble measured through
the fluid
Lr and Lz are the width and
height of the domain
= g f
Note: u = (u x , u y )T

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 20 / 52
Equations and Boundary Conditions Boundary Conditions

At the axis of symmetry (x = 0) we claim that no fluid exits the


domain and the gradient of the velocity must not have a kink:
u n = 0 and u n = 0
The adverse wall (x = Lr ) is considered to be frictionless, therefore
the same boundary conditions as at the symmetry axis must hold
At the nozzle (y = 0, x < Rd ) we assume the inflow profile of a fully
developed laminar flow:
ugy (x) = 2u0y (1 (x/Rd )2 )
At the bottom wall (y = 0, x > Rd ) we have the no-slip condition:
u = 0 or u n = 0 u n = 0
At the outflow (y = Lz ) we have natural Neumann conditions:
u n = n u = 0
The conditions for the pressure are on the whole boundary:
n p = 0
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 21 / 52
The CLSVOF-Method

The CLSVOF-Method
Adaption and Discretization
Interface Reconstruction
Interface Advection
Surface Tension Model
The Algorithm - an Overview
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 22 / 52
The CLSVOF-Method Adaption and Discretization

Adaption and Fusion of the Coupled PDEs


As we deal with static grids, we derive just one set of equations for the
entire simulation domain = g f . Hence, we use the Heaviside-
function:
(
1, if > 0
H() = , where is (again) the implicit LS-function
0, if 0

An interesting fact about this functional is, that we can transform surface
forces into volume forces by using its derivative in normal direction, a
Dirac-measure:
Z Z Z
f(x)dA = f(x) s (x)dx = f (x) [H((x)) n]dx
gf

Thus, for the surface tension force Ks = n, we obtain the transformed


volume force:

Kv = (n) (H() n) = (n n)H() = H()


Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 23 / 52
The CLSVOF-Method Adaption and Discretization

Adaption and Fusion of the Coupled PDEs


Further on, we define, using Heaviside- and LS-functional:
() = f H() + g (1 H())
() = f H() + g (1 H())
and the averaged curvature of the surface as before

() = .
kk
Then the two phase flow is described by the so-called
Whole-Domain Formulation

u =0

 
u h
T
i
() + u u = p + ()(u + u ) in
t


+ ()g + ()H() + Kv

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 24 / 52
The CLSVOF-Method Adaption and Discretization

Discretization
We have now derived the whole-domain formulation, which has to be
discretized in an appropriate way. For this purpose we subdivide our
domain in quadratic cells of size xy .
On this orthonormal and equidistant
grid we arrange the variables with the
concept of staggered grids, where
all scalar variables (e.g. pressure,
indicator-functions, ...) are
located in the center of each cell
the vector-valued quantities, like
the velocity, are located on the
edges
The indices i and j number the cells
in x- and y -direction.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 25 / 52
The CLSVOF-Method Adaption and Discretization

Discretization the Indicator-Functions


Now we have to specify how the Level-Set indicator-function and the
Volume-of-Fluid indicator-function are defined and discretized.
As explained before, the LS-function is the signed distance measure to
the interface gf :
(
dist(x, gf ), if x f
(x) =
dist(x, gf ), if x g

and it is discretized by i,j = (xi,j ), where xi,j is the center of cell i, j.

The VOF-function is the fluid level in each cell, thus it is an intrinsic


discrete functional, defined as the fraction of the volume of the fluid
(Vf )i,j and the volume of the cell:
(Vf )i,j
2D case: Fi,j = , 0 Fi,j 1
xy

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 26 / 52
The CLSVOF-Method Adaption and Discretization

Towards the Algorithm


Here are examples of the two indicator-functions:

Solving methods for flows with one phase are well-known. For the
treatment of two phase flows with the CLSVOF-method are essentially
three additional steps necessary:
the transport of the interface (interface advection),
the geometrical reconstruction of the interface,
an appropriate model for the surface tension,
with which will be dealt on the next slides.
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 27 / 52
The CLSVOF-Method Interface Reconstruction

Geometrical Interface Reconstruction


In every timestep the interface has to be reconstructed out of LS- and
VOF-function.
There are several ways of reconstruction:
SLIC (single line interface calculation)
PLIC (piecewise linear), used here
PROST (parabolic reconstruction)
The linear interface segment of each cell is characterized by the normal
ni,j (= /kk), approximated by central difference quotient, and the
distance li,j to the center, calculated such that the fluid level is correct.

Exact interface SLIC reconstruction PLIC reconstruction


Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 28 / 52
The CLSVOF-Method Interface Advection

Interface Advection
Having reconstructed the interface, we need to transport it with the given
velocity field u of the flow. Therefore we solve the transport equation for
the VOF-function:
F F
+ u F = 0 + (uF ) = F ( u)
t t
Let the velocity field u(n) at time t n be given. We want to compute the
VOF-function F n+1 at time t n+1 = t n + t. We discretize and obtain:

n+1 n t n x x
Fi,j = Fi,j + [(Fi1/2,j Fi+1/2,j ) + Fi,j (ui+1/2,j ui+1/2,j )]
x
t n y y
+ [(Fi,j1/2 Fi,j+1/2 ) + Fi,j (ui,j+1/2 ui,j+1/2 )]
y

In this equation a new quantity emerges: the flux F = (uF ) over the
edges of the cell.
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 29 / 52
The CLSVOF-Method Interface Advection

Interface Advection - Geometrical Considerations


The flux is a quantity defined on the edges, which depends on the velocity
and the fluid level F . But as F is non-smooth we cannot interpolate to
obtain a value on the edges. To overcome this problem and to conserve F
globally we derive F geometrically.

We assume that over the right edge the


x
fraction ui+1/2,j ty of the cell is
transported. Then we calculate:
x
ui+1/2,j (Vf )i+1/2,j (Vf )i+1/2,j
Fi+1/2,j = x =
ui+1/2,j ty ty

(Vf )i+1/2,j is the volume of the transported fluid and has to be determined
geometrically.
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 30 / 52
The CLSVOF-Method Interface Advection

Interface Advection - Advanced Techniques


It is of advantage to split the transport-equation into an x- and
y -advection, so that the transported volumina do not overlap. We obtain
the temporary fluid level F 0 after x-advection:
n + t x
0
Fi,j x (Fi1/2,j Fi+1/2,j ) ui,j
Fi,j = t x x
, implicit discretization of F ( )
1 x (ui+1/2,j ui1/2,j )
x

n+1 u y
The final fluid level Fi,j with explicit discretization of F ( yi,j ) is:
 
n+1 0 t y y t 0 0
Fi,j = Fi,j 1 + (ui,j+1/2 ui,j1/2 ) + (Fi,j1/2 Fi,j+1/2 )
y y

Since the flux F 0 of the temporary fluid level occurs, the interface
has again to be reconstructed the indicator-function is required.
The divergence term, which was retained despite of the
incompressibility, leads in this split version to more accurate results.
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 31 / 52
The CLSVOF-Method Interface Advection

Interface Advection - Overview

Now we summarize the procedure of the interface advection algorithm:

1 Solve the transport equation for F n in x-direction and obtain F 0


2 Solve the transport equation in x-direction for with special schemes
for the convective term (ENO - essentially nonoscillatory) and for the
time derivative (total variation diminishing - TVD Runge-Kutta)
3 Reconstruct the interface
4 Solve the transport equation for F 0 in y -direction and obtain F n+1
5 Solve the transport equation in y -direction for
6 Reconstruct the interface
7 Reinitialize in the neighborhood of the interface geometrically

If in every step the order of the directions of the advection is interchanged


then this scheme is second order accurate.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 32 / 52
The CLSVOF-Method Surface Tension Model

Surface Tension Model - Smoothed Heaviside-Function

Transforming surface forces into volume forces with the Heaviside-


function H was useful for the derivation of the whole-domain
formulation
Distributions like H are numerically not manageable on static grids
because of infinitely thin area of influence
Idea: Introduction of a smoothed Heaviside-function H with an area
of influence of 2

0,
if <
H () = 12 [1 + + 1 sin(
)], if ||


1, if >

Best accordance with analytical solutions for = 32 x = 23 y


Viscosity and density are also updated with H for numerical reasons
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 33 / 52
The CLSVOF-Method The Algorithm - an Overview

CLSVOF-Algorithm
1 To given un do the interface advection and reconstruction step
2 Update viscosity and density with smoothed Heaviside-function
3 Solve the momentum-conservation equation explicit (using the old
pressure p n ) and obtain u, which does not fulfill u = 0
4 With p n+1 = p n + p 0 calculate the pressure correction p 0 by solving:
 
1 0 1
p = u
n+1 t

5 Calculate the new velocity field un+1 = u t


n+1
p 0

There exist upper bounds for the size of the timestep t (h = x):
1/2
3 h2 (f + g )h3

h
t , t < , t <
2 max |u| 14 4

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 34 / 52
Bubble Formation on Nozzles

Bubble Formation on Nozzles


Validation
Dependence of Separation Volume on
Parameters

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 35 / 52
Bubble Formation on Nozzles Validation

Validation of Interface-Advection and -Reconstruction


Before we investigate the formation of bubbles on nozzles, we have to
ensure that the CLSVOF-method can describe realistic flows. Therefore it
is validated with certain test problems.

The first setting is a pure advection


of a hollow square in a constant
velocity field u = (2, 1)T .
Since in this case no deformation
occurs, the exact solution of this
advection problem is a mere
translation along u without change of
shape. The error can be calculated by
sim ex
P
i,j |Fi,j Fi,j |
E= P 0
i,j Fi,j

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 36 / 52
Bubble Formation on Nozzles Validation

Validation Simple Translation

The two pictures show the result after 500 timesteps on a 200 200 grid
with Courant number, CFL = max(|u|)t/x, of 0.25. The result is
overlayed with the exact solution. On the left CSLVOF-method - on the
right a standard discretization with a 2nd -order ENO-scheme.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 37 / 52
Bubble Formation on Nozzles Validation

Validation - Shear Flow

The second setting considers the deformation of a circle in a vortex:


u = (sin x cos y , cos x sin y )T , = (0, )2 , CFL = 0.25
The circle is located at (/2, /4) with radius /5
First 1000 (left) resp. 2000 (right) timesteps are calculated then the
result is integrated backwards 1000 resp. 2000 timesteps

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 38 / 52
Bubble Formation on Nozzles Validation

Validation - Mass Conservation and Surface Tension

Mass conservation can be easily checked by evaluating


Vfn = ( i,j Fi,j
0 n
P P
i,j Fi,j )xy

(for the advection and shear flow test in the order of 109 and 104 ).

To validate the surface tension model, which is very important for the
exact calculation of capillary forces, a static circular fluid element without
gravity is considered.
The jump condition then gives: [p] = = R
The mean pressure in the fluid element N1 N
P
i=1 pi is compared to it
(assuming that the ambient pressure is zero)
Since both fluids are considered nonviscous emerging parasitic
currents are not damped out.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 39 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Dependence of Separation Volume on Parameters


Equipped with this numerical tool, the main goal is now, to determine the
influence of certain physical parameters on the volume of the bubbles after
they have separated from the nozzle: the separation volume.
The Separation Volume as Function of Parameters
The big advantage of the numerical simulation is that we can vary just a
single parameter and investigate the resulting change:

Vb = f (Q, Rd , f , g , f , g , , s , g),

where Q denotes the volume flow rate.

Not in all cases does it make sense to consider all parameters:


Typically the ratios of the densities and viscosities are very small
Different bubble growth and bubble rise regimes
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 40 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Bubbles on Nozzles
We now have render the details for the special setting of bubbles on
nozzles more precisely.

The nozzle is modeled as a circular hole in the bottom plate with


infinitely sharp edges (ideal 90 edges)
The volume flow rate (denoted by Q) is considered to be constant
Vb = QTb
(Vb : separation volume, Tb : periodic time of bubbling)
Pressure fluctuations in the bubble are decoupled from the gas
reservoir (achieved e.g. through porous materials in gas conduit)

The bubbling can be split into three phases:


Bubble growth
Bubble separation
Bubble rise
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 41 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Quasi-Static Bubble Growth

For very small values of Q the bubble growth is that slow that in every
single point of time a static bubble shape (negligible small motion of the
fluids) can be assumed to exist.

Consequences for small Q


The only forces that determine the shape of the growing bubble are
capillary, static pressure and lifting forces
The list of parameters that influence Vb reduces to
Vb = f (Rd , f , g , , s , g)

Quasi-Analytical Solution
In this case a ODE for the contour of the bubble can be derived and solved
by high order schemes very accurate. These (quasi-analytical) results can
then again be used to validate the CLSVOF solver.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 42 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Single Periodic and Double Periodic Regimes

If the volume flow rate Q is increased the quasi-static bubble growth turns
into a process that is more affected by dynamic forces:
Single Periodic Dissolving
At a certain range the dissolving of the bubbles is periodic
Two successive bubbles do not affect the growth and dissolving
process of each other

Double Periodic Dissolving


Further increase of Q leads to vertical interactions of two bubbles
each
The flow field around the first bubble causes the second bubble to
dissolve earlier
Both regimes can be observed in simulations with the CLSVOF-method.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 43 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

SP- and DP-Regimes

On the left numerical results in the SP-regime are compared to


experiment with excellent accordance.
On the right is shown an example of a DP-regime during a numerical
simulation.

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 44 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Animation - Single Periodic Regime

This short movie shows the CLSVOF-solver simulating a single periodic


bubble generation.
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 45 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Static Contact Angle Model

Materials have different


wetting properties, i.e. how
favourable a liquid is for the
material.

Considering a droplet on a plate, the wetting property - with respect to


the gas, the fluid and the material - is characterized by the contact angle
s measured through the liquid.
During the bubble growth it can happen, that the interface of the bubble
evolves such, that the contact angle falls below s .

It is assumed that the contact angle of interface and plate is always


less or equal than s , regardless of angular velocity or hysteresis
To fulfill this assumption the contact line of the bubble possibly has
to spread out from the edge of the nozzle
Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 46 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Spreading of The Contact Line during Bubble Growth

In this example the interface of a growing bubble on a non-wetting


material is shown (s > 90 ).

In step (2) the maximum


angle = s is reached.
Further growth of the bubble
would result in reducing the
contact angle . To prohibit
this, the contact line travels
away from the edge to a
certain maximum distance
(step 6).

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 47 / 52
Bubble Formation on Nozzles Dependence of Separation Volume on Parameters

Separation Volume in Single Periodic Regime

A short overview, how the different parameters can influence the


separation volume Vb in the single periodic regime:
Volume flow rate Q: higher Q higher Vb ; at higher values of s
less effect
Radius of the nozzle Rd : affects Vb almost linearly; can prohibit
influence of s if high enough
Static contact angle s : until a critical value ( 50 ) nearly no
influence, then higher s higher Vb
Density of the fluid f : higher density smaller Vb
Viscosity of the fluid f : higher viscosity higher Vb
Surface tension : higher surface tension higher Vb

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 48 / 52
Perspectives

Perspectives

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 49 / 52
Perspectives

Perspectives - Electric Fields

The model we treated with the CLSVOF method included additional


volume and surface forces Kv and Ks
The numerical scheme can simulate the influence of electric fields on
the process, using the proper expressions for Kv and Ks
It could be shown that the separation volume of the bubbles is
significantly decreased with electric fields under certain circumstances

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 50 / 52
Perspectives

Thats it!
Questions?

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 51 / 52
Bibliography

Literature

Daniel Gerlach, Analyse von kapillar-dominanten


Zweiphasenstromungen mit einer kombinierten Level-Set und
Volume-of-Fluid Methode
Roberto Croce, Ein paralleler, dreidimensionaler Navier-Stokes-Loser
fur inkompressible Zweiphasenstromungen mit Oberflachenspannung,
Hindernissen und dynamischen Kontaktflachen
Ruben Scardovelli and Stephane Zaleski, Direct numerical simulation
of free-surface and interfacial flow

Christoph Strohmeyer (FAU Erlangen) Numerical Investigation of Bubbles December 16th 2008 52 / 52

You might also like