SlideShare a Scribd company logo
1 of 56
Download to read offline
welcome
Towards a numerical model for the twin jet
interaction in air
K. Intzes,
Internship, Mechanical Engineering TU/e
Thermofluids Engineering group - EfAM
Introduction (1)
- Subject
● High volume manufacturing of liquid products
by Inkjet printing (ENTHALPY Project)
● Realized by a multinozzle printer head
● Liquid jets sprayed at close proximity
● Potential jet – jet interaction
● Study the factors causing jet – jet attraction
Introduction (2)
- Summary
● The physical problem
● Boundary layer model
● Numerical Navier Stokes solver
● Results
● Discussion
The physical problem (1)
Printing head - Multi nozzle configuration
Liquid columns flowing near each other in air.
Air boundary layers develop (due to skin drag)
at the liquid – air interface
Expansion, possible interaction - collision
The physical problem (2)
- Primary physical phenomena inside the
induced air flow field
● Momentum influx from both sides
● Air supply from the sides
● Air velocity change close to the jets in the upper
region pressure variations
The physical problem (3) – domain of
interest
The physical problem (3) – domain of
interest cont.
The physical problem (4)
- Assumptions and governing equations
● Neglect of jet instability, break up
● Approximate jets by moving walls
● Icompressible, laminar air (induced) flow
● Steady – State problem
The physical problem (4)
- Assumptions and governing equations cont.
● Incompressibility constraint :
● Incompressible Navier Stokes :
● Scale with jet gap d, jet velocity U and ρνU/d
(pressure scale). Dimensionless form :
∇⋅⃗u = 0
⃗u⋅∇ ⃗u = −ρ−1
∇ p+ν Δ⃗u
Re⃗u⋅∇ ⃗u = −∇ p+Δ⃗u , Re =
dU
ν
The physical problem (5)
- Boundary conditions
● Walls : upper wall
moving walls
⃗u = ⃗0
⃗u = U
● No inflow in x-direction● No inflow in x-direction
● Free lateral and bottom boundaries
Boundary layer model
- A preliminary investigation of the boundary layer
growth
● Analytical model based on a air flow profile of
predifined shape : exponential decay of the
velocity magnitude in the downstream direction
w.r.t. The distance from the interface
● Assumptions : steady state, uniaxial, laminar air
flow, block liquid velocity profile
Boundary layer model (2)
- Boundary conditions
● u = liquid (jet) velocity at the air – liquid
interface, u(z,0) = ul0
(z)
● u = 0 at the boundary layer (and beyond)
● At the interface
[∂2
u
∂ y
2
+
1
a(z)
∂u
∂ y ]∣y=0
Boundary layer model (3)
- equations
● Momentum balance
● Interface flux balance
● Liquid jet mass balance
2π ρa ∫
0
δ(z)
[α(z)+y]u
2
(z , y)dy+ρl π α
2
(z)ul (z) = ρl π α0
2
(z)ul0
d
dz
[π ρl α2
(z)ul
2
(z)] = 2π α(z)μa
∂u
∂ y∣y=0
π α2
(z)ul (z)=π α0
2
ul0
Boundary layer model (3)
- equations cont.
● Air velocity profile
● Closes system of equations and satisfies the
boundary conditions
● Is a generic solution to the Navier Stokes
equations
u(z , y) = ul (z)
(1−
1
β(z)
ln
(1+
y
α(z))) β(z) = ln
[1+
δ(z)
α(z)]
Boundary layer model (4)
● Single jet analysis
● To fit for the twin jet problem, two single jet
solutions are superimposed
● Estimation of the interaction distance
- Pitfalls of the superposition approach :
● Solution not linear
● Different boundary conditions active in the twin
jet problem
● Only one velocity component considered
● Pressure field obtained by Bernoulli
The numerical solver (1)
- A global approach
● Custom Finite Volume discretization numerical
algorithm
● Aim to resolve the induced air flow field in the
domain
Numerical implentation
The numerical solver (2)
- Computational grid
● Standard staggered Finite Volume grid
● Velocity nodes control volumes shifted by half
grid size w.r.t. the scalar contol volumes
The numerical solver (3)
- Discretization
● Continuity : around scalar control volumes
x-direction velocity nodes : u
y-direction velocity nodes : v
z-direction velocity nodes : w
ui+1, J , K −ui , J , K
dx
+
vI , j+1, K −vI , j , K
dy
+
wI , J ,k−wI , J ,k+1
dz
= 0
The numerical solver (3)
- Discretization cont.
● Momentum equations : around staggered
control volumes in each respective direction
Central Difference scheme. For x-direction :
0 = −
pI , J ,K − pI−1, J , K
dx
+
ui−1, J , K−2ui , J , K+ui+1, J , K
dx2
+
ui , J −1, K−2ui , J , K+ui , J +1, K
dy2
+
ui , J ,K−1−2ui , J , K+ui , J , K +1
dz2
−
Re
dx (1
2
(ui+1, J , K+ui , J ,K )
1
2
(ui+1, J , K +ui , J , K)−
1
2
(ui , J , K+ui−1, J , K )
1
2
(ui , J , K +ui−1, J , K ))−
Re
dy (1
2
(vI −1, j+1, K+vI , j+1, K )
1
2
(ui , J +1, K+ui , J , K )−
1
2
(vI −1, j , K +vI , j , K)
1
2
(ui , J , K +ui , J−1, K ))−
Re
dz (1
2
(wI−1, J ,k+wI , J ,k )
1
2
(ui , J , K+ui , J , K −1)−
1
2
(wI −1, J ,k+1+wI , J , k+1)
1
2
(ui , J , K +ui , J , K +1))
The numerical solver (4)
- Boundary conditions
● Walls (moving walls and upper printer head) : no
slip
● z-y planes :
no flow in x-direction u = 0
zero tangential shear :
∂v
∂ x
=
∂ w
∂ x
= 0
The numerical solver (4)
- Boundary conditions cont.
● Lateral boundaries (x-y planes) :
zero normal velocity gradient and tangential
shear :
● Bottom boundary (x-z plane) : similarly
● Introduced by virtual points and discretized by
centrall diference
∂u
∂ z
=
∂v
∂ z
=
∂ w
∂ z
= 0
∂u
∂ y
=
∂ v
∂ y
=
∂ w
∂ y
= 0
The numerical solver (5)
- Iterative linear solver
● System of nonlinear discretized equations :
L : Discretization of Stokes equation, x :
degrees of freedom (velocity and pressure
nodes), C(x) : discretization of transport term,
b : boundary conditions
L x+C (x)−b = 0
The numerical solver (5)
- Iterative linear solver cont.
● Linearized system : Ax = b
● ILU(0) (Incomplete LU factorization with no fill-in)
left preconditioned restarted GMRES
● Fast converging, numerically robust, flexible
The numerical solver (6)
- Discrete Penalty Function Method
● Big zero block in the discretization matrix
● ILU(0) not applicable
● Modify continuity discretization as such :
● ε small (but not too small !) = 10-8
ui+1, J , K−ui , J , K
dx
+
vI , j+1, K−vI , j , K
dy
+
wI , J ,k−wI , J , k+1
dz
+εpI , J , K = 0
The numerical solver (7)
- Picard linearization iteration
● Non linearity requires convergence of the
solution inside iteration
● Linearized transport term : at iteration level k+1
● Iteration initiated with the solutionof the Stokes
eqation
● Stop when and
⃗u⋅∇ ⃗u = ⃗uk
⋅∇ ⃗uk+1
∣∣xk+1
−xk
∣∣inf < tol
∣∣L xk+1
+C(xk+1
)−b∣∣inf < tol
The numerical solver (8)
- Convergence stability and speed
● Under relaxation :
0 < a ≤ 1
● Continuation : Reynolds number increazed
incremantaly
Re Re / n, n positive integer
xk+1
= α xk+1
+(1−α) xk
The numerical solver (9)
- Algorithm overview
● 1. Data input
● 2. Grid
● 3. Discretization of The Stokes equation
● 4. Solution of the linear system
● 5. Discretization of transport terms (linearized)
● 6. Iterate full Navier Stokes
● 7. output
Numerical nesults (1)
- Results for the Stokes problem
● Air at temperature : 20 o
C
● Moving wall velocity : -12 m/s
● Jet gap : 300μm
● Reynolds number : 79.42
Velocity magnitude contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 12 m/s, jet gap = 300 μm
Velocity magnitude contour in the x – z top-plane of the domain.
Incoming jet velocity = - 12 m/s, jet gap = 300 μm
Fig. 17 : Pressure contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 12 m/s, jet gap = 300 μm
Pressure contour in the x – z top-plane of the domain. Incoming jet
velocity = - 12 m/s, jet gap = 300 μm
Numerical nesults (2)
- Results for the Stokes problem
● Air at temperature : 20 o
C
● Moving wall velocity : -12 m/s
● Jet gap : 500μm
● Reynolds number : 79.42
Velocity magnitude contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 12 m/s, jet gap = 500 μm
Pressure contour in the x – y mid-plane of the domain. Incoming jet
velocity = - 12 m/s, jet gap = 500 μm
Numerical nesults (3)
- Results for the Stokes problem
● Air at temperature : 20 o
C
● Moving wall velocity : -4 m/s
● Jet gap : 300μm
● Reynolds number : 26.47
Velocity magnitude contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 4 m/s, jet gap = 300 μm
Pressure contour in the x – y mid-plane of the domain. Incoming jet
velocity = - 4 m/s, jet gap = 300 μm
Numerical nesults (4)
- Results for the Navier Stokes problem
● Air at temperature : 20 o
C
● Moving wall velocity : -0.5 m/s
● Jet gap : 300μm
● Reynolds number : 3.31
Velocity magnitude contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 0.5 m/s, jet gap = 300 μm
Pressure contour in the x – y mid-plane of the domain. Incoming jet
velocity = - 0.5 m/s, jet gap = 300 μm
Numerical nesults (5)
- Results for the Navier Stokes problem
● Air at temperature : 20 o
C
● Moving wall velocity : -2 m/s
● Jet gap : 300μm
● Reynolds number : 13.27
Velocity magnitude contour in the x – y mid-plane of the domain.
Incoming jet velocity = - 2 m/s, jet gap = 300 μm
Pressure contour in the x – y mid-plane of the domain. Incoming jet
velocity = - 2 m/s, jet gap = 300 μm
Numerical nesults (2) - discussion
● Velocity boundary conditions succesful
● Development of boundary layer expands far
downstream
● No stagnate flow region
Numerical nesults (3) - discussion
● Pressure field unrealistic
● Numerical results sound from a numerical point
of view only. Comparison of cases reveals trend
● Pressure virtual grid points
● No distinct driving force
Closing remarks
● Sudden velocity change near jet walls in the
upper region gives rise to pressure gradients
● Reconsider boundary conditions
● Challenging physical problem equals
challenging numerical problem
Well thought out boundary conditions !

More Related Content

What's hot

Projectile Motion
Projectile MotionProjectile Motion
Projectile MotionArlo Alegre
 
Real Time Code Generation for Nonlinear Model Predictive Control
Real Time Code Generation for Nonlinear Model Predictive ControlReal Time Code Generation for Nonlinear Model Predictive Control
Real Time Code Generation for Nonlinear Model Predictive ControlBehzad Samadi
 
7.3 volumes by cylindrical shells
7.3 volumes by cylindrical shells7.3 volumes by cylindrical shells
7.3 volumes by cylindrical shellsdicosmo178
 
6.2 volume of solid of revolution dfs
6.2  volume of solid of revolution dfs6.2  volume of solid of revolution dfs
6.2 volume of solid of revolution dfsFarhana Shaheen
 
Comparison GUM versus GUM+1
Comparison GUM  versus GUM+1Comparison GUM  versus GUM+1
Comparison GUM versus GUM+1Maurice Maeck
 
Volumes of solids of revolution dfs
Volumes of solids of revolution dfsVolumes of solids of revolution dfs
Volumes of solids of revolution dfsFarhana Shaheen
 
Projectile motion
Projectile motionProjectile motion
Projectile motiongngr0810
 
Robust model predictive control for discrete-time fractional-order systems
Robust model predictive control for discrete-time fractional-order systemsRobust model predictive control for discrete-time fractional-order systems
Robust model predictive control for discrete-time fractional-order systemsPantelis Sopasakis
 
1D Simulation of intake manifolds in single-cylinder reciprocating engine
1D Simulation of intake manifolds in single-cylinder reciprocating engine1D Simulation of intake manifolds in single-cylinder reciprocating engine
1D Simulation of intake manifolds in single-cylinder reciprocating engineJuan Manzanero Torrico
 
Nyquist and polar plot 118 &amp; 117
Nyquist and polar plot 118 &amp; 117Nyquist and polar plot 118 &amp; 117
Nyquist and polar plot 118 &amp; 117RishabhKashyap2
 
mat lab introduction and basics to learn
mat lab introduction and basics to learnmat lab introduction and basics to learn
mat lab introduction and basics to learnpavan373
 
Ignations Antoniadis "Inflation from supersymmetry breaking"
Ignations Antoniadis "Inflation from supersymmetry breaking"Ignations Antoniadis "Inflation from supersymmetry breaking"
Ignations Antoniadis "Inflation from supersymmetry breaking"SEENET-MTP
 

What's hot (18)

U unit4 vm
U unit4 vmU unit4 vm
U unit4 vm
 
Projectile Motion
Projectile MotionProjectile Motion
Projectile Motion
 
Real Time Code Generation for Nonlinear Model Predictive Control
Real Time Code Generation for Nonlinear Model Predictive ControlReal Time Code Generation for Nonlinear Model Predictive Control
Real Time Code Generation for Nonlinear Model Predictive Control
 
7.3 volumes by cylindrical shells
7.3 volumes by cylindrical shells7.3 volumes by cylindrical shells
7.3 volumes by cylindrical shells
 
6.2 volume of solid of revolution dfs
6.2  volume of solid of revolution dfs6.2  volume of solid of revolution dfs
6.2 volume of solid of revolution dfs
 
Comparison GUM versus GUM+1
Comparison GUM  versus GUM+1Comparison GUM  versus GUM+1
Comparison GUM versus GUM+1
 
Volumes of solids of revolution dfs
Volumes of solids of revolution dfsVolumes of solids of revolution dfs
Volumes of solids of revolution dfs
 
Lecture 12 f17
Lecture 12 f17Lecture 12 f17
Lecture 12 f17
 
Curl
CurlCurl
Curl
 
Projectile motion
Projectile motionProjectile motion
Projectile motion
 
Robust model predictive control for discrete-time fractional-order systems
Robust model predictive control for discrete-time fractional-order systemsRobust model predictive control for discrete-time fractional-order systems
Robust model predictive control for discrete-time fractional-order systems
 
Finite frequency H∞control design for nonlinear systems
Finite frequency H∞control design for nonlinear systemsFinite frequency H∞control design for nonlinear systems
Finite frequency H∞control design for nonlinear systems
 
1D Simulation of intake manifolds in single-cylinder reciprocating engine
1D Simulation of intake manifolds in single-cylinder reciprocating engine1D Simulation of intake manifolds in single-cylinder reciprocating engine
1D Simulation of intake manifolds in single-cylinder reciprocating engine
 
residue
residueresidue
residue
 
Nyquist and polar plot 118 &amp; 117
Nyquist and polar plot 118 &amp; 117Nyquist and polar plot 118 &amp; 117
Nyquist and polar plot 118 &amp; 117
 
mat lab introduction and basics to learn
mat lab introduction and basics to learnmat lab introduction and basics to learn
mat lab introduction and basics to learn
 
Ignations Antoniadis "Inflation from supersymmetry breaking"
Ignations Antoniadis "Inflation from supersymmetry breaking"Ignations Antoniadis "Inflation from supersymmetry breaking"
Ignations Antoniadis "Inflation from supersymmetry breaking"
 
Deflection in beams 1
Deflection in beams 1Deflection in beams 1
Deflection in beams 1
 

Viewers also liked

Viewers also liked (6)

Bongs
BongsBongs
Bongs
 
Real estate business in ncr
Real estate business in ncrReal estate business in ncr
Real estate business in ncr
 
Boone presentation
Boone presentationBoone presentation
Boone presentation
 
Medios de transporte
Medios de transporteMedios de transporte
Medios de transporte
 
Evolución histórica de la información
Evolución histórica de la informaciónEvolución histórica de la información
Evolución histórica de la información
 
Allan Delsaut's Guide to Dental Implants
Allan Delsaut's Guide to Dental ImplantsAllan Delsaut's Guide to Dental Implants
Allan Delsaut's Guide to Dental Implants
 

Similar to TwinJetModeling

EAGES Proceedings - D. N. Sinitsyn
EAGES Proceedings - D. N. SinitsynEAGES Proceedings - D. N. Sinitsyn
EAGES Proceedings - D. N. SinitsynStephan Aubin
 
009b (PPT) Viscous Flow -2.pdf .
009b (PPT) Viscous Flow -2.pdf           .009b (PPT) Viscous Flow -2.pdf           .
009b (PPT) Viscous Flow -2.pdf .happycocoman
 
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigation
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical InvestigationAerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigation
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigationdrboon
 
ODDLS: Overlapping domain decomposition Level Set Method
ODDLS: Overlapping domain decomposition Level Set MethodODDLS: Overlapping domain decomposition Level Set Method
ODDLS: Overlapping domain decomposition Level Set MethodAleix Valls
 
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...SahilJawa3
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfRTEFGDFGJU
 
Numerical study of natural convection in an enclosed
Numerical study of natural convection in an enclosedNumerical study of natural convection in an enclosed
Numerical study of natural convection in an enclosedeSAT Publishing House
 
Sprittles presentation
Sprittles presentationSprittles presentation
Sprittles presentationJamesSprittles
 
Integration application (Aplikasi Integral)
Integration application (Aplikasi Integral)Integration application (Aplikasi Integral)
Integration application (Aplikasi Integral)Muhammad Luthfan
 
2D CFD Code Based on MATLAB- As Good As FLUENT!
2D CFD Code Based on MATLAB- As Good As FLUENT!2D CFD Code Based on MATLAB- As Good As FLUENT!
2D CFD Code Based on MATLAB- As Good As FLUENT!Jiannan Tan
 
Numerical simulation on laminar convection flow and heat transfer over a non ...
Numerical simulation on laminar convection flow and heat transfer over a non ...Numerical simulation on laminar convection flow and heat transfer over a non ...
Numerical simulation on laminar convection flow and heat transfer over a non ...eSAT Journals
 
Chap-1 Preliminary Concepts and Linear Finite Elements.pptx
Chap-1 Preliminary Concepts and Linear Finite Elements.pptxChap-1 Preliminary Concepts and Linear Finite Elements.pptx
Chap-1 Preliminary Concepts and Linear Finite Elements.pptxSamirsinh Parmar
 
characteristic of function, average rate chnage, instant rate chnage.pptx
characteristic of function, average rate chnage, instant rate chnage.pptxcharacteristic of function, average rate chnage, instant rate chnage.pptx
characteristic of function, average rate chnage, instant rate chnage.pptxPallaviGupta66118
 

Similar to TwinJetModeling (20)

EAGES Proceedings - D. N. Sinitsyn
EAGES Proceedings - D. N. SinitsynEAGES Proceedings - D. N. Sinitsyn
EAGES Proceedings - D. N. Sinitsyn
 
009b (PPT) Viscous Flow -2.pdf .
009b (PPT) Viscous Flow -2.pdf           .009b (PPT) Viscous Flow -2.pdf           .
009b (PPT) Viscous Flow -2.pdf .
 
cfd ahmed body
cfd ahmed bodycfd ahmed body
cfd ahmed body
 
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigation
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical InvestigationAerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigation
Aerodynamic and Acoustic Parameters of a Coandã Flow – a Numerical Investigation
 
ODDLS: Overlapping domain decomposition Level Set Method
ODDLS: Overlapping domain decomposition Level Set MethodODDLS: Overlapping domain decomposition Level Set Method
ODDLS: Overlapping domain decomposition Level Set Method
 
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...
2018SOE07-Kim-Computation of Added resistance of ships by using a frequency-d...
 
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdfreservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
reservoir-modeling-using-matlab-the-matalb-reservoir-simulation-toolbox-mrst.pdf
 
Numerical study of natural convection in an enclosed
Numerical study of natural convection in an enclosedNumerical study of natural convection in an enclosed
Numerical study of natural convection in an enclosed
 
Sprittles presentation
Sprittles presentationSprittles presentation
Sprittles presentation
 
Optimisation random graph presentation
Optimisation random graph presentationOptimisation random graph presentation
Optimisation random graph presentation
 
Integration application (Aplikasi Integral)
Integration application (Aplikasi Integral)Integration application (Aplikasi Integral)
Integration application (Aplikasi Integral)
 
NS Equation .pdf
NS Equation .pdfNS Equation .pdf
NS Equation .pdf
 
Ms2018
Ms2018Ms2018
Ms2018
 
2D CFD Code Based on MATLAB- As Good As FLUENT!
2D CFD Code Based on MATLAB- As Good As FLUENT!2D CFD Code Based on MATLAB- As Good As FLUENT!
2D CFD Code Based on MATLAB- As Good As FLUENT!
 
New name-400-4
New name-400-4New name-400-4
New name-400-4
 
CLIM Fall 2017 Course: Statistics for Climate Research, Spatial Data: Models ...
CLIM Fall 2017 Course: Statistics for Climate Research, Spatial Data: Models ...CLIM Fall 2017 Course: Statistics for Climate Research, Spatial Data: Models ...
CLIM Fall 2017 Course: Statistics for Climate Research, Spatial Data: Models ...
 
lecture-2-not.pdf
lecture-2-not.pdflecture-2-not.pdf
lecture-2-not.pdf
 
Numerical simulation on laminar convection flow and heat transfer over a non ...
Numerical simulation on laminar convection flow and heat transfer over a non ...Numerical simulation on laminar convection flow and heat transfer over a non ...
Numerical simulation on laminar convection flow and heat transfer over a non ...
 
Chap-1 Preliminary Concepts and Linear Finite Elements.pptx
Chap-1 Preliminary Concepts and Linear Finite Elements.pptxChap-1 Preliminary Concepts and Linear Finite Elements.pptx
Chap-1 Preliminary Concepts and Linear Finite Elements.pptx
 
characteristic of function, average rate chnage, instant rate chnage.pptx
characteristic of function, average rate chnage, instant rate chnage.pptxcharacteristic of function, average rate chnage, instant rate chnage.pptx
characteristic of function, average rate chnage, instant rate chnage.pptx
 

TwinJetModeling

  • 1. welcome Towards a numerical model for the twin jet interaction in air K. Intzes, Internship, Mechanical Engineering TU/e Thermofluids Engineering group - EfAM
  • 2. Introduction (1) - Subject ● High volume manufacturing of liquid products by Inkjet printing (ENTHALPY Project) ● Realized by a multinozzle printer head ● Liquid jets sprayed at close proximity ● Potential jet – jet interaction ● Study the factors causing jet – jet attraction
  • 3. Introduction (2) - Summary ● The physical problem ● Boundary layer model ● Numerical Navier Stokes solver ● Results ● Discussion
  • 4. The physical problem (1) Printing head - Multi nozzle configuration Liquid columns flowing near each other in air. Air boundary layers develop (due to skin drag) at the liquid – air interface Expansion, possible interaction - collision
  • 5. The physical problem (2) - Primary physical phenomena inside the induced air flow field ● Momentum influx from both sides ● Air supply from the sides ● Air velocity change close to the jets in the upper region pressure variations
  • 6.
  • 7. The physical problem (3) – domain of interest
  • 8. The physical problem (3) – domain of interest cont.
  • 9. The physical problem (4) - Assumptions and governing equations ● Neglect of jet instability, break up ● Approximate jets by moving walls ● Icompressible, laminar air (induced) flow ● Steady – State problem
  • 10. The physical problem (4) - Assumptions and governing equations cont. ● Incompressibility constraint : ● Incompressible Navier Stokes : ● Scale with jet gap d, jet velocity U and ρνU/d (pressure scale). Dimensionless form : ∇⋅⃗u = 0 ⃗u⋅∇ ⃗u = −ρ−1 ∇ p+ν Δ⃗u Re⃗u⋅∇ ⃗u = −∇ p+Δ⃗u , Re = dU ν
  • 11. The physical problem (5) - Boundary conditions ● Walls : upper wall moving walls ⃗u = ⃗0 ⃗u = U ● No inflow in x-direction● No inflow in x-direction ● Free lateral and bottom boundaries
  • 12.
  • 13. Boundary layer model - A preliminary investigation of the boundary layer growth ● Analytical model based on a air flow profile of predifined shape : exponential decay of the velocity magnitude in the downstream direction w.r.t. The distance from the interface ● Assumptions : steady state, uniaxial, laminar air flow, block liquid velocity profile
  • 14.
  • 15. Boundary layer model (2) - Boundary conditions ● u = liquid (jet) velocity at the air – liquid interface, u(z,0) = ul0 (z) ● u = 0 at the boundary layer (and beyond) ● At the interface [∂2 u ∂ y 2 + 1 a(z) ∂u ∂ y ]∣y=0
  • 16. Boundary layer model (3) - equations ● Momentum balance ● Interface flux balance ● Liquid jet mass balance 2π ρa ∫ 0 δ(z) [α(z)+y]u 2 (z , y)dy+ρl π α 2 (z)ul (z) = ρl π α0 2 (z)ul0 d dz [π ρl α2 (z)ul 2 (z)] = 2π α(z)μa ∂u ∂ y∣y=0 π α2 (z)ul (z)=π α0 2 ul0
  • 17. Boundary layer model (3) - equations cont. ● Air velocity profile ● Closes system of equations and satisfies the boundary conditions ● Is a generic solution to the Navier Stokes equations u(z , y) = ul (z) (1− 1 β(z) ln (1+ y α(z))) β(z) = ln [1+ δ(z) α(z)]
  • 18. Boundary layer model (4) ● Single jet analysis ● To fit for the twin jet problem, two single jet solutions are superimposed ● Estimation of the interaction distance - Pitfalls of the superposition approach : ● Solution not linear ● Different boundary conditions active in the twin jet problem ● Only one velocity component considered ● Pressure field obtained by Bernoulli
  • 19.
  • 20.
  • 21.
  • 22. The numerical solver (1) - A global approach ● Custom Finite Volume discretization numerical algorithm ● Aim to resolve the induced air flow field in the domain Numerical implentation
  • 23. The numerical solver (2) - Computational grid ● Standard staggered Finite Volume grid ● Velocity nodes control volumes shifted by half grid size w.r.t. the scalar contol volumes
  • 24.
  • 25. The numerical solver (3) - Discretization ● Continuity : around scalar control volumes x-direction velocity nodes : u y-direction velocity nodes : v z-direction velocity nodes : w ui+1, J , K −ui , J , K dx + vI , j+1, K −vI , j , K dy + wI , J ,k−wI , J ,k+1 dz = 0
  • 26. The numerical solver (3) - Discretization cont. ● Momentum equations : around staggered control volumes in each respective direction Central Difference scheme. For x-direction : 0 = − pI , J ,K − pI−1, J , K dx + ui−1, J , K−2ui , J , K+ui+1, J , K dx2 + ui , J −1, K−2ui , J , K+ui , J +1, K dy2 + ui , J ,K−1−2ui , J , K+ui , J , K +1 dz2 − Re dx (1 2 (ui+1, J , K+ui , J ,K ) 1 2 (ui+1, J , K +ui , J , K)− 1 2 (ui , J , K+ui−1, J , K ) 1 2 (ui , J , K +ui−1, J , K ))− Re dy (1 2 (vI −1, j+1, K+vI , j+1, K ) 1 2 (ui , J +1, K+ui , J , K )− 1 2 (vI −1, j , K +vI , j , K) 1 2 (ui , J , K +ui , J−1, K ))− Re dz (1 2 (wI−1, J ,k+wI , J ,k ) 1 2 (ui , J , K+ui , J , K −1)− 1 2 (wI −1, J ,k+1+wI , J , k+1) 1 2 (ui , J , K +ui , J , K +1))
  • 27.
  • 28. The numerical solver (4) - Boundary conditions ● Walls (moving walls and upper printer head) : no slip ● z-y planes : no flow in x-direction u = 0 zero tangential shear : ∂v ∂ x = ∂ w ∂ x = 0
  • 29. The numerical solver (4) - Boundary conditions cont. ● Lateral boundaries (x-y planes) : zero normal velocity gradient and tangential shear : ● Bottom boundary (x-z plane) : similarly ● Introduced by virtual points and discretized by centrall diference ∂u ∂ z = ∂v ∂ z = ∂ w ∂ z = 0 ∂u ∂ y = ∂ v ∂ y = ∂ w ∂ y = 0
  • 30. The numerical solver (5) - Iterative linear solver ● System of nonlinear discretized equations : L : Discretization of Stokes equation, x : degrees of freedom (velocity and pressure nodes), C(x) : discretization of transport term, b : boundary conditions L x+C (x)−b = 0
  • 31. The numerical solver (5) - Iterative linear solver cont. ● Linearized system : Ax = b ● ILU(0) (Incomplete LU factorization with no fill-in) left preconditioned restarted GMRES ● Fast converging, numerically robust, flexible
  • 32. The numerical solver (6) - Discrete Penalty Function Method ● Big zero block in the discretization matrix ● ILU(0) not applicable ● Modify continuity discretization as such : ● ε small (but not too small !) = 10-8 ui+1, J , K−ui , J , K dx + vI , j+1, K−vI , j , K dy + wI , J ,k−wI , J , k+1 dz +εpI , J , K = 0
  • 33.
  • 34. The numerical solver (7) - Picard linearization iteration ● Non linearity requires convergence of the solution inside iteration ● Linearized transport term : at iteration level k+1 ● Iteration initiated with the solutionof the Stokes eqation ● Stop when and ⃗u⋅∇ ⃗u = ⃗uk ⋅∇ ⃗uk+1 ∣∣xk+1 −xk ∣∣inf < tol ∣∣L xk+1 +C(xk+1 )−b∣∣inf < tol
  • 35. The numerical solver (8) - Convergence stability and speed ● Under relaxation : 0 < a ≤ 1 ● Continuation : Reynolds number increazed incremantaly Re Re / n, n positive integer xk+1 = α xk+1 +(1−α) xk
  • 36. The numerical solver (9) - Algorithm overview ● 1. Data input ● 2. Grid ● 3. Discretization of The Stokes equation ● 4. Solution of the linear system ● 5. Discretization of transport terms (linearized) ● 6. Iterate full Navier Stokes ● 7. output
  • 37. Numerical nesults (1) - Results for the Stokes problem ● Air at temperature : 20 o C ● Moving wall velocity : -12 m/s ● Jet gap : 300μm ● Reynolds number : 79.42
  • 38. Velocity magnitude contour in the x – y mid-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 300 μm
  • 39. Velocity magnitude contour in the x – z top-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 300 μm
  • 40. Fig. 17 : Pressure contour in the x – y mid-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 300 μm
  • 41. Pressure contour in the x – z top-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 300 μm
  • 42. Numerical nesults (2) - Results for the Stokes problem ● Air at temperature : 20 o C ● Moving wall velocity : -12 m/s ● Jet gap : 500μm ● Reynolds number : 79.42
  • 43. Velocity magnitude contour in the x – y mid-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 500 μm
  • 44. Pressure contour in the x – y mid-plane of the domain. Incoming jet velocity = - 12 m/s, jet gap = 500 μm
  • 45. Numerical nesults (3) - Results for the Stokes problem ● Air at temperature : 20 o C ● Moving wall velocity : -4 m/s ● Jet gap : 300μm ● Reynolds number : 26.47
  • 46. Velocity magnitude contour in the x – y mid-plane of the domain. Incoming jet velocity = - 4 m/s, jet gap = 300 μm
  • 47. Pressure contour in the x – y mid-plane of the domain. Incoming jet velocity = - 4 m/s, jet gap = 300 μm
  • 48. Numerical nesults (4) - Results for the Navier Stokes problem ● Air at temperature : 20 o C ● Moving wall velocity : -0.5 m/s ● Jet gap : 300μm ● Reynolds number : 3.31
  • 49. Velocity magnitude contour in the x – y mid-plane of the domain. Incoming jet velocity = - 0.5 m/s, jet gap = 300 μm
  • 50. Pressure contour in the x – y mid-plane of the domain. Incoming jet velocity = - 0.5 m/s, jet gap = 300 μm
  • 51. Numerical nesults (5) - Results for the Navier Stokes problem ● Air at temperature : 20 o C ● Moving wall velocity : -2 m/s ● Jet gap : 300μm ● Reynolds number : 13.27
  • 52. Velocity magnitude contour in the x – y mid-plane of the domain. Incoming jet velocity = - 2 m/s, jet gap = 300 μm
  • 53. Pressure contour in the x – y mid-plane of the domain. Incoming jet velocity = - 2 m/s, jet gap = 300 μm
  • 54. Numerical nesults (2) - discussion ● Velocity boundary conditions succesful ● Development of boundary layer expands far downstream ● No stagnate flow region
  • 55. Numerical nesults (3) - discussion ● Pressure field unrealistic ● Numerical results sound from a numerical point of view only. Comparison of cases reveals trend ● Pressure virtual grid points ● No distinct driving force
  • 56. Closing remarks ● Sudden velocity change near jet walls in the upper region gives rise to pressure gradients ● Reconsider boundary conditions ● Challenging physical problem equals challenging numerical problem Well thought out boundary conditions !