Вы находитесь на странице: 1из 13

Comput. Methods Appl. Mech. Engrg.

200 (2011) 1008–1020

Contents lists available at ScienceDirect

Comput. Methods Appl. Mech. Engrg.


journal homepage: www.elsevier.com/locate/cma

Improved Incompressible Smoothed Particle Hydrodynamics method


for simulating flow around bluff bodies
Mostafa Safdari Shadloo, Amir Zainali, Samir H. Sadek, Mehmet Yildiz ⇑
Faculty of Engineering and Natural Sciences, Advanced Composites and Polymer Processing Laboratory, Sabanci University, 34956 Tuzla, Istanbul, Turkey

a r t i c l e i n f o a b s t r a c t

Article history: In this article, we present numerical solutions for flow over an airfoil and a square obstacle using Incom-
Received 19 March 2010 pressible Smoothed Particle Hydrodynamics (ISPH) method with an improved solid boundary treatment
Received in revised form 14 September 2010 approach, referred to as the Multiple Boundary Tangents (MBT) method. It was shown that the MBT
Accepted 1 December 2010
boundary treatment technique is very effective for tackling boundaries of complex shapes. Also, we have
Available online 7 December 2010
proposed the usage of the repulsive component of the Lennard-Jones Potential (LJP) in the advection
equation to repair particle fractures occurring in the SPH method due to the tendency of SPH particles
Keywords:
to follow the stream line trajectory. This approach is named as the artificial particle displacement method.
Meshless methods
Incompressible Smoothed Particle
Numerical results suggest that the improved ISPH method which is consisting of the MBT method, arti-
Hydrodynamics (ISPH) ficial particle displacement and the corrective SPH discretization scheme enables one to obtain very sta-
Airfoil problem ble and robust SPH simulations. The square obstacle and NACA airfoil geometry with the angle of attacks
Square obstacle problem between 0° and 15° were simulated in a laminar flow field with relatively high Reynolds numbers. We
Bluff body illustrated that the improved ISPH method is able to capture the complex physics of bluff-body flows nat-
Solid boundary treatment urally such as the flow separation, wake formation at the trailing edge, and the vortex shedding. The SPH
results are validated with a mesh-dependent Finite Element Method (FEM) and excellent agreements
among the results were observed.
Ó 2010 Elsevier B.V. All rights reserved.

1. Introduction Due to being a relatively new computational method for engi-


neering applications (roughly two decades old), there are still a
Smoothed Particle Hydrodynamics (SPH) is one of the members few significant issues with SPH that need to be scrutinized. It is still
of meshless Lagrangian particle methods used to solve partial a challenge to model physical boundaries correctly and effectively.
differential equations widely encountered in scientific and engi- In addition, there are various ways to construct SPH equations (dis-
neering problems [1–4]. Unlike Eulerian (mesh-dependent) com- cretization), and a consistent approach has not gained consensus.
putational techniques such as finite difference, finite volume and Highly irregular particle distributions which occur as the solution
Finite Element Methods, the SPH method does not require a grid, progresses may cause numerical algorithms to break down, there-
as field derivatives are approximated analytically using a kernel by making robustness another significant issue to be addressed.
function. In this technique, the continuum or the global computa- Namely, it is well-known by SPH developers that when passing
tional domain is represented by a set of discrete particles. Here, it from one test case to another, new problems are faced. For exam-
should be noted that the term particle refers to a macroscopic part ple, instabilities due to clamping of SPH particles which is not in
(geometrical position) in the continuum. Each particle carries general present in modeling a dam-breaking problem show them-
mass, momentum, energy and other relevant hydrodynamic prop- selves in the simulation of flow over bluff bodies, especially at the
erties. These sets of particles are able to describe the physical leading and trailing edges. These shortcomings are not insur-
behavior of the continuum, and also have the ability to move under mountable. The underlying factors causing these shortcomings
the influence of the internal/external forces applied due to the can be understood through extensive research on the verification
Lagrangian nature of SPH. Although originally proposed to handle of SPH against a wide variety of possible applications as being done
cosmological simulations [5,6], the SPH method has become in the SPH literature.
increasingly generalized to handle many types of fluid and solid In most engineering problems, the domain of interest has, in
mechanics problems [7–11]. general, solid boundaries. The SPH formulations being valid for
all interior particles are not necessarily accurate for particles close
⇑ Corresponding author. to the domain boundary since the kernel function is truncated by
E-mail address: meyildiz@sabanciuniv.edu (M. Yildiz). the boundary. Therefore, the application of boundary conditions is

0045-7825/$ - see front matter Ó 2010 Elsevier B.V. All rights reserved.
doi:10.1016/j.cma.2010.12.002
M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1009

problematic in the SPH technique. Consequently, the proper and The SPH approach assumes that the fields of the particle of
correct boundary treatments have been an ongoing concern for interest are affected by that of all other particles within the global
an accurate and successful implementation of the SPH approach domain. The interactions among the particles within the global do-
[12,13] as well as other meshless methods [14,15] in the solution main are achieved through a compactly supported, normalized and
of engineering problems with solid walls. Improper boundary even weighting function (smoothing kernel function) W(rij, h) with
treatment has two important consequences. The first originates a smoothing radius jh (cut off distance, localized domain) beyond
from the penetration of fluid particles into boundary walls, which which the function is zero. Hence, in computations, a given particle
then leave the computational domain. The second is that kernel interacts with only its nearest neighbors contained in this localized
truncation at the boundary produces errors in the solution. Hence, domain. Here, the length h defines the support domain of the par-
over the years, several different approaches have been used for ticle of interest, j is a coefficient associated with the particular ker-
the boundary treatment such as specular reflections, or bounce- nel function, and rij is the magnitude of the distance between the
back of fluid particles with the boundary walls [16], Lennard- particle of interest i and its neighboring particles j. If the Dirac del-
Jones Potential (LJP) type force as a repulsive force [17,18], ghost ta function in Eq. (1) is replaced by the kernel function W(rij, h), the
particles [19–21], and Multiple Boundary Tangent (MBT) method integral estimate or the kernel approximation to an arbitrary func-
[22]. tion f ð~
ri Þ can be introduced as
Additionally, the homogeneity of the particle distribution is Z
3
quite important for the accuracy and the robustness of SPH models. f ð~
ri Þ ffi hf ð~
ri Þi  f ð~
rj ÞWðrij ; hÞd ~rj ; ð2Þ
X
The formation of ill particle distributions during the simulation
may result in the numerical solution to fail. For instance, if the where the angle bracket h i denotes the kernel approximation, and ~ ri
pressure field is solved correctly thereby imposing the incompress- is the position vector defining the center point of the kernel
ibility condition as accurately as possible, the particle motion clo- function.
sely follows the trajectory of streamline, hence resulting in a linear Approximation to the Dirac-delta function by a smoothing ker-
clustering and in turn fracture in particle distribution. In these re- nel function is the origin of the Smoothed Particle Hydrodynamics.
gions due to the lack of sufficient number of particles, or inhomo- The Dirac-delta function can be replaced by a smoothing kernel
geneous particle distribution, the gradients of field variables can function provided that the smoothing kernel satisfies the following
not be computed reliably. Such a situation leads to spurious fields, several conditions; namely, (i) normalization condition: the area un-
especially erroneous pressure values in the ISPH approach. As the der the smoothing function must be unity over its support domain,
R 3
computation progresses, errors in computed field variables accu- ~
X Wðr ij ; hÞd rj ¼ 1, (ii) the Dirac-delta function property: as the
mulate whereby blowing-up the simulation. smoothing length approaches to zero, the Dirac-delta function
This paper suggests an improved ISPH algorithm that includes should be recovered, limh?0 W(rij, h) = d3(rij), (iii) compactness prop-
the implementation of (i) the multiple boundary tangent method erty: which necessitates that the kernel function be zero beyond its
to treat geometrically complex solid boundaries in a flow field, compact support domain, W(rij, h) = 0 when rij > jh, and (iv) the
(ii) the artificial particle displacement (particle fracture repair) kernel function should be spherically symmetric even function,
procedure for eliminating particle clustering induced instabilities, W(rij, h) = W(rij, h), and be positive within the support domain
and (iii) the corrective SPH discretization scheme to improve the W(rij, h) > 0 when rij < jh. Finally, the value of the smoothing func-
accuracy of the computation. tion should decay with increasing distance away from the center
particle.
2. Smoothed Particle Hydrodynamics The smoothing function can be represented in a general form as
W(rij, h) = (1/hd)f(rij/h) where d is the dimension of the problem,
For clarity of the presentation, it is worthy of introducing nota- and f is a function. In literature, it is possible to find a wide variety
tional conventions to be used throughout this article. All vector and of kernel functions which satisfy above-listed conditions, such as
tensorial quantities are written either using suffix notation with Gaussian, cubic or quintic kernel functions [18,23]. The smoothing
Latin indices denoting the components or direct notation with kernels can be considered as discretization schemes in mesh
boldface letters. These components will be written either as sub- dependent techniques such as finite difference and volume. The
scripts (when particle identifiers are not used) or superscripts stability, the accuracy and the speed of an SPH simulation heavily
(when particle identifiers are used). As well, throughout this article depend on the choice of the smoothing kernel function as well as
the Einstein summation convention is employed, where any the smoothing length. Considering the stability and the accuracy
repeated component index is summed over the range of the index. of the simulations, throughout the present work, the compactly
These superscripts do not represent any covariant or contravariant supported two-dimensional quintic spline kernel is used at the ex-
nature. Latin boldface indices (i, j) will be used as particle identifi- pense of higher computational cost. For example, the utilization of
ers to denote particles and will always be placed as subscripts that the higher order quintic spline in simulations is at least two times
are not summed, unless indicated with a summation symbol. For computationally more expensive than that of the cubic spline
example, the position vector for particle i is ~ ri ¼ xki ~
ek where xki 8
>
> ð3  sij Þ5  6ð2  sij Þ5 þ 15ð1  sij Þ5 if 0 6 sij < 1;
denotes the components of the position vector and ~ ek is a base >
>
7 < 5
ð3  sij Þ  6ð2  sij Þ
5
if 1 6 sij < 2;
vector. The distance vector  between a pair of particles is indicated Wðrij ; hÞ ¼ 2> 5
by ~ rij ¼ ~ rj ¼ xki  xkj ~
ri  ~ ek ¼ r kij~
ek , and the magnitude of the 478ph >> ð3  s ij Þ if 2 6 sij 6 3;
>
:
distance vector k~ rij k is denoted by rij. 0 if sij P 3;
The three-dimensional Dirac-delta function d3(rij), also referred ð3Þ
to as a unit pulse function, is the starting point for the SPH tech-
nique. This function satisfies the identity here sij = rij/h. The spatial resolution of SPH is affected by the
smoothing length. Hence, depending on the problem solved, each
Z
3 particle can be assigned to a different value of smoothing length.
f ð~
ri Þ ¼ rj Þd3 ðr ij Þd ~
f ð~ rj ; ð1Þ
X However, for a variable smoothing length, it is probable to violate
Newton’s third law. For example, it might be possible for a particle
3
where d ~
rj is a differential volume element and X represents the to- j to exert a force on particle i, and not to experience an equal and
tal bounded volume of the domain. opposite reaction force from particle i. To ensure that Newton’s
1010 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

third law is not violated and the pair wise interaction among parti- @ 2 f m ð~
ri Þ XN
mj p p ~
r pij @Wðr ij ; hÞ
cles moving close to each other is achieved, the smoothing length is ¼ 8 ðf ð~r i Þ  f ð r j ÞÞ ; ð9Þ
@xki @xki j¼1
qj r 2ij @xm
i
substituted by its average, defined as hij = 0.5(hi + hj). The averaged
smoothing length ensures that particle i is within the influence do- @ 2 f p ð~
ri Þ XN
mj p r sij @Wðr ij ; hÞ
¼2 ri Þ  f p ð~
ðf ð~ rj ÞÞ 2 : ð10Þ
main of particle j and vice versa. k
@xi @xi k
j¼1
q j r ij @xsi

2.1. Spatial derivatives and particle approximation in SPH Unlike Eq. (8), Eq. (7) can only be used for divergence free vector-
valued functions as shown in Appendix A.
The SPH approximation for the gradient of an arbitrary function Throughout this work, all modeling result are obtained with the
(i.e., scalar, vectorial, or tensorial) can be simply written through usage of corrective SPH discretization schemes since corrective
the substitution f ð~ rj Þ=@xkj in Eq. (2) to produce
rj Þ ! @f ð~ SPH formulations produce more accurate and stable results than
the standard SPH equations. We have also observed that Eq. (7)
* + Z
@f ð~
ri Þ @f ð~
ri Þ @f ð~
rj Þ performs better for the discretization of the Laplacian of velocity
3
ffi  Wðr ij ; hÞd ~rj : ð4Þ fields than Eq. (8). Therefore, in all presented results, Eq. (7) is used
@xki @xki X @xj
k
for the Laplacian of velocity, while Eq. (8) is used for the Laplacian
of pressure in the Poisson pressure equation.
Upon integrating Eq. (4) by parts and using the compactness prop-
erty of the kernel function as well as noting that @Wðr ij ; hÞ=@xki ¼
2.2. Instabilities and their possible remedies in the SPH method
@Wðrij ; hÞ=@xkj for a constant smoothing length h, it can be shown
that
To prevent the particle clustering, the trajectory of particles can
* + Z
be disturbed by adding relatively small artificial displacement drki
@f ð~
ri Þ @f ð~
ri Þ @Wðr ij ; hÞ 3
ffi  f ð~
rj Þ d~ rj : ð5Þ to the advection of particles computed by the solution of the
@xki @xki X @xki
equation of motion. Recall the form of the Lennard-Jones Potential
(LJP)-type force used in the SPH literature as a repulsive force for
Using a Taylor series expansion and the properties of a second-rank
the solid boundary treatment,
isotropic tensor, as derived in Appendix A, a more accurate SPH
approximation for the gradient of an arbitrary function can be intro- X
N
  br kij v 2max
duced as F ki;LJP ¼ ðro =r ij Þn1  ðro =r ij Þn2 ; ð11Þ
j¼1
r 2ij

ri Þ ks X
@f p ð~ N
mj p @Wðr ij ; hÞ where F ki;LJP is the force per unit mass on fluid particle i due to the
aij ¼ rj Þ  f p ð~
ðf ð~ ri ÞÞ ; ð6Þ
@xi k
j¼1
q j @xsi neighbor particles j, n1 and n2 are constants, b is a problem-
dependent parameter, ro is the cutoff distance, and vmax is the
PN
where aks ij ¼
k s
j¼1 ðmj =qj Þr ji ð@Wðr ij ; hÞ=@xi Þ is a corrective second-
largest particle velocity in the system. In this work, vmax is set to
rank tensor. This form is referred to as the corrective SPH gradient be equal to the absolute value of the maximum vx velocity. If the
formulation that can be used to eliminate particle inconsistencies. It second term (attractive interaction) on the right-hand side of LJP
should be noted that the corrective term aks ij is ideally equal to
force is neglected, and n1 = 2, and the force F ki;LJP , and vmax are
Kronecker delta dks for a continuous function. On using Kronecker replaced by dr ki =ðDtÞ2 and rij/Dt, one can write the relationship
delta in Eq. (6), one can obtain the SPH gradient formulation of a X
N rk
ij
vector-valued function commonly seen in the SPH literature. It dr ki ¼ b r 2o v max Dt; ð12Þ
should be noted that the corrective SPH formulation requires the j¼1
r 3ij
inversion of aks
ij , which might be singular for irregular and ill particle
where drki is an artificial particle displacement vector.
distribution. We have not experienced any difficulties related to aks P
ij
Here, the cut-off distance can be approximated as r o ¼ Nj¼1 rij =N.
corrective tensor being singular for a wide variety of benchmark k 3
Given that rij =rij is an odd function with vanishing integral, one can
problems solved (i.e., lid driven cavity, flow over backward facing P
write Nj¼1 rkij =r 3ij ¼ 0 for a spherically symmetric particle distribu-
step, Taylor vortices, and bubble deformation). However, if such a
tion. However, if the particle distribution is asymmetric, and clus-
singularity problem exists for a given particle which can easily be P
tered, the term Nj¼1 r kij =r 3ij – 0 is no longer equal to zero, whereby
determined through monitoring whether the determinant of the
implying the region with clustered particle distribution. The artifi-
aks
ij is zero or not, the corrective SPH formulation on that particle
ks cial particle displacement is only influential in the clustered region
should not be imposed through setting aks ij ¼ d , thereby leading
and negligibly small in the rest of the computational domain due to
to the utilization of the standard SPH discretization scheme. PN k 3
Additionally, there are two main forms of the SPH approxima- j¼1 r ij =r ij ffi 0 provided that the particle distribution is closely uni-
form. The offset vector d^rkii between the particle i and the center of
tion for the Laplacian of a vector-valued function [19,24]. For the
mass of its influence domain can be presented as
sake of completeness, we have in Appendix A shown that these
two forms can be derived from the SPH representation of the sec- X
N

ond order spatial derivative of a vector field @ 2 f p ð~ ri Þ=@xki @xli as d^r kii ¼ xki  ^xki ¼ rkij =N; ð13Þ
j¼1
@ 2 f p ð~
ri Þ pm XN
mj p p ~
r pij @Wðr ij ; hÞ
a ¼ 8 ðf ð~
r i Þ  f ð r j ÞÞ ; ð7Þ where xki and ^
xki are the coordinates of the particle i and the center
@xki @xki ij j¼1
qj r 2ij @xm
i of mass for the influence domain of the particle i.
ri Þ 
@ 2 f p ð~  XN
mj p rsij @Wðrij ; hÞ The comparison of the artificial particle displacement and offset
2 þ allij ¼ 8 ri Þ  f p ð~
ðf ð~ rj ÞÞ 2 : ð8Þ vectors implies that upon using the particle displacement vector in
k
@xi @xi k
j¼1
qj rij @xsi
the advection equation, the particle i moves towards the diluted
Likewise, upon replacing the corrective second rank tensor in Eq. (7) particle region (the region which is away from the center of mass).
and its trace in Eq. (8) by Kronecker delta and its trace, respectively, Hence, the fractures in the simulation domain are repaired. Since
one can obtain the SPH Laplacian formulations of a vector-valued the near boundary fluid particles have influence domains truncated
function suggested by Clearly and Monaghan [24], and Morris by boundaries, with the usage of the artificial particle displace-
et al. [19], correspondingly ment vector in the computation, these fluid particles will tend to
M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1011

move towards the boundary and stick to it. Even though this situ- v  ~
ðq=DtÞ~ n ¼ rp  ~
n; ð18Þ
ation may appear as a problem and the deficiency of the approach,
where ~ n is the unit normal vector. Having solved the pressure Pois-
it might be used in advantageous way such that fluid particles
son equation to obtain the pressure field and then computed the
close to boundaries are then artificially forced to move in confor-
pressure gradient, we can use the Hodge decomposition equation
mation with boundaries. Hence pressure forces on the boundaries
can be computed much more accurately in that particle deficiency
to determine the correct, incompressible velocity field ~ v . Often,
is no longer problem therein. In our simulations, since the ghost
the boundary conditions for ~ v ðnþ1Þ are used for ~ v . This reduces Neu-
mann boundary condition to rp  ~ n ¼ 0 for no slip boundary condi-
particles are used for near boundary fluid particles, the influence
tion. Note that in order for differentiating between spatial and
domain of the kernel function is fully populated, and therefore
temporal indices, the time index n is put within brackets.
such a problem is not an issue. The artificial particle displacement
One of the main advantages of using ISPH is the elimination of
vector is added to the particle advection equation in both predic-
the speed of sound parameter in the time-step conditions. Much
tion and correction steps. This approach repairs all the clustering
larger time steps can be used in this approach, at the computa-
and fracture in the domain gradually without inducing significant
tional expense of having to solve the pressure Poisson equation
errors in the computation, and enabling a quite robust SPH ap-
at each time step. The algorithm stability is controlled by the Cou-
proach. It is due to this approach that it becomes possible to run
rant–Friedrichs–Lewy (CFL) condition, where the recommended
simulations with higher Reynolds numbers, which are otherwise
time-step is Dt 6 CCFLhij,min/vmax where hij = 0.5(hi + hj), hij,min is
impossible to achieve.
the minimum smoothing length among all i–j particle pairs, and
CCFL is a constant satisfying 0 < CCFL 6 1 (in this work, CCFL = 0.125).
2.3. SPH solution algorithms
For time marching of the ISPH approach, we have used a first-
order Euler time step scheme. This technique is an explicit time
The governing equations used to solve the fluid problems in this
integration scheme, and is relatively simple to implement. Particle
article are the mass and linear momentum balance equations
positions, and velocities are computed respectively as D~ ri =Dt ¼
which are expressed in the Lagrangian form and given in direct
vi ; D~
~ vi =Dt ¼ ~f i . The general form of the ISPH algorithm is as fol-
notation as
low. The predictor step starts with determining an estimate ~ ri for
ðnÞ
v;
Dq=Dt ¼ qr  ~ ð14Þ all particle locations, given the previous particle positions ~ ri and
the previous correct velocity field ~ v ðnÞ as ~ ri ¼ ~
ðnÞ
ri þ ~ v ðnÞ Dt where
v =Dt ¼ r  r þ q~f B :
qD~ ð15Þ i
ri is the intermediate particle position. The intermediate velocity
~
i

In the present simulations, the fluid is assumed to be incompress- field ~ v i is computed on the temporary particle locations through
ible and Newtonian. Hence, the incompressibility condition requires the solution of the momentum balance equations with forward
that the divergence of the fluid velocity r  ~v ¼ 0 be zero. Here, q is time integration by omitting the pressure gradient term as
vi ¼ ~v ðnÞ ~ðnÞ
i þ f i Dt. The pressure Poisson equation is solved to obtain
v is the divergence-free fluid velocity, r is the total
the fluid density, ~ ~
ðnþ1Þ
stress tensor, and ~
f B is the body force term, respectively. The total the pressure pi which is required to enforce the incompressibil-
stress is defined as r = pI + T, where p is the absolute pressure, I ity condition. The pressure Poisson equation is solved using a
is the identity tensor, T ¼ lðr~ vÞT Þ is the viscous part of the
v þ ðr~ biconjugate gradient stabilized method or a direct solver based
total stress tensor, where l is the viscosity. Finally, D/Dt is the on the Gauss elimination method. The Hodge decomposition prin-
material time derivative operator defined as D/Dt = @/@t + vl@/@xl. ciple is employed to solve for the actual velocity field ~ v ðnþ1Þ
i by
ðnþ1Þ
There are two common approaches utilized in the SPH literature using the computed pressure pi . Finally, with the correct veloc-
for solving the balance of the linear momentum equation. The first ity field for time-step n + 1, all fluid particles are advected to their
ðnþ1Þ
one is widely referred to as the Weakly Compressible SPH (WCSPH) new positions ~ ri using an averageof the previous  and current
ðnþ1Þ ðnÞ
where the pressure term in the momentum equation is determined particle velocities as ~ ri ¼~ri þ 0:5 ~ v ðnÞ
i þ vi
~ðnþ1Þ Dt.
through an artificial equation of state. In the second approach
known as the Incompressible SPH (ISPH), the pressure is computed 2.4. Mesh generation and MBT boundary treatment for airfoil
by means of solving a pressure Poisson equation. geometry
The ISPH approach is based on the projection method [25–27],
which uses the principle of Hodge decomposition. Upon using the This section presents the geometry and mesh generation, ghost
Hodge decomposition, any vector field can be broken into a diver- particle creations and the implementation of the MBT boundary
gence-free part plus the gradient of an appropriate scalar potential. treatment for the airfoil geometry. Initially, a Cartesian mesh is
The Hodge decomposition can be written for a velocity field as created over a rectangular domain with the length and height of
L and H, respectively. Then, an airfoil geometry is created using
v ¼ ~
~ v þ ðDt=qÞrp; ð16Þ
Eqs. (20) and (21). Since the leading edge of the airfoil has a curve
where v is the intermediate velocity, and ~
~ v is the divergence-free with a steeper slope, the chord is split into two parts to be able to
part of the velocity field. The projection method begins by ignoring locate more boundary particles towards the leading edge. Discrete
the pressure gradient in the momentum balance equation. The points on the chord are created with the formula
solution of Eq. (15) without the pressure gradient produces the
intermediate velocity ~ v , which does not, in general, satisfy mass xc ¼ ½ði  1Þ=ðilen  1Þn  idis ð19Þ
conservation. However, this incorrect velocity field can be projected
onto a divergence-free space after solving a pressure Poisson equa- where xc is coordinates along the chord of the airfoil, i is a nodal in-
tion, from which the divergence-free part of the velocity field ~ v can dex, ilen is the number of nodes along the chord, idis is the length of
be extracted. The pressure Poisson equation is obtained by taking the chord, and n is the geometrical progression coefficient which
the divergence of Eq. (16) as controls the distance between points on the chord. Given the chord
length of 1, 6 inequidistant nodal points created through the geo-
v =Dt ¼ r  ðrp=qÞ:
r~ ð17Þ
metrical progression coefficient of 2 are located along the 5% of
Eq. (17) is subjected to Neumann boundary conditions that can be the chord length starting from the leading edge. The remaining sec-
obtained by using the divergence theorem on the pressure Poisson tion of the chord has 50 equidistant nodal points. The mean camber
equation as line coordinates are computed using Eq. (20)
1012 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

  
yc ¼ m 2pxc  x2c =p2 0 6 xc 6 p; then updated at each time step. The neighbor boundary par-
ð20Þ
yc ¼ mð2pðxc  1Þ þ 1  x2c Þ=ð1  p2 Þ p < xc 6 1; ticles of a given near boundary fluid particle are sorted in
accordance with the distance between boundary particles
where m is the maximum camber in percentage of the chord, which and the fluid particle in ascending order. Then, the fluid par-
is taken to be 5%, p is the position of the maximum camber in per- ticle in question is given the unit normal vector of its nearest
centage of the chord that is set to be 50%, and t is the maximum boundary neighbor particle. For instance, fluid particle i = 25
thickness of the airfoil in percentage of the chord, which is 15%. in Fig. 1a is given the unit normal of the boundary particle
The thickness distribution above and below the mean camber line i = 7. The neighbor lists of all particles are updated by com-
is calculated as puting the angles ð~ ni  ~
nj Þ among unit normal vectors of par-
  ticles and their neighbors. Here, ~ ni and ~
nj are the unit
yt ¼ 5t 0:2969x0:5 2 3 4
c  0:126xc  0:3516xc þ 0:284xc  0:1015xc :
normal of a given particle and its neighbors. Only the parti-
ð21Þ
cles with angles smaller than the preset value (130° used in
The final coordinates of the airfoil for the upper surface (xU, yU) and this study) are regarded as neighbors to each other, whereby
the lower surface (xL, yL) are determined using the following forming the updated neighbor list. To be more specific, as
relations: xU = xc  ytsinu, yU = yc + ytcosu, xL = xc + ytsinu, yL = yc  can be seen from Fig. 1b, the updated neighbor list of the
ytcosu, and u = arctan(dyc/dx). Having obtained all coordinates of particle i = 25 includes only those particles enclosed by a
the airfoil geometry, the upper and lower surface lines are curve fit- square frame since other neighbor particles do not satisfy
ted using the least square method of order six. In so doing, it be- the preset angle condition even though they are in the influ-
comes possible to compute boundary unit normals, tangents and ence domain of the particle i = 25.
slopes for each boundary particles. All the initial particles falling (b) As in the case of step-a, all near boundary fluid and bound-
between the upper and lower camber fitted curves are removed ary particles are associated with their updated neighbor
from the rectangular computational domain, then remaining fluid boundary particles. Associating near boundary fluid particles
particles are combined with the boundary particles to form a parti- and boundary particles with their neighbor boundary parti-
cle array of the computational domain. cles, and sorting and then storing these neighbor boundary
The various steps of implementing the MBT boundary treat- particles in accordance with the shortest distance among
ment technique to the airfoil geometry, as depicted in Figs. 1 and them allows for (i) the computation of the overlapping con-
2, are as follows: tributions of mirrored particles from each boundary particle,
(ii) the confinement of the mirrored particles into the solid
(a) At each or prescribed time steps, all near boundary fluid par- domain, (iii) defining solid boundaries by the envelope of
ticles (particles with boundary truncations) as well as boundary tangent lines, as well as (iv) associating mirrored
boundary particles are associated with their neighbor bound- particles with near boundary fluid particles.
ary particles using the cell array data structure (the Fortran (c) Given that each boundary particle has fluid particles in its
90 derived data type) as also described in our earlier work influence domain as neighbors, these fluid particles are mir-
[22], see Fig. 1a. When dealing with a thin solid object rored with respect to the tangent line of the corresponding
enclosed by flow such as the trailing edge of the airfoil, for boundary particle as indicated in Fig. 2. The fluid particles
instance, near boundary fluid particles or boundary particles should satisfy the condition ~ rbf  ~
nb P 0, where ~
rbf is a posi-
positioned above/on the upper camber take contribution tion vector between the boundary particle and its neighbor
from fluid and boundary particles located below the upper fluid particles directing towards the fluid particles and ~ nb
camber since the weighting function W(rij, h) has an influ- is the unit normal of the boundary particle. This condition
ence domain that spans over the smoothing radius jh. Phys- ensures that only fluid particles above the associated bound-
ically, particles flanking a solid wall should not affect each ary particle tangent line are mirrored. The second condition
other. Consequently, the neighbor list computed through ~
rnbg  ~
nnb 6 0 to be fulfilled is that mirrored particles should
the standard box-sorting algorithm has to be modified, and be confined into the solid region, meaning that mirrored

Fig. 1. Boundary treatment for a submerged thin object: step-a.


M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1013

Fig. 2. Boundary treatment for a submerged thin object; (a) step-c and (b) step-d.

particles associated with a boundary particle have to be the creation of ghost particles, there is an over-creation of
inside of the all tangent lines of the neighbor boundary par- ghost particles due to the fact that the influence domain of
ticles of the boundary particle in question, where ~ rnbg is the neighboring boundary particles overlaps. The overlapping
position vector between the ghost particles and the neighbor contributions of mirrored particles can be eliminated by
boundary particles of the given boundary particle and, ~ nnb is determining the number of times a given fluid particle is
the unit normal vector of the neighbor boundary particles mirrored into the influence domain of the associated fluid
for the boundary particle in question. Using the cell array particle with respect to a boundary particle’s tangent line.
structure, every boundary particle is associated with its cor- For computational efficiency, the fluid particle might only
responding mirrored particles. Spatial coordinates and parti- be associated with the mirror particles of its several nearest
cle identification numbers of mirrored particles are stored in boundary particle rather than all neighbor boundary parti-
a cell array. To be more precise, mirrored particles are asso- cles as explained in Fig. 2b. Boundary particle i = 7 has the
ciated with the particle identification number of the fluid shortest distance to i = 25 compared to other boundary par-
particle from which they are originated (referred to as the ticles neighbor to the fluid particle i = 25. Hence, mirror par-
‘mother’ fluid particle). For example, for a fluid particle ticles of i = 7 also become the neighbor of i = 25 provided
indexed with i = 25, the ghost particle mirrored about a that above two conditions (i and ii) are satisfied. Near
boundary particle tangent line (for example, boundary parti- boundary fluid particles hold the information of spatial coor-
cle 7) will also be associated with i = 25 as shown in Fig. 2a. dinates and fluid particle identity numbers, boundary parti-
Note that fluid and boundary particles have numerical iden- cle identity numbers (i.e. the particle number for a boundary
tifications that are permanent, whereas mirrored particles particle to which mirrored particles are associated initially),
have varying (dummy) indices throughout the simulation. and over-creation number for mirrored particles in the cell
A ghost particle is given the same mass, density and trans- array format. During the SPH summation over ghost parti-
port parameters, such as viscosity, as the corresponding fluid cles for a fluid particle with a boundary truncation, the mass
particle. As for the field values (i.e. velocities) of a ghost par- of the ghost particles are divided by the number of corre-
ticle, they are obtained depending on the type of boundary sponding over-creations.
condition implemented. For instance, for no-slip boundary
conditions, the following relation is implemented: ~ vg ¼ 3. Flow around a square obstacle and an airfoil
2~vb  ~v f where ~ vg ; ~v b and ~
v f are the velocities of the ghost,
boundary, and fluid particles, respectively. As for the imple- In this work, to be able to test the effectiveness of the improved
mentation of a zero-gradient at the boundary, a ghost parti- SPH algorithm proposed in Section 2 (involving the utility of the
cle is given the same field values as the corresponding fluid MBT method together with the artificial particle displacement
particle; ~ vg ¼ ~v f , and pg = pf, where pg and pf are the pres- and the corrective SPH discretization scheme) for modeling fluid
sures of the ghost and fluid particles. If the boundaries are flow over complex geometries, we have solved two benchmark
stationary walls, the ghost particles will have the velocity flow problems; namely, two-dimensional simulations of a flow
v g ¼ ~
~ v f for no-slip boundary conditions. around a square obstacle and a NACA airfoil. Mass and linear
(d) In a loop over all particles, if a fluid particle has a boundary momentum balance equations are solved for both test cases on a
particle or multiple boundary particles as neighbor(s), then rectangular domain with the length of L = 15 m and the height of
the fluid particle will become a neighbor of all mirrored par- H = 6 m.
ticles associated with the corresponding boundary particles A square obstacle with a side dimension of 0.7 m is positioned in
on the condition that (i) the mirrored particles are in the the computational domain with its center coordinates at x = L/3 and
influence domain of the fluid particle in question, and (ii) y = L/2. Initially, a 349  145 array (in x- and y-directions, respec-
for a mirrored particle, its mother particle has to be within tively) of particles is created in the rectangular domain, and then
the influence domain of the fluid particle in question. During particles within the square obstacle are removed from the particle
1014 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

array. This set of initial particles are created regularly through the the square obstacle. For upper and lower walls bounding the sim-
formulations x = (i  1)  L/(ilen  1), and y = (j  1)  H/(jlen  1) ulation domain, the symmetry boundary condition for the velocity
where x and y are coordinates of particles, i and j are nodal indices is applied such that vy = 0, and @vx/@y = 0 which is discretized by
in the x- and y-directions, respectively, and ilen and jlen are the using Eq. (6). As for the pressure, a zero-pressure gradient condi-
number of nodes along the x- and y-directions in the given order. tion rp  ~n ¼ 0 is enforced on all solid boundary particles.
The boundary particles on the square obstacle are created such that The channel geometry and the boundary conditions for the sec-
their particle spacing is almost the same as the initial particle spac- ond benchmark problem are identical to the first one except that
ing of the fluid particles. The implementation of the MBT method the square obstacle geometry is replaced by the NACA airfoil with
for the square obstacle follows the same steps described previously a chord length of 2 m. The leading edge of the airfoil is located at
for the airfoil geometry. The simulation parameters, fluid density, Cartesian coordinates (L/5, H/2). Initially, a 300  125 array (in
dynamic viscosity and body force are taken as respectively x- and y-directions, respectively) of particles is created in the rect-
q = 1000 kg/m3, l = 1 kg/ms, and F xB ¼ 3:0  103 N=kg. The mass angular domain, and then, particles within the airfoil are removed
of each particle is constant and found through the relation from the particle array. Subsequently, boundary particles are cre-
P
mi = qi/ni where ni ¼ j¼1 Wðr ij ; hÞ is the number density of the par- ated and then distributed on solid boundaries. The smoothing
ticle i. The smoothing length for all particles is set equal to 1.6 times length for all particles is set equal to 1.6 times the initial particle
the initial particle spacing. spacing. To show convergence, we run a test case with three differ-
The slightly modified periodic boundary condition is imple- ent particle arrays, namely, 150  62, and 300  125 and
mented for inlet and outlet particles in the direction of the flow. 400  167 were used. It was observed that 300  125 array of par-
Particles crossing the outflow boundary are reinserted into the ticles is sufficient for particle number independent solutions.
flow domain at the inlet from the same y-coordinate positions with The flow around the airfoil and square obstacle positioned in-
the velocity of inlet fluid region with its coordinates of x = 0, and side the channel were simulated for a range of Reynolds numbers
y = 3 so that the inlet velocity profile is not poisoned by the outlet Re = qlcvb/l, which is defined by the characteristic length, lc (set
velocity profile. The no-slip boundary condition is implemented for equal to the side length for the square obstacle, and the chord
length for the airfoil geometry), the density, the bulk flow velocity
vb and the dynamic viscosity l. Both test cases are validated
through comparing SPH results with those obtained by a Finite
Element Method (FEM) based solver of a Comsol multiphsics
software tool. The ISPH and FEM results are compared in terms
of velocity contours for both test cases, and the pressure envelope
for the airfoil.
Fig. 3 shows the close-up view of particle positions around the
square obstacle for Reynolds number of 300. One can conclude that
the implementation of the MBT method together with the artificial
particle displacement and the corrective SPH discretization scheme
can successfully hinder the formation of chaotic particle distribu-
tion and fracture (unlike those observed in Ref. [22]) in the entire
flow domain (particularly in the vicinity of the boundary) and
effectively prevent the particle penetration through the boundary
(see Fig. 3), whereby producing simulation results in excellent
Fig. 3. A close-up view for particle positions around the square obstacle for
Reynolds number of 300.
agreement with FEM method as shown in Fig. 4. It is noted that

Fig. 4. A comparison of ISPH (left) and FEM (right) velocity contours for two different Reynolds number values, 100 and 200. It should be noted that in this presentation, all
velocities are given as a velocity magnitude.
M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1015

for all of the test cases, the artificial particle movement coefficient of attack of 5° and 15° for a simulation time of 100 s, corresponding
is kept constant and equal to 0.01. It is also noted that this coeffi- to the Reynolds number of 570.
cient should be selected carefully such that it should be small en- The proposed algorithm is also very successful in simulating the
ough not to affect the physics of the flow, but also large enough to flow around the airfoil geometry with any geometrical orientations
prevent the occurrence of clustering and particle deficiency. Fig. 4 across the flow field, whereby producing simulation results in very
compares ISPH and FEM velocity contours for two different Rey- good agreement with the FEM method as shown in Figs. 8 and 9.
nolds number values, 100 and 200. Fig. 8 compares SPH and FEM velocity contours for the angle of at-
It is well-known from both earlier experiments and numerical tack of 15° with the Reynolds number value of 570.
studies that vortex shedding is observed at the rear edge of the The pressure envelope results obtained by ISPH and FEM for
square obstacle at higher Reynolds numbers [28]. In light of this, smaller angles of attack are also in very good agreement with each
to be able address whether the SPH method can capture vortex other with some local deviations as shown in Fig. 9 (left). As for the
shedding as accurately as mesh dependent solvers, we here present angle of attack of 15°, there is a slight departure in pressure values
simulation results for Reynolds number of 300, where Fig. 5 (left from FEM results for the upper camber in the vicinity of leading
figures) shows the simulation results for the vortex tail down edge and the stagnation point. These discrepancies in pressure val-
and up. On comparing ISPH and FEM results, one can notice that re- ues might be attributed to the dynamic nature of the SPH method
sults are satisfactorily in agreement with each other regarding the since fluid particles are in continuous motion. Hence, there might
magnitude of velocities as well as the position and the number of be a local temporary depletion of particles nearby the solid bound-
vortices. However, there is a slight discrepancy between ISPH and aries as shown in Fig. 7, which deteriorates the accuracy of the
FEM results in terms of the separation point of the vortices from computed pressure because the SPH gradient discretization
the rear edge of the obstacle. For the sake of brevity, without pre- scheme is rather sensitive to the particle deficiencies within the
senting further results, we can safely assert that the SPH method is influence domain of the smoothing kernel function. Except the lo-
highly successful in predicting changes of the topology of the vor- cal deviations in pressure values on the airfoil, SPH results compare
tex shedding behind a square obstacle with the Reynolds number. excellently well with FEM solutions. Additionally, the pressure dif-
To have a closer look at the vortex shedding behavior captured ferences between upper and lower camber which correlate with
at the trailing edge of the square obstacle by the ISPH method, in the lift force are in match with FEM results for a given position
Fig. 6 are presented the streamlines of vortex shedding for a full on the boundary.
period for the Reynolds number of 300. One can immediately no- In order to investigate the sensitivity of the numerical solutions
tice the development of a small vortex at the rear top edge of the to particle numbers in the ISPH method and the underlying mesh
square obstacle, which is growing in size during its motion towards in FEM, the velocity field over the airfoil at the same values of
the rear lower edge, and then separating from therein. The next the parameters have been computed on three different sets of par-
vortex starts at the lower rear edge, and grows in size while mov- ticles (i.e., 150  62 (coarse), 300  125 (intermediate), and
ing towards the top rear edge, and finally leaves the top rear edge. 400  167 (fine)) and two sets of meshes (i.e., 11,953 number of
The accuracy of the ISPH method can be further validated by triangular elements with 54,688 degrees of freedom (DOF)
considering the Strouhal number, which is defined as St = xlc/vb, (coarse), and 191,248 number of triangular elements with
where x is the frequency of vortex shedding. The computed value 864,206 DOF (fine)). Fig. 10 shows velocity contours in terms of
of the Strouhal number for the ISPH method for the Reynolds num- velocity magnitudes for the airfoil with the angle of attack of 15°
ber of 300 is 0.142, which is also consistent with the experimental at Reynolds number of 420. The comparison of results on the
result reported in the literature [29]. coarse, medium and the fine particle numbers demonstrates evi-
Having showed the capability and effectiveness of the improved dently that the intermediate particle number provides solutions
ISPH algorithm on a geometry with sharp corners, we further with sufficient accuracy considering the trade-off between compu-
tested our algorithm on a more general and complex geometry tational costs and capturing the features being studied. Since finer
with curved boundaries and a thin body section. Fig. 7 presents a meshes are computationally expensive, the intermediate particle
close-up view of particle positions around airfoils with the angles number is chosen for the numerical simulations presented in this

Fig. 5. The comparison of vortex shedding contours obtained with ISPH (left) and FEM (right) methods for the cases of vortex tail down (up figures) and up (down figures) for
the Reynolds number of 300.
1016 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

Fig. 6. The streamlines of vortex shedding for a full period at the Reynolds number of 300 plotted on particle distribution where colors denote the velocity magnitude. One
period T is 9.85 s. (For interpretation of the references to color in this figure legend, the reader is referred to the web version of this article.)

article. The simulations are performed on a workstation with computational cost in terms of CPU time for the coarse, medium
the configuration of Intel (R) Core (TM) i7 (@9500 @3.07 GHz) and fine particle numbers are 1.36, 3.24 and 14.05 s per each time
processor under Windows XP (64 bit) operating system. The step, respectively.
M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1017

Fig. 7. Close-up view of particle positions around airfoils with the angles of attack of 5° and 15° for a simulation time of 100 s, corresponding to the Reynolds number of 570.
For the angle of attack of 15°, there is slight particle depletion in the close vicinity of the stagnation point, which is not observed for lower values of the angle of attack.

Fig. 8. A comparison of ISPH (left) and FEM (right) velocity contours for the angle of attack of 15° with the Reynolds number value of 570.

Fig. 9. The comparison of pressure envelopes for the angles of attack of 5° (left) and 15° (right) for the Reynolds numbers of 420 (up) and 570 (down).
1018 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

Fig. 10. The velocity fields in terms of velocity magnitudes over the airfoil (with the angle of attack of 15° at Reynolds number of 420) computed on three different sets of
particles for the ISPH method and on two sets of meshes for FEM.

Fig. 11. The comparison of vortex shedding contours produced by ISPH (left) and FEM (right) methods for the angle of attack of 10° and the Reynolds number of 1600.

Fig. 11 compares ISPH and FEM results in terms of the vortex a new vortex appears on the upper camber again, thereby complet-
shedding contours for the angle of attack of 10° with the Reynolds ing a full period.
number of 1600. As in the case of the presented square obstacle re-
sults, SPH results are also satisfactorily in agreement with FEM 4. Conclusion
regarding the magnitude of velocities as well as the position and
the number of vortices for the airfoil geometry. In this work, we have presented solutions for flow over an air-
The vortex shedding behavior computed by the SPH method is foil and a square obstacle using an improved ISPH algorithm that
presented in Fig. 12 as a close-up view magnifying the region about can handle complex geometries with the usage of the MBT method,
one airfoil length behind the trailing edge in terms of the stream- and eliminate particle clustering induced instabilities with the
lines of vortex shedding for a full period for the Reynolds number implementation of artificial particle displacement (particle frac-
of 1400 and the angle of attack of 10°. There are two vortices near ture repair) procedure as well as the corrective SPH discretization
the trailing edge of the airfoil, one being on the upper camber, and scheme. The close-up views for the distribution of fluid particles
the second is at the end of the trailing edge. The first vortex is around bluff bodies illustrate that the proposed boundary treat-
pushing the second vortex away from the trailing edge during its ment prevents both particle deficiency and particle penetration
downward motion towards the trailing edge. When the second across the solid boundary without disturbing flow structure. We
vortex disappears, and the first vortex reaches to the trailing edge, have shown that the improved ISPH method can be effectively
M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020 1019

Fig. 12. The streamlines of vortex shedding for a full period at the Reynolds number of 1400 plotted on particle distribution where colors denote the velocity magnitude. One
period T is 3.2 s. (For interpretation of the references to color in this figure legend, the reader is referred to the web version of this article.)

Z
used for flow simulations over bluff-bodies with Reynolds num- @Wðr ij ; hÞ 3
ðf p ð~
rj Þ  f p ð~
ri ÞÞ d~ rj
bers as high as 1600, which is not achievable with standard ISPH X @xsj
formulations. It should be noted that the improved ISPH algorithm Z
@f p ð~
ri Þ @Wðr ij ; hÞ 3 1 @f p ð~
ri Þ
is not limited to simulations for Reynolds numbers of 1600 in lam- ¼ rlji s
d~ rj þ
inar flow regime. It can run to higher Reynolds number values @xli X @x j 2 @x l
i @x k
i
|fflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl{zfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl}
without any interruption. Our simulation results are validated with Ils
an FEM method, and excellent agreements among the results were Z
@Wðr ij ; hÞ 3
observed. We illustrated that the improved ISPH method is able to  rlji r kji d~ rj : ðA:2Þ
X @xsj
capture the complex physics of bluff-body flows naturally such as |fflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl{zfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl}
flow separation, wake formation at the trailing edge, and vortex Ilks ¼0

shedding without any extra effort to increase the particle resolu- Note that the first and the second integrals on the right hand side of
tion in some specific areas of interest. As well, our future work in- Eq. (A.2) are, respectively, second- and third-rank tensors. The
cludes the implementation of artificial particle displacement third-rank tensor Ilks can be integrated by parts, which, upon using
algorithm for the flow problems with free surfaces as well as the the Green–Gauss theorem produces Eq. (A.3) since the kernel
utilization of the MBT boundary treatment method in multiphase W(rij, h) vanishes beyond its support domain
flow problems. Z
@  l k 3
Ilks ¼  r r d~
Wðr ij ; hÞ rj
X @rsj ji ji
Acknowledgement Z  
3
¼  Wðr ij ; hÞ r lji dsk þ r kji dls d ~ rj ðA:3Þ
Funding provided by the European Commission Research Direc- X
torate General under Marie Curie International Reintegration Grant
Recalling that the kernel function is spherically symmetric even
program with the Grant Agreement number of 231048 (PIRG03-
function and the multiplication of an even function by an odd func-
GA-2008-231048) is gratefully acknowledged.
tion produces an odd function. Integration of an odd function over a
symmetric domain leads to zero
Appendix A
Z Z
3 3
Ilks ¼ dsk r lji Wðr ij ; hÞd ~ rj dls rkji Wðrij ; hÞd ~ rj ¼ 0: ðA:4Þ
X X
The following section provides derivations for the SPH approx- |fflfflfflfflfflfflfflfflfflfflfflfflfflfflffl{zfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl} |fflfflfflfflfflfflfflfflfflfflfflfflfflfflffl{zfflfflfflfflfflfflfflfflfflfflfflfflfflfflffl}
¼0 ¼0
imation to first- and second-order derivatives of a vector-valued
function. The derivations are carried out in Cartesian coordinates. Following the above described procedure identically, the second
The SPH approximation for the gradient of a vectorial function rank tensor Ils can be written as
starts with a Taylor series expansion of f p ð~
rj Þ so that Z
3
Ils ¼ dls Wðr ij ; hÞd ~ rj ¼ dls : ðA:5Þ
X
ri Þ
@f p ð~ 1 ri Þ
@f p ð~ |fflfflfflfflfflfflfflfflfflfflfflffl{zfflfflfflfflfflfflfflfflfflfflfflffl}
f p ð~
rj Þ ¼ f p ð~
ri Þ þ r lji þ rlji r kji l k : ðA:1Þ ¼1
@xli ~
2 @xi @xi
rj ¼~
ri ~
rj ¼~
ri On combining Eq. (A.2) with Eqs. (A.4) and (A.5), one can write,
Z
@f p ð~
ri Þ @Wðr ij ; hÞ 3
Upon multiplying Eq. (A.1) by the term, @Wðr ij ; hÞ=@xsj , and then ¼ ðf p ð~
rj Þ  f p ð~
ri ÞÞ d~ rj : ðA:6Þ
3
integrating over the whole space d ~rj , one can write, @xsi X @xsi
1020 M.S. Shadloo et al. / Comput. Methods Appl. Mech. Engrg. 200 (2011) 1008–1020

Note that in Eq. (A.6), the relationship @Wðrij ; hÞ=@xsj ¼ Upon contracting on indices s and m of Eq. (A.10), an alternative
@Wðrij ; hÞ=@xsi has been used. Replacing the integration in Eq. form of the Laplacian for a vector field can be obtained as
(A.6) with the SPH summation over particle ‘‘j’’ and setting
3 X
N
mj r sij @Wðr ij ; hÞ @ 2 f p ð~
ri Þ
d~ rj ¼ mj =qj , we can obtain the gradient of a vector-valued function 8 ðf p ð~
ri Þ  f p ð~
rj ÞÞ ¼ ð2 þ dss Þ k k : ðA:15Þ
in the form of the SPH interpolation as j¼1
qj 2
r ij @xis
@xi @xi

ri Þ X
@f p ð~ N
mj p @Wðr ij ; hÞ If the trace of the Kronecker delta in Eq. (A.15) is replaced by the
¼ rj Þ  f p ð~
ðf ð~ ri ÞÞ : ðA:7Þ
@xi s
qj @xsi trace of Eq. (A.12), one can obtain an alternative form of the correc-
j¼1
tive SPH interpolation for the Laplacian.
It is important to note that the second rank tensor Ils, shown to be
equal to Kronecker delta for a continuous function, may not be References
equal to Kronecker delta for discrete particles. Hence, for the accu-
racy of the computations, this term should be included in the SPH [1] A. Rafiee, M.T. Manzari, S.M. Hosseini, An incompressible SPH method for
simulation of unsteady viscoelastic free-surface flows, Int. J. Non-Linear Mech.
gradient interpolation of a function. From Eq. (A.2), we can write 42 (10) (2007) 1210–1223.
[2] Y. Mele’an, L.D.G. Sigalotti, A. Hasmy, On the SPH tensile instability in forming
X
N
mj @Wðr ij ; hÞ viscous liquid drops, Comput. Phys. Commun. 157 (2004) 191–200.
ðf p ð~
rj Þ  f p ð~
ri ÞÞ [3] A.M. Tartakovsky, P. Meakin, A smoothed particle hydrodynamics model for
j¼1
qj @xsi
miscible flow in three-dimensional fractures and the two-dimensional
Rayleigh Taylor instability, J. Comput. Phys. 207 (2) (2005) 610–624.
ri Þ X
@f p ð~ N
mj l @Wðrij ; hÞ [4] P.W. Cleary, J. Ha, V. Aluine, T. Nguyen, Flow modelling in casting processes,
¼ r : ðA:8Þ
@xi j¼1 qj ji
l @xsi Appl. Math. Mod. 26 (2002) 171–190.
[5] L.B. Lucy, A numerical approach to the testing of the fission hypothesis, Astron.
J. 82 (1977) 1013.
Eq. (A.8) can be written in matrix form as [6] R.A. Gingold, J.J. Monaghan, Smooth particle hydrodynamics: theory and
2 3 2 3 application to non-spherical stars, Mon. Not. R. Astron. Soc. 181 (1977) 375.
PN
ð1Þ ð1Þ PN
ð1Þ ð1Þ P
N
ð2Þ ð1Þ
2 ð1Þ 3
[7] L.D.G. Sigalotti, J. Klapp, E. Sira, Y. Mele’an, A. Hasmy, SPH simulations of time-
6 fji aj 7 6 r ji aj r ji aj 7 @fið1Þ
6 j¼1 7 6 j¼1 j¼1 76 @xi 7 dependent Poiseuille flow at low Reynolds numbers, J. Comput. Phys. 191
6 7¼6 76 7 ðA:9Þ
6P 7 6 N 74 ð1Þ 5; (2003) 622–638.
4 N ð1Þ ð2Þ 5 4 P ð1Þ ð2Þ PN
ð2Þ ð2Þ 5 @fi [8] A. Rafiee, K.P. Thiagarajan, An SPH projection method for simulating fluid-
fji aj r ji aj r ji aj @x
ð2Þ
hypoelastic structure interaction, Comput. Methods Appl. Mech. Engrg. 198
j¼1 j¼1 j¼1 i
(2009) 2785–2795.
  [9] M.B. Liu, G.R. Liu, K.Y. Lam, A one-dimensional meshfree particle formulation
where asj ¼ ðmj =qj Þ @Wðr ij ; hÞ=@xsi . for simulating shock waves, Shock Waves 13 (2003) 201–211.
Starting with the relation for the SPH second-order derivative [10] S.M. Hosseini, M.T. Manzari, S.K. Hannani, A fully explicit three-step SPH
approximation [22] of a vector valued-function f p ð~
ri Þ given in Eq. algorithm for simulation of non-Newtonian fluid flow, J. Numer. Methods Heat
Fluid Flow 17 (7) (2007) 715–735.
(A.10)
[11] R.A. Rook, M. Yildiz, S. Dost, Modelling 2D transient heat transfer using SPH
Z and implicit time integration, J. Numer. Heat Transfer B 51 (2007) 1–23.
rsij @Wðrij ; hÞ 3
2 ðf p ð~
ri Þ  f p ð~
rj ÞÞ d~ rj [12] S. Kulasegaram, J. Bonet, R.W. Lewis, M. Profit, A variational formulation based
X r2ij @xm
i contact algorithm for rigid boundaries in two-dimensional SPH applications,
Comput. Mech. 33 (2004) 316–325.
2 @ 2 f p ð~
ri Þ 1 @ 2 f p ð~
ri Þ sm [13] J. Feldman, J. Bonet, Dynamic refinement and boundary contact forces in SPH
¼ þ d ; ðA:10Þ with applications in fluid flow problems, Int. J. Numer. Methods Engrg. 72
n @xi @xm
s
i n @x k
i @x k
i (2007) 295–324.
[14] Y. Krongauz, T. Belytschko, Enforcement of essential boundary conditions in
which, upon contracting on indices p and s, one can obtain meshless approximations using finite elements, Comput. Methods Appl. Mech.
Z Engrg. 131 (1996) 133–145.
rpij @Wðrij ; hÞ 3 1 @ 2 f p ð~
ri Þ pm [15] I. Alfaro, F. Yvonnet, R. Chinesta, E. Cueto, A study on the performance of
2 ðf p ð~
ri Þ  f p ð~
rj ÞÞ 2 m
d~ rj ¼ d : ðA:11Þ
X rij @xi n @xki @xki natural neighbour-based Galerkin methods, Int. J. Numer. Methods Engrg. 71
(2007) 1436–1465.
Note that the first term on the right hand side of Eq. (A.10) becomes [16] J.C. Simpson, M. Wood, Classical kinetic theory simulations using smoothed
particle hydrodynamics, Phys. Rev. E 54 (2) (1996) 2077–2083.
ri Þ=@xpi @xm
@ 2 f p ð~ i and consequently drops off if the vector-valued [17] J.J. Monaghan, A. Kos, Solitary waves on a cretan beach, J. Waterway Port
function f p ð~ ri Þ is assumed to be a divergence-free velocity field. Coastal Ocean Engrg. – ASCE 125 (1999) 145–154.
Here, the coefficient n takes the value of 4 and 5 in two and three [18] J.J. Monaghan, Smoothed particle hydrodynamics, Rep. Prog. Phys. 68 (2005)
1703.
dimensions, respectively. We have shown in Eqs. (A.2) and (A.5) [19] J.P. Morris, P.J. Fox, Y. Zhu, Modeling low Reynolds number incompressible
that Kronecker delta can be written as, flows using SPH, J. Comput. Phys. 136 (1997) 214–226.
Z [20] A. Colagrossi, M. Landrini, Numerical simulation of interfacial flows by
@Wðr ij ; hÞ 3 smoothed particle hydrodynamics, J. Comput. Phys. 191 (1) (2003) 448–475.
dpm ¼ r pji d~ rj : ðA:12Þ [21] H. Takeda, S.M. Miyama, M. Sekiya, Numerical simulation of viscous flow by
X @xm
i
smoothed particle hydrodynamics, Prog. Theor. Phys. 92 (5) (1994) 939–960.
Casting Eq. (A.12) into Eq. (A.11) leads to [22] M. Yildiz, R.A. Rook, A. Suleman, SPH with the multiple boundary tangent
method, Int. J. Numer. Methods Engrg. 77 (10) (2009) 1416–1438.
Z
rpij @Wðrij ; hÞ 3 [23] M.B. Liu, G.R. Liu, Smoothed particle hydrodynamics (SPH): an overview and
2 ðf p ð~
ri Þ  f p ð~
rj ÞÞ d~ rj recent developments, Arch. Comput. Methods Engrg. 17 (2010) 25–76.
X r2ij @xm
i [24] P.W. Cleary, J.J. Monaghan, Conduction modelling using smoothed particle
Z hydrodynamics, J. Comput. Phys. 148 (1999) 227–264.
1 @ 2 f p ð~
ri Þ @Wðrij ; hÞ 3 [25] A.J. Chorin, Numerical solutions of the Navier–Stokes equations, Math.
¼ r pji d~ rj ðA:13Þ Comput. 22 (1968) 745–762.
n @xki @xki X @xm
i [26] A.J. Chorin, On the convergence of discrete approximations to the Navier–
Stokes equations, Math. Comput. 23 (1969) 341–353.
Eq. (A.13) can be written in matrix form as [27] S.J. Cummins, M. Rudman, An SPH projection method, J. Comput. Phys. 152
2 P ð1Þ ð1Þ P 32 3 (1999) 584–607.
2 3 r a
ð2Þ ð1Þ
r ji aj @2 f
i
ð1Þ

  ð1Þ [28] J. Bernsdorf, Th. Zeiser, G. Brenner, F. Durst, Simulation of a 2D channel flow
X ð1Þ ð1Þ ð2Þ ð2Þ 8 4 j 5
a 6 j¼1 ji j j¼1 76 7
@xki @xki
fij r ij þ fij r ij 6
¼ 4 P ð1Þ ð2Þ P 76 7 around a square obstacle with Lattice–Boltzmann (BGK) automata, Int. J. Mod.
r 2ij að2Þ ð2Þ ð2Þ 54 @ 2 f ð2Þ 5 Phys. C 9 (8) (1998) 1129–1141.
j¼1 r a j ji j r ji aj i
j¼1 j¼1 @xk @xk [29] A. Okjima, Strouhal numbers of rectangular cylinders, J. Fluid Mech. 123
i i
(1982) 379–398.
ðA:14Þ

Вам также может понравиться