0% found this document useful (0 votes)
53 views

Simulation of Synthetic Jets in Quiescent Air Using Unsteady Reynolds Averaged Navier-Stokes Equations

The document discusses simulations of synthetic jets created by a piezoelectric actuator in quiescent air. It compares computational results using turbulence models to experimental data. Grid refinement, preconditioning, and time step variation are examined. Governing equations, discretization methods, and the numerical solution algorithm are described.
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
53 views

Simulation of Synthetic Jets in Quiescent Air Using Unsteady Reynolds Averaged Navier-Stokes Equations

The document discusses simulations of synthetic jets created by a piezoelectric actuator in quiescent air. It compares computational results using turbulence models to experimental data. Grid refinement, preconditioning, and time step variation are examined. Governing equations, discretization methods, and the numerical solution algorithm are described.
Copyright
© © All Rights Reserved
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 17

Simulation of Synthetic Jets in Quiescent Air Using Unsteady Reynolds

Averaged Navier-Stokes Equations


Veer N. Vatsa
NASA Langley Research Center, Hampton, VA 23681
Eli Turkel
Tel-Aviv University, Israel and NIA, Hampton, VA 23681
Abstract
We apply an unsteady Reynolds-averaged Navier-Stokes (URANS) solver for the simulation
of a synthetic jet created by a single diaphragm piezoelectric actuator in quiescent air. This configuration was designated as Case 1 for the CFDVAL2004 workshop held at Williamsburg, Virginia,
in March 2004. Time-averaged and instantaneous data for this case were obtained at NASA Langley Research Center, using multiple measurement techniques. Computational results for this case
using one-equation Spalart-Allmaras and two-equation Menters turbulence models are presented
along with the experimental data. The effect of grid refinement, preconditioning and time-step
variation are also examined in this paper.

Introduction
Significant interest has been growing in the aerospace community in the field of flow control
in recent years. An entire AIAA conference is now devoted every other year to this field. In
March 2004, NASA Langley Research Center, in conjunction with five other international organizations held the CFDVAL2004 workshop,1 in Williamsburg, Virginia. The primary objective of
this workshop was to assess the state of the art for measuring and computing aerodynamic flows
in the presence of synthetic jets. Thomas, Choudhari, and Joslin2 have conducted an exhaustive
and comprehensive survey identifying the feasibility of using active flow control to improve the
performance of both external and internal flows. Suggested applications cover a wide range from
smart materials and micro-electro-mechanical-systems (MEMS) to synthetic zero net mass jets for
enhancing control forces, reducing drag, increasing lift, and enhancing mixing, to name a few.
It is also conjectured that active flow control would permit the use of thicker wing sections in
non-conventional configurations, such as the blended wing body (BWB) configuration, without
compromising the aerodynamic performance.

Senior Research Scientist, Senior Member AIAA


Professor, Department of Mathematics, Associate Fellow AIAA
1

OF

17

Most of the research in the area of active flow control is of an empirical nature, mainly due
to the cost and lack of confidence in computational methods for such complex flows. However,
without the availability of efficient and well-calibrated computational tools, it will be a very difficult, expensive, and slow process to determine the optimum layout and placement for active flow
control devices in practical applications. With the continuous reduction of computer costs in recent years, researchers are devoting more attention to the simulation of such unsteady flows and
flow control devices from a computational point of view [Ref. 3-8]. With few exceptions, most
of the numerical studies are undertaken without an active interaction with experimental investigators. Comparisons with experimental data are sometimes done years after the experimental data
have been acquired. Under such a scenario, one has to reconstruct many of the details about the
experimental arrangement and boundary conditions without the benefit of concrete and consistent
information. Based on our experience from previous validation exercises,9 we recognized the need
for active collaboration of the computational and experimental research. Without a symbiotic relationship between the two groups, major misunderstandings can develop when results from these
disciplines differ significantly. We were very fortunate to have a cooperative relationship with the
researchers conducting the experiments, as well as access to pertinent experimental data.
Our primary objective for this work is to calibrate an existing computational scheme with experimental data for the time-dependent flows encountered in active flow control environments. We
devote special attention to establishing appropriate boundary conditions for such flows, especially
in the absence of the detailed experimental data required for closure.
The configuration chosen for CFD validation is identified as Case 1 in the CFDVAL2004 workshop1 and represents an isolated synthetic jet formed by a single diaphragm, piezoelectric actuator
exhausting into ambient quiescent air. Multiple measurement techniques, including PIV, LDV, and
hotwire probes were used to generate a large body of experimental data for this configuration. References 1 and 10 describe the details of the experimental setup and geometric configuration. In
this paper, we assess the effects of grid refinement, preconditioning and turbulence models on the
computational simulations of the flow field generated by this flow control device. We replace the
actuator cavity with a simpler configuration in the present simulations. We demonstrate and calibrate our computational method for simulating synthetic jets by comparing the numerical results
with the experimental data.

Governing Equations
A generalized form of the thin layer Navier-Stokes (N-S) equations is used to model the flow.
The equation set is obtained from the complete N-S equations by retaining the viscous diffusion
terms normal to the solid surfaces in every coordinate direction. For a body-fitted coordinate

OF

17

system (, , ) fixed in time, these equations can be written in the conservative form as:
V ol

(U) (F Fv ) (G Gv ) (H Hv )
+
+
+
=0
t

(1)

where U represents the conserved variable vector. The vectors F, G, H, and Fv , Gv , Hv represent
the convective and diffusive fluxes in the three transformed coordinate directions, respectively.
In Eq. (1), Vol represents the cell volume or the Jacobian of the coordinate transformation. A
multigrid-based, multiblock structured grid flow solver TLNS3D, developed at NASA Langley
Research Center is used for the solution of the governing equations. References 11 and 12 describe
the TLNS3D solver in detail, therefore only a brief summary of its general features is included here.

Discretization
The spatial terms in Eq. (1) are discretized using a cell-centered finite volume scheme. The
convection terms are discretized using second-order central differences with a matrix artificial dissipation (second- and fourth- difference dissipation) added to suppress the odd-even decoupling
and oscillations in the vicinity of shock waves and stagnation points.1315 The viscous terms are
discretized with second-order accurate central difference formulas.11 The zero-equation model
of Baldwin-Lomax,16 one-equation model of Spalart-Allmaras17 and Menters two-equation SST
model18 are available in TLNS3D code for simulating turbulent flows. For the present computations, the Spalart-Allmaras (SA) model and the Menters SST model are used.
Regrouping the terms on the right-hand side into convective and diffusive terms, Eq. (1) can
be rewritten as:
dU
= C(U) + Dp (U) + Da (U)
dt

(2)

where C(U), Dp (U), and Da (U) are the convection, physical diffusion, and artificial diffusion
terms, respectively. These terms include the cell volume or the Jacobian of the coordinate transformation.
The time-derivative term can be approximated to any desired order of accuracy by a Taylor
series
dU
1
=
[a0 Un+1 + a1 Un + a2 Un1 + a3 Un2 + ...]
dt
t

(3)

The superscript n represents the last time level at which the solution is known, and n + 1 refers
to the next time level to which the solution will be advanced. Similarly, n 1 refers to the solution
at one time level before the current solution. Eq. (3) represents a generalized backward difference
scheme (BDF) in time, where the order of accuracy is determined by the choice of coefficients
3 OF 17

a0 , a1 , a2 ... etc. For example, a0 = 1.5, a1 = 2 and a2 = .5, results in a second-order


accurate scheme (BDF2) in time, which is the primary scheme chosen for this work because of
its unconditional stability and good robustness properties.19 Regrouping the time-dependent terms
and the original steady-state operator leads to the equation:
a0 n+1 E(Un,n1,.. )
U
+
= S(Un )
t
t

(4)

where E(Un,n1,.. ) depends only on the solution vector at time levels n and earlier. S represents
the steady-state operator or the right-hand side of Eq. (2). By adding a pseudo-time term, we
rewrite the above equation as:
U
a0 n+1 E(Un,n1,.. )
+
+
U
= S(Un )

t
t

(5)

Solution Algorithm
The algorithm for solving unsteady flow relies on the steady-state algorithm in the TLNS3D
code.11, 12 The basic algorithm consists of a five-stage Runge-Kutta time-stepping scheme for advancing the solution in pseudo-time. Efficiency of this algorithm is enhanced through the use of
local time-stepping, residual smoothing and multigrid techniques developed for solving steadystate equations. Because the Mach number in much of the domain is very low, we consider the use
of preconditioning methods20, 21 to improve the efficiency and accuracy of the flow solver.
In order to solve the time-dependent Navier-Stokes equations (Eq. 5), we add another iteration
loop in physical time outside the pseudo-time iteration loop. For fixed values of E(Un,n1,.. ),
we iterate on Un+1 using the standard multigrid procedure of TLNS3D developed for steadya0
U + E(U)
S(U) approaches zero. This strategy, originally
state, until the the pseudo-residual t
t
22
proposed by Jameson for Euler equations and adapted for the TLNS3D viscous flow solver by
Melson et. al,19 is popularly known as the dual time-stepping scheme for solving unsteady flows.
The process is repeated until the desired number of physical time steps is completed. The details
of the TLNS3D flow code for solving unsteady flows are available in Ref. 19, 23, 24 and 25.

Boundary Conditions
The boundary conditions required for solving the Navier-Stokes equations, such as the no-slip,
no injection, fixed wall temperature or adiabatic wall, far-field and extrapolation conditions, are
well understood and readily available in most flow codes including the TLNS3D code. On the
other hand, accurate simulation of oscillating diaphragm requires information about mode shapes
and moving grid capability. The mode shape information is not readily available for this configuration, therefore we simulate this boundary condition by a periodic velocity transpiration condition
4

OF

17

imposed at the diaphragm surface. The frequency of the transpiration velocity at the diaphragm
surface in the numerical simulation corresponds to the frequency of the oscillating diaphragm. We
obtained the peak velocity at the diaphragm surface from numerical iteration to match the experimentally measured peak velocity of the synthetic jet emanating from the slot exit. The pressure
at the moving diaphragm is also required for closure. However, in the absence of unsteady pressure data from the experiment, we imposed a zero pressure gradient at the diaphragm boundary.
We also tested the pressure gradient boundary condition obtained from a one-dimensional normal
momentum equation.26 This had very little impact on the solutions. Because of its simplicity and
robustness, we selected the zero pressure gradient boundary condition at the diaphragm surface.

Synthetic Jet Test Case: Background


The test configuration is a single diaphragm piezoelectric actuator operating in quiescent air.
The oscillatory motion of the diaphragm produces a synthetic jet that exhausts into the surrounding
air. This configuration, shown in Fig. 1, consists of a 1.27 mm wide rectangular slot connected
to a cavity with a piezoelectric diaphragm and corresponds to Case 1 of the CFDVAL2004 workshop on flow control devices.1 The cavity and diaphragm geometry of this actuator are highly
three-dimensional in the interior. However, the actual slot through which the fluid emerges is a
high aspect ratio rectangular slot and can be modeled as a two-dimensional configuration. Partial
view of the 2-D grid provided to the workshop participants, and used by the present authors, is
shown in Fig. 2(a) and 2(b). The computational results contributed by the workshop participants
are available in Ref. 1 and 27. A consensus developed during the workshop that simulating the
flow field inside the actuator cavity with an oscillating piezoelectric diaphragm from first principles
was beyond the capability of existing CFD codes. Most of the workshop participants, including
the present authors, modeled the internal cavity of the actuator as a two-dimensional configuration and simulated the diaphragm motion via a transpiration condition imposed at the diaphragm
surface. Some of the workshop participants further simplified the cavity modeling by imposing a
transpiration condition at the bottom part of the slots neck or even directly at the slot exit. After
examining these results, we concluded that as long as the unsteady velocity signal at the slot exit
replicates experimental conditions, details of the cavity modeling have an insignificant effect on
the development of the synthetic jet emanating from the slot. Another conclusion derived from
the CFDVAL2004 workshop was that no particular methodology or turbulence model emerged as
superior for simulating this test case.1, 27
We include here sample results obtained with the TLNS3D code to encapsulate the status of
CFD simulations at the conclusion of the CFDVAL2004 workshop. For these computations, we
used the 2-D grid of approximately 65,000 nodes from the CFDVAL2004 workshop website as
the baseline grid. As depicted in Fig. 2(a) and 2(b), this grid includes the internal cavity and the
5

OF

17

diaphragm geometry. A sinusoidal transpiration condition is imposed at the diaphragm surface,


which is represented by the left face of the cavity in Fig. 2(b). We present the time history of
the phase-averaged v-velocity at x = 0, y = 0.12 mm, and the time-averaged v-velocity along
the jet centerline in Fig. 3 and 4, respectively. We performed the computations for three grid
densities, two physical time steps and two turbulence models. The coarse grid (cg) was obtained
by eliminating every other point from the baseline grid, and a fine grid (fg) was obtained by adding
50% more points in the normal direction. We see from these figures that varying all these factors
did not produce any major changes in the computational results in the region near the slot exit.
However, further away from the slot exit, these results indicate that the coarse grid (cg) does not
provide adequate resolution for this problem. A finer grid (fg) and a reduction in time step (low dt)
had an insignificant effect on the computational results. However, significant differences are seen
in outer region between the SA and the SST computations. It is difficult to make any definitive
conclusion regarding the accuracy of the turbulence models based on these limited comparisons.
One of the major difficulties identified during the CFDVAL2004 workshop was the large disparity in experimental data obtained from different measurement techniques, as seen in Fig. 3
and 4. Such a variation in experimental data made it difficult to validate the numerical methods.
Part of the difficulty in acquiring a consistent set of experimental data arose from the fact that the
performance of the piezoelectric diaphragm depends on ambient conditions. Also, its performance
degrades over time, which means that, for a given input voltage, the actuator produces smaller jet
velocities as it ages. Because these experiments were conducted over several months, inconsistencies crept in the data.

Results: Synthetic Jet II


Yao et al.10 have recently revisited the synthetic jet test case and acquired experimental data for
this configuration with a new piezoelectric diaphragm. They obtained the detailed field data with
the PIV technique and pointwise data along the jet centerline with hotwire and LDV techniques.
They monitored the performance of the actuator regularly and demonstrated good consistency
among multiple measurement techniques.10
Based on the CFDVAL2004 workshop1 results, it can be concluded that replicating the flow
conditions at the slot exit is more important than the detailed modeling of cavity geometry for
accurate simulation of the growth of a synthetic jet for this configuration. Therefore, we simulated
the new experimental test case with a simplified cavity geometry, shown schematically in Fig. 5.
We imposed the transpiration condition at the bottom of the slots neck to simulate the velocity
generated by the oscillating diaphragm. A similar boundary condition treatment has also been
studied in detail by Yamaleev and Carpenter.28 They demonstrated that for actuators with deep
cavities, specifying the transpiration condition at a distance of at least 4-5 slot widths away from
6

OF

17

the slot exit produces only a small loss in numerical accuracy. A top-hat velocity profile, with a
dominant frequency of 450 Hz replicating the experimental conditions, was imposed at the bottom
boundary. The precise form of the velocity signal was obtained by curve fitting the measured
velocities at the slot exit (x = 0, y = 0.3 mm) with a fast Fourier transform (FFT) to reflect the proper
mode shape and to ensure zero net mass transfer. The amplitude of this velocity was determined
numerically to match the peak velocity from the experiment at the slot exit. The free stream Mach
number in the exterior quiescent region is specified as M = .001 to simulate incompressible flow
in the compressible flow code to avoid numerical difficulties at Mach zero.
The computational grid for this case was obtained from the baseline grid described in the
previous section by eliminating the portions of the grid below the neck of the slot. The resulting
grid consists of over 60,000 nodes and provides adequate resolution based on the grid refinement
study reported in Ref. 1 and as seen from the results in Fig. 3 and 4. Similarly, 72 time-steps/period
corresponding to a 5 phase angle between the time-steps provides sufficient temporal resolution.
The baseline results were obtained with the one-equation Spalart-Allmaras (SA) turbulence model.
In addition, the solutions on the baseline grid were also obtained with low-speed preconditioning
(prec) and Menters turbulence model (sst). Finally, the results on fine grid (fg) with the SA
model have been obtained. Based on the peak jet velocity and slot width, the Reynolds number
is approximately 3000, and therefore falls in the regime where the jet is expected to be turbulent.
Therefore, we assumed the flow to be fully turbulent in the present computations.
The time history of the vertical velocity for a complete period from the computational results
is compared with the experimental data in Fig. 6 at x = 0 and y = 0.3 mm. This is the closest point
to the slot exit where the PIV data is available. In addition to the PIV data, LDV measurements are
also available at this location and are shown in this figure. The LDV data was scaled down by a
factor of 0.9 as suggested by Yao et al.10 to match the diaphragm displacement for the two sets of
measurements. Unlike the earlier results shown in Fig. 3, the overall agreement between the computational and experimental results is quite good at this location. The four sets of computational
results shown in this figure are indistinguishable from one another, indicating a minimal effect of
preconditioning, grid density and turbulence model at the slot exit boundary.
In Fig. 7, we compare the time-averaged v-velocities along the jet centerline with the PIV
and LDV data. The experimental data from two different techniques (PIV and LDV) are in fair
agreement with each other. The overall agreement of the baseline TLNS3D results with the experimental data is also quite good. The low-speed preconditioning results included in this figure are
essentially identical to the baseline results. Because low-speed preconditioning20, 21, 24 primarily
reduces the artificial viscosity for unsteady flows, we may infer that the artificial viscosity is low
in these simulations, even without preconditioning. Similarly, the effect of grid refinement (fg)
is seen to be negligible on the computational results. However, the SST results differ from the
7

OF

17

baseline results in regions away from the slot exit (y > 8 mm).
Figures 8 and 9, respectively, show the time-averaged v-velocity profiles at y = 1 and 4 mm.
Except for a smaller velocity peak at y = 1 mm, the computational results are in very good agreement with the experimental data and with each other at these locations. Comparing the contour
plots of the time-averaged v-velocities obtained from measured PIV data and baseline TLNS3D
computations (Fig. 10(a) and 10(b), respectively) gives a global perspective of the velocity field.
Although the computational results are available over a much larger domain, these figures show
a domain covering a distance of only 8 mm from slot exit, corresponding to the region for which
the high resolution PIV data was available. The computational results accurately capture all of the
prominent features seen in the PIV data including the width and spreading rate of the synthetic jet.
The contour plots obtained with preconditioning and the SST model (not shown here) for the same
domain are nearly identical to the baseline computations.
We now examine the phase-averaged velocities at selected locations in space and time, starting
with v-velocities at y = 2 and 4 mm along the jet center line. Figures 11(a) and 11(b) show the
PIV and LDV data, along with TLNS3D solutions at these locations. The computational results
are in fairly good agreement with the two sets of experimental data, especially in the suction
phase. The agreement with the experimental data further away from the slot exit is slightly worse
during the peak expulsion cycle. In particular, the CFD results predict a delayed phase shift for the
peak expulsion, reflective of a smaller convective speed for outward movement of the synthetic jet
compared to the experimental data. Except for a slightly larger peak velocity for the SST model
during the expulsion phase, all four sets of computational results are practically indistinguishable
from one another.
We gain a broader perspective of the flow field by examining the contour plots of the velocities
at the phase angles representative of the expulsion (phase = 75 ) and suction (phase = 255 ) cycles.
Figures 12-19 show the velocity contours for streamwise (u-vel) and vertical velocities (v-vel) obtained from the PIV data and TLNS3D computational results (baseline). Although not shown here,
the results obtained with preconditioning, the SST model and finer grid show very little variation
from the baseline solutions over this domain. These figures were generated using identical contour
levels for both the experimental and CFD data to provide quantitative comparisons. The solid lines
represent positive values for the velocities while the dashed line represent negative values. This
sign convention is helpful in identifying the flow direction and the position of the vortex center. It
is clear from these figures that the computational results capture most of the pertinent features observed experimentally and are in very good agreement for the suction phase. During the expulsion
phase, the computed vortex center is located closer to the slot exit compared to the experimental
data, although the peak velocity at the vortex center is in good agreement with the PIV data. Yao
et al.10 have observed increasing three-dimensional effects for this case as one moves away from
8

OF

17

the slot exit, mainly because of ring vortices formed from the slot edges. We conjecture that these
ring vortices induce forces that accelerate the convection of the synthetic jet in the far field.

Concluding Remarks
Detailed comparisons have been presented for time-averaged and phase-averaged velocities
between experimental data and CFD results. The effect of truncation errors were found to be
small based on grid refinement, preconditioning, and physical time-step refinement studies. The
development of the synthetic jet in the quiescent medium is driven primarily by the velocity field
at the slot exit. Hence, approximating this forcing function is much more crucial than detailed
modeling of the cavity and parametric variations of the numerical algorithm. The computational
results in the reduced domain with a modified forcing function are found to be in much better
agreement with the new experimental data in the near field. However, the agreement with the
experimental data deteriorates in regions further away from the slot exit. Based on the available
experimental data, it appears that the flow becomes three-dimensional after 5-6 slot widths away
from the exit. Future work should focus on 3-D computations for this configuration to resolve such
issues.

Acknowledgment
The authors would like to acknowledge Dr. C. Yao of NASA Langley Research Center for
sharing his experimental data for the synthetic jet and for constructive discussions on the experimental procedures used for acquiring the data. The authors would also like to acknowledge Dr.
Avi Seifert of Tel Aviv University for helpful suggestions regarding boundary condition treatment
for synthetic jets, and Dr. C.L. Rumsey of NASA Langley Research Center for helpful discussions
on various aspects of this problem.

References
1

CFD Validation of Synthetic Jets and Turbulent Separation Control: Langley Research Center
Workshop, Willimasburg, VA, March 29-31, 2004. (http://cfdval2004.larc.nasa.gov)
2

Thomas R.H.; Choudhari, M.M.; and Joslin, R.D.: Flow and Noise Control: Review and
Assessment of Future Directions. NASA TM 2002-211631, April 2002.
3

Hassan, A.A. and Mults, A.A.: Transverse and Near-Tangent Synthetic Jets for Aerodynamic Flow Control. AIAA paper 2000-4334, Aug. 2000.
4

Mittal, R., Rampunggoon, P.; and Udaykumar, H.S.: Interaction of a Synthetic Jet with a
Flat Plate Boundary Layer. AIAA paper 2001-2772, June 2001.
5

Lin, H. and Chieng, C.C.: Computations of Compressible Synthetic Jet Flows Using Multigrid/Dual Time Stepping Algorithm. AIAA Paper 99-3114, June-July 1999.
9

OF

17

Donovan, J.F.; Kral, L.D.; and Cary, A.W.: Active Flow Control Applied to an Airfoil.
AIAA Paper 98-0210, Jan. 1998.
7

Kral, L.D.; Donoval, J.F.; Cain, A.B.; and Cary, A.W.: Numerical Simulation of Synthetic
Jet Actuators. AIAA Paper 97-1824, June-July 1997.
8

Joslin, R.D.; Horta, L.G.; and Chen, F.J.: Transitioning Active Flow Control to Applications. AIAA Paper 99-3575, June-July 1999.
9

Viken, S.A.; Vatsa, V.N.; Rumsey, C.L.; and Carpenter, M.H.: Flow Control Analysis on the
Hump Model with RANS Tools. AIAA Paper 2003-218, Jan. 2003.
10

Yao, C.; Chen, F.J.; Neuhart, D.; and Harris, J.: Synthetic Jet Flow Field Database for CFD
Validation. AIAA Paper 2004-2218, June 2004.
11

Vatsa, V.N. and Wedan, B.W.: Development of a multigrid code for 3-d Navier-Stokes
equations and its application to a grid-refinement study. Computers and Fluids, Vol. 18, 1990,
pp.391-403.
12

Vatsa, V.N.; Sanetrik, M.D.; and Parlette, E.B.: Development of a Flexible and Efficient
Multigrid-Based Multiblock Flow Solver. AIAA paper 93-0677, Jan. 1993.
13

Jameson, A.; Schmidt, W.; and Turkel, E.: Numerical Solutions of the Euler Equations by
Finite Volume Methods Using Runge-Kutta Time-Stepping Schemes. AIAA Paper 1981-1259,
June 1981.
14

Turkel, E. and Vatsa, V.N.: Effect of artificial viscosity on three-dimensional flow solutions. AIAA Journal, vol. 32, no. 1, Jan. 1994, pp. 39-45.
15

Swanson, R.C. and Turkel, E.: On Central Difference and Upwind Schemes. Journal of
Computational Physics, vol. 101, 1992, pp. 292-306.
16

Baldwin,B.S. and Lomax,H.: Thin layer approximation and algebraic model for separated
turbulent flows. AlAA Paper 78-257, Jan. 1978.
17

Spalart, P.A. and Allmaras, S.R.:A one-equation turbulence model for aerodynamic flows.
AIAA Paper 92-439, Reno, NV, Jan. 1992.
18

Menter, F.R.: Zonal Two Equation k- Turbulence Models for Aerodynamic Flows. AIAA
paper 93-2906, Orlando, Fl, 1993.
19

Melson,N.D.; Sanetrik, M.D.; and Atkins, H.L.:Time-accurate Navier-Stokes calculations


with multigrid acceleration. Appeared in Proceedings of the Sixth Copper Mountain conference
on multigrid methods, 1993, edited by: Melson, N.D.; Manteuffel, T.A.; and S.F. McCormick,
S.F.
20

Turkel, E.: Preconditioned Methods for Solving the Incompressible and Low Speed Compressible Equations. Journal of Computational Physics, Vol. 72, 1987, pp. 277-298.

10 OF 17

21

Turkel, E.: Preconditioning Techniques in Computational Fluid Dynamics. Annual Reviews in Fluid Mechanics 1999, Vol. 31, 1999, pp. 385-416.
22

Jameson, A.: Time Dependent Calculations Using Multigrid, with Applications to Unsteady
Flows past Airfoils and Wings. AIAA Paper 91-1596, 1991.
23

Bijl, H.; Carpenter, M.H.; and Vatsa, V.N.: Time Integration Schemes for the Unsteady
Navier-Stokes Equations. AIAA Paper 2001-2612.
24

Vatsa, V.N. and Turkel, E.: Assessment of Local Preconditioners for steady state and time
dependent flows. AIAA paper 2004-2134, June 2004.
25

Turkel, E. and Vatsa, V.N.: Local Preconditioners for Steady State and Dual TimeStepping. submitted to ESAIM: Mathematical Modelling and Numerical Analysis.
26

Rizzetta, D.P.; Visbal. M.R.; and Stanek, M.J.: Numerical Investigation of Synthetic Jet
Flowfields. AIAA Paper 98-2910, June 1998.
27

Rumsey, C.L.; Gatski, T.B.; Sellers III, W.L.; Vatsa, V.N.; and Viken, S.A.: Summary of
the 2004 CFD Validation Workshop on Synthetic Jets and Turbulent Separation Control. AIAA
Paper 2004-2217, June 2004.
28

Yamaleev, N.K. and Carpenter, M.H.: A Reduced Order Model for Efficient Simulation of
Synthetic Jet Actuators. NASA TM-2003-212664, Dec. 2003.

11 OF 17

Figure 1 Schematic of Piezoelectric Actuator


12
0

11
10

-10

-20

Y (mm)

Y (mm)

-30

5
4

-40

3
2

-50

1
0
-4

-3

-2

-1

X(mm)

(a) Global view

-60
-20

-15

-10

-5

X(mm)

10

15

20

(b) Detailed view

Figure 2 Computational grid for Piezoelectric Actuator

12 OF 17

Exp. data, PIV


Exp. data, Hotwire
NASA-tlns3d-sa
NASA-tlns3d-sa (cg)
NASA-tlns3d-sa (fg)
NASA-tlns3d-sa (low dt)
NASA-tlns3d-sst

40

20

10

v, m/s

v, m/s

6
0

Exp. data, PIV


Exp. data, Hotwire
NASA-tlns3d-sa
NASA-tlns3d-sa (cg)
NASA-tlns3d-sa (fg)
NASA-tlns3d-sa (low dt)
NASA-tlns3d-sst

-20
2

-40

90

180

phase, deg

270

360

10

y, mm

15

20

Figure 3 Time-history of v-velocity at x = 0,

Figure 4 Time-averaged v-velocity along jet

y = 0.12 mm

centerline

40

20

-20

-40

-60
-40

-20

20

40

Figure 5 Simplified model of actuator

13 OF 17

10
PIV data
LDV data
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

30

Vvel (m/sec)

20

8
centerline velocity (m/sec)

40

10
0
10

Exp. data, PIV


Exp. Data, LDV
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

20
30

90

180
Phase angle (deg)

270

360

12

16

20

y (mm)

Figure 6 Time-history of v-vel near slot exit

Figure 7 Time-averaged v-vel along centerline,

(x = 0, y = 0.3 mm), Synjet II

Synjet II

12

14
PIV data
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

10

10

Vvel (m/sec)

Vvel (m/sec)

4
2

8
6
4

0
x (mm)

PIV data
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

12

0
x (mm)

Figure 8 Time-averaged v-vel at y = 1 mm, Syn-

Figure 9 Time-averaged v-vel at y = 4 mm, Syn-

jet II

jet II

14 OF 17

8
6

2
8

7
0

4
8

4
2

8
6

2
0

y (mm)

-2

0
-3.00

x (mm)

(a) PIV measurements

-2.00

-2

-1.00

0.00

1.00

2.00

3.00

(b) TLNS3D computations

Figure 10 Time-averaged v-velocity contours for Synjet II

50

50
PIV data
LDV data
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

40

40
30
Vvel (m/sec)

Vvel (m/sec)

30
20
10

20
10

10

10

20

90

180
Phase angle (deg)

(a) x = 0, y = 2 mm

270

360

PIV data
LDV data
TLNS3Dsa (baseline)
TLNS3Dsa (prec)
TLNS3Dsa (fg)
TLNS3Dsst

20

90

180
Phase angle (deg)

270

360

(b) x = 0, y = 4 mm

Figure 11 Phase-averaged v-velocity comparisons for Synjet II


15 OF 17

-1

x, mm

Figure 12 Contour plots of u-vel, PIV data at


phase =

75

0.00

1.00

8
4

x, mm

75

24

0
0
-3.00 -2.00 -1.00

32

4
0

48

-8
-4

-4
0

28
1620

36

2024

-1

-4

40
36
32

16
2
0

40

-2

-4

24

-4

-8

32

12

28
20

20

36

40 32
28

0 4

12
4

4
12
2016
24

-4

-8

24 16 20
12

Figure 14 Contour plots of v-vel, PIV data at


phase =

-4

32
28

-8

16

12

16

-8

-4

-4

24

y, mm

16 2 0
28

6
12

0
-3

3.00

2.00

sults at phase = 75

-4 -2 -6

Figure 13 Contour plots of u-vel, TLNS3D re-

6
0
4
0 2
-3.00 -2.00 -1.00

-1 0 0
-1
-8

-2

10

4
-4

12
10
8

12
4
0 -2 2
--6 -4
8
-12

-6

10

12

-2
6

-2

2 2

-8

14

46

2
4

0
-4

-1 0

y, mm

-1

-4
6

-14 -108
-10
-6 - 4
-4
4 22
68

1
0
-3

0-2
-6

-6-6

8
10

-12

-4

-1 0
-6

-8

2
-1
-8

8
64
2

-4 -2
0

-6

10

10

-4

-8

8
10

-4-6
-2

14

-12

-14

-6

-6
-8 -8
-1 2

-2

-4

-2

-2

0.00

1.00

2.00

3.00

Figure 15 Contour plots of v-vel, TLNS3D results at phase = 75

16 OF 17

-2

4
2

4
-2

3
-2

4
0

y, mm

2
-2

-6

x, mm

Figure 16 Contour plots of u-vel, PIV data at

1142
16
2
0 2 226

4
0 2
-3.00 -2.00 -1.00

0.00

-2 0 -4

1.00

3.00

sults at phase = 255

8
7

7
0

0
0

4
3

3
2

-8

-4

-4

-4

-8

-4

y, mm

2.00

Figure 17 Contour plots of u-vel, TLNS3D re-

-6

-6 -8

phase =

255

-4

-4

12

-1

0
2

-2

-4

0
-3

0
2
4

-4

-4 -2

-2

-1

x, mm

Figure 18 Contour plots of v-vel, PIV data at


phase =

--112
6

-4

0
-3

255

0 4
0
-3.00 -2.00 -1.00

0.00

1.00

2.00

3.00

Figure 19 Contour plots of v-vel, TLNS3D results at phase = 255

17 OF 17

You might also like