SPH Cam Clay
SPH Cam Clay
SPH Cam Clay
Abstract: Numerical simulation of large deformation of soil based on constitutive models describing small
deformation of soil in the framework of smoothed particle hydrodynamics (SPH) is investigated in this
paper. In recent decades, the SPH method has been successfully used to simulate large deformation of soil.
When SPH is used to simulate soil, constitutive models should be implemented in the SPH code in order to
reflect the stress-strain relationship of soil. Nevertheless, typical soil constitutive models generally describe
small deformation, and so the effects of them in the problem of simulating large deformation are worth
researching. In this study, the SPH method with two elastic–plastic constitutive models i.e. Drucker-Prager
model and the modified Cam-Clay model, are applied to simulate soil collapse. Numerical results indicate
that there are superior differences in SPH simulation with the two constitutive models. Based on the
obtained results, that constitutive models play an important role in simulation of large deformation of soil
could be considered.
Key words: Elastic-plastic constitutive model, large deformation, smoothed particle hydrodynamics, soil
collapse.
1. Introduction
Slope failures are complex natural phenomena that constitute a serious natural hazard, and impose heavy
loss each year to human life and properties all over the world. Given this understanding, it is not surprising
that landslides are rapidly becoming the focus of major scientific research, engineering study, and practices.
To prevent or mitigate the landslide damage, one of research methodologies is numerical simulation
technique, and it can understand and evaluate the processes that govern the behavior of the slopes
economically and abundantly.
Slope failures belong to large deformation problems of soil, and dealing with such problems is generally
difficult for finite element method (FEM) since FEM is suffered from grid distortions. Aim to simulate large
deformation of soil, smoothed particle hydrodynamics (SPH) has been presented. SPH is a purely
Lagrangian meshless method, compared with grid-based numerical methods, the SPH method can handle
large deformation problems without mesh distortion.
SPH was originally developed for astrophysical applications by Lucy [1] and Monaghan & Gingold [2].
Then it has been widely applied to dynamic response of material strength [3], [4], fluid flow [5], [6], etc.
More recently, SPH application to soil mechanics was proposed by Maeda et al. [7], in which a simple
non-linear elastic model was employed to simulate granular soil. SPH implemented by Drucker-Prager
constitutive model was researched by Bui et al. [8], [9], which has demonstrated successful performance of
SPH for simulating slope failure, landslide that are about large deformation in geotechnical engineering.
When SPH is utilized to mimic deformation of soil, the constitutive models should be implemented into
the SPH code to describe the stress-strain relationship. Using different constitutive models, the soil is
treated as an ideal material with different properties. In the problem of slope failures, the soil will
experience the process of small deformation to large deformation, and exhibit the transition from a
solid-like to a fluid-like behavior. The constitutive models of soils in SPH give rise to more realistic and
accurate simulation results for large deformation problems [9].
Although there are many constitutive models of soil, frequently-used constitutive models are a few of
elastic-plastic models, such as Drucker-Prager model (D-P model) and the modified Cam-Clay model (MCC
model), because these models are relatively simple, easy programming and widespread application.
In this study, the two kinds of typical soil constitutive models are embedded into the SPH algorithm. The
SPH method with D-P model and MCC model are adopted to simulate soil collapse. Based on the numerical
and experimental results, the differences of the two constitutive models in simulation large deformation of
soil are discussed.
The paper is organized as follows. In the next section the SPH method is briefly described. Then the SPH
method implemented by soil constitutive models is presented. In the remaining section of the paper, the
numerical framework is used in the simulations of soil collapse, and the results of numerical simulation are
discussed and analyzed.
where x , x are coordinate vectors contained in the influence domain Ω, dx is infinitesimal volume
element at point x , W is kernel or smoothing function, h is the radius of the influence domain, depicting
the influence of the smooth function.
The smooth function acts as a weight function in the approximation process, largely deciding the
precision and stability of SPH method. The smooth function should satisfy the unity condition, the delta
condition and the compact condition.
There are many kernel functions in the literature, such as bell-shaped function [1], Gaussian function [10],
the cubic spline kernel function [11], the quartic spline function [12] etc. Among various smooth functions,
the cubic spline kernel function is the most popular, and this kernel function is employed in the current
study and can be expressed as
2 1 3
3 R 2 R , 0 R 1
2
W x x, h =W R, h ad 2 R ,
1 3
1 R 2
(2)
6
0, R2
conditions. R is the relative distance between two particles at points x and x , and its expression is as
follows
x x
R (3)
h
In particle approximation, the integral representation (1) concerning the SPH kernel approximation can
be converted to discretized forms of summation over all the particles in the support domain. The particle
approximation for a function at particle i can finally be written as
f x j Wij
N mj
f xi (4)
j 1 j
where m j , j represent the mass and density of particle j (=1,2,…,N) respectively , in which N is the
number of particles within the support domain of particle at point x .
The particle approximation for the spatial derivative of the function f x is
f xi N m j W
f x j ij (5)
x j 1 j xi
where
Wij W xi x j , h (6)
Dv 1
+f (8)
Dt x
where , denote the Cartesian components x, y and z with the Einstein convention applied to repeated
indices; is the soil density; v denotes the velocity; f is gravity force; D / Dt represents the
material derivative;
stands for the total tress tensor of soil, and it can be divided into an isotropic
hydrostatic pressure p and a deviatoric stress tensor s :
= p s (9)
where
is Kronecker’s delta. In the framework of SPH, hydrostatic pressure p is instead calculated
directly from mean stress:
xx yy zz
1
p (10)
3 3
where , and are the components of the stress tensor in the x, y and z directions, and it can
xx yy zz
Di N W
= m j vi vj ij (11)
Dt j 1 xi
Dvi N W
m j i 2 j2 ij +f (12)
Dt j xi
j 1 i
It is noted that both of Equations (11) and (12) include the symmetrical structure, and it can reduce
errors arising from the particle inconsistency problem [11].
In order to simulate large deformation of soil by SPH, the governing equations should be approximated
using SPH interpolation functions. On the other hand, the soil constitutive models are important to describe
the stress–strain relationship of soil in the SPH framework.
(13)
= e + p
It is noted that the stress and strain are expressed by the form of rate because of the requirement of
calculating in SPH method.
The elastic strain rate tensor e can be calculated by the generalized Hooke’s law:
s 1 2 (14)
e =
2G 3E
where is Poisson’s ratio; E denotes Young’s modulus; G represents the shear modulus.
The plastic strain rate tensor p can be given by using the plastic flow rule:
g (15)
p =
where is the rate form of plastic multiplier, which can be computed from the consistency condition; g is
the plastic potential function.
The general stress–strain relationship for elastic-plastic soil can be derived as follows:
(16)
2 2 g g
2G K G K G mn mn 2G
3
3
where = is the sum of the three normal strain components, K is the elastic bulk
xx yy zz
modulus.
3.2.2. Drucker-Prager model
As the failure surface of D-P model is smooth, this brings great convenience for numerical calculation and
application. The D-P constitutive model with non-associated flow rule had been implemented in the SPH
code in literature [9], and the soil is regarded as elastic–perfectly plastic material at that time. Herein, the
process of implementation is just outlined.
The D-P yield criteria can be expressed as
f I1 , J 2 J 2 I1 kc (17)
where I1 and J2 are the first and second stress invariants respectively, i.e.
1
I1 xx yy zz , J 2 s s (18)
2
and kc are D-P constants, and in plane strain the two constants are computed by
tan 3c
, kc (19)
9 12 tan
2
9 12 tan 2
(21)
D i 2
i i + i i 2G i K G i i
Dt 3
G
i 9 K sin si
J
2
with the following equation for the rate of change of plastic multiplier
i =
3 K i G / J 2 si i (22)
27 K sin G
(23)
1 v v
=
2 x x
1 N m W W
= j vj vi ij j v j vi ij
N m
2 j 1 j xi j 1 j xi
f p, q, p0 p 2 M 2 q 2 M 2 pp0 0 (24)
3
q s s (25)
2
1 e0
p0 pa exp p (27)
where pa is the initial pressure; , denote compression and swelling index, respectively; e 0 is initial
void ratio. The MCC model adopts associated flow rule, and plastic potential function g is the same as the
yield function f. The final stress rate in SPH discretization form of MCC model can be expressed by
(28)
D i 2
i i + i i +2G i K G i i
Dt 3
i KM 2 p0 2 pi 6Gsi
with the following equation for the rate of change of plastic multiplier
(29)
KM 2 p0 2 pi i 6G i si
i
1 e0
KM 4 2 pi p0 12Gqi 2 p p M 4 2 pi p0
2
i 0
4. Algorithm Design
4.1. Stress Correction
Since two kinds of elastic-plastic soil constitutive model were implanted in SPH method, the behavior of
soil has to keep to the models i.e. the stress state must not lie outside the yield surface when plastic
deformation takes place. However, the stress state of soil may leave the elastic domain during
computational plasticity, which can lead to numerical errors. In order to avoid the errors, a stress correction
algorithm is often used to numerically return the stress state to the yield surface.
4.1.1. Stress correction on Drucker-Prager model
For the stress correction on D-P model, the literature [9] has described in detail, here only the main idea
is listed.
If the stress state of soil moves beyond the apex of the yield surface during computation, such as the
stress state changes point A to point B illustrated in Figure 1, tension cracking will happen. The criterion of
judging this situation is followed as
which means the stress state of material at a time step n exceeds the apex of the yield surface. In this case,
we shall keep the shearing stresses unchanged, and adjust the normal stress components to new values
so that the hydrostatic pressure corresponds to that at the apex (see Figure 1) followed as
(31)
1
n n
I1n
3 kc
J2
D
E
Yield surface
C
kc
O -I1
kc/αϕ
On the other hand, if a stress state lies far away from the yield surface, i.e. the path CD in Figure 1, the
stress-rescaling procedure should be employed to return the stress state to the yield surface. The condition
of this case can be written as
I1n kc
rn 1 (32)
J 2n
In such a circumstance, the deviatoric shear stress components are reduced in proportion to the scaling
factor r, whereas the hydrostatic stress component I1 is left unchanged. The correction procedure can be
expressed as
(33)
1 1
r n n I1n I1n
3 3
Thus, the stress state will be pulled back from point D to point E on the yield surface (see Fig. 1).
4.1.2. Stress correction on the modified cam-clay model
When the soil is obedient to MCC model, the method of stress correction is quite different from D-P model,
because MCC model has a cap-shaped yield function and a critical state line in stress space.
Similar to the second situation of D-P model, when a stress state exceeds the yield surface, such as the
stress state at point F illustrated in Figure 2, which satisfies the following condition
For the sake of returning the stress state F to the yield surface, we can make firstly a straight line between
the stress point F and the center of the elliptic yield, and the intersection of the straight line and the yield
surface is the correction stress point G (see Figure 2). The formula of correction procedure can be written
as
2 pn p0 p0 M 2 2qn 2 pn p0 p0 M 2
2
p%n , %
q (35)
M 2 2 pn p0 4qn2 M 2 2 pn p0 4qn2
2 n 2
It is noted that in the present study adopts the leapfrog (LF) algorithm for numerical integration, so the
stress of soil is also interpolated at the half-time step (n+1/2).
CSL:q=Mp
Yield surface
p0/2 p0 p
O
Dvi N W
m j i 2 j2 ij ij +f (36)
Dt j 1 i j xi
where
and where
hij vi v j xi x j
ij , cij
1
ci c j , ij 12 i j , hij 12 hi h j (38)
xi x j + 0.1hij
2 2
2
In the above equations, and are constants that are all typically set around 1.0 [13]. c is the
sound speed in soil, which typically lies in the range 450–600m/s.
Fig. 4 shows velocity nephograms of collapse in the simulations for SPH with D-P model and MCC model
at representative times. The propagation of the shear bands from the crest to the toe of the columns can be
clearly observed. The progressive failure process can be captured by the SPH code with the two models. In
the SPH simulations, the thickness of shear band is mainly dominated by the smoothing length h. In
addition, results of the SPH simulation with the two models are quite different. Soil simulated by D-P model
acts more like granular material during the process of collapse, while soil looks more like clay in the SPH
simulation of MCC model. As could be seen, soil in the D-P simulation performs much looser than in the
MCC simulation, and soil collapses into blocks in some parts in the MCC simulation. [15] (top image), SPH
with D-P model (middle image) and MCC model (bottom image)
(a) t=0.05s
(b) t=0.10s
(c) t=0.15s
(d) t=0.20s
Fig. 4. Velocity nephograms of collapse in the simulations for SPH with D-P model (left images) and MCC
model (right images) at representative times: (a) t=0.05s; (b) t=0.10s; (c) t=0.15s; (d) t=0.20s.
Final shapes of the deposit obtained by experimentally and numerically are given in Figure 5. Good
agreement between simulations and experiment is found for the surface configurations; moreover, the
surface of SPH simulation with MCC model is smoother and more analogous to experiment than D-P model.
It can be found in MCC model that configuration of non-deformation sand on the right boundary is almost
exactly alike as experiment. The repose angles of the two simulations are good agree with experiments, and
these repose angles are less than the internal friction angle of 35°.
The different features of two constitutive models are possible reasons for aforementioned differences.
Soil is deemed as elastic-perfectly-plastic material in simulation of D-P model; once the condition of failure
is satisfied, the soil may flow, and it acts more like fluid. Whereas soil described by the modified Cam-Clay
model takes on the property of gradual failure.
6. Conclusions
The SPH method embedded by two elastic-plastic constitutive models is applied to simulate large
deformation of soil in the present study. The most popular elastic-plastic constitutive models i.e.
Drucker-Prager model and the modified Cam-Clay model describe different stress-strain relationships of
small deformation of soil. Constitutive models should be added to the governing equations when the SPH
method is used to mimic the behaviors of soil. The proposed SPH codes with D-P model and MCC model are
adopted to simulate soil collapse. The numerical results agree with the experimental well, but some
differences are found in the SPH simulation with two models. For non-cohesive soil in our study, SPH with
MCC model performs better than SPH with D-P model in term of surface configuration and shape of layers.
Although constitutive models represent generally properties of soil during small deformation, they also play
an important role in simulation of large deformation of soil.
In the future research, more constitutive models conforming to the characteristics of soil deformation
may be embedded in the SPH method to find more and better details of large deformation of soil.
Acknowledgment
The research in this paper is funded by Huanggang Normal University Natural Science Foundation under
Grant No. 201617603.
References
[1] Lucy, L. (1977). A numerical approach to testing the fission hypothesis. Astronomical Journal, 82,
1013–1024.
[2] Gingold, R. A., & Monaghan, J. J. (1977). Smoothed particle hydrodynamics: theory and application to
nonspherical stars. Monthly Notices of the Royal Astronomical Society, 181, 375–389.
[3] Libersky, L. D., Petschek, A. G., Carney, T. C., Hipp, J. R., & Allahdadi, F. A. (1993). High strain Lagrangian
hydrodynamics: a three dimensional SPH code for dynamic material response. Journal of Computational
Physics, 109, 67–75.
[4] Benz, W., & Asphaug, E. (1995). Simulations of brittle solids using smooth particle hydrodynamics.
Computer Physics Communications, 87, 253–265.
[5] Monaghan, J. J. (1994). Simulating free surface flows with SPH. Journal of Computational Physics, 110,
399–406.
[6] Takeda. H., Miyama, S. M., & Sekiya, M. (1994). Numerical simulation of viscous flow by smoothed
particle hydrodynamics. Progress of Theoretical Physics, 92(5), 939.
[7] Maeda, K., & Sakai, M. (2004). Development of seepage failure analysis procedure of granular ground
with smoothed particle hydrodynamics (SPH) method. Journal of Applied Mechanics (JSCE), 7, 775–786.
[8] Bui, H. H. (2007). Lagrangian mesh-free particle method (SPH) for large deformation and post-failure
of geomaterial using elasto-plastic constitutive models. Ph.D. Dissertation of Ritsumeikan University,
Japan.
[9] Bui, H. H., Fukagawa, R., Sako, K., & Ohno, S. (2008). Lagrangian meshfree particles method (SPH) for
large deformation and failure flows of geomaterial using elastic-plastic soil constitutive model. Int J
Numer Anal Meth Geomech, 32(12), 1537–1570.
[10] Monaghan, J., J. (1992). Smoothed particle hydrodynamics. Annual Review of Astronomy and
Astrophysics, 30, 543–574.
[11] Monaghan, J. J., & Lattanzio, J. C. (1985). A refined particle method for astrophysical problems.
Astronomic and Astrophysics, 149, 135.
[12] Morris, J., P. (1996). Analysis of SPH with applications. Ph.D. Thesis, Mathematics Department, Monash
University, Melbourne, Australia.
[13] Monaghan, J., J. (1988). An introduction to SPH. Computer Physics Communication, 48, 89-96.
[14] Gray, J. P., Monaghan, J. J., & Swift, R., P. (2001). SPH elastic dynamics. Computer Methods in Applied
Mechanics and Engineering, 190, 6641–6662.
[15] Catherine, M., & Trent, T. (2008). Scaling the final deposits of dry cohesive granular columns after
collapse and quasi-static fall. Physics of Fluids, 20(3).
Dandan Dong was born in Henan, China, in 1997. Now, she is a B.S. candidate in
mathematics and applied mathematics from Huanggang Normal University, China since
2016.
Xuejun Zhou was born in Hubei, China, in 1981. He received the B.S. in mathematics
and applied mathematics from Hubei Engineering University, China, in 2003, and the M.S.
in applied mathematics from Hubei University, China, in 2006. Now, he is a Ph.D.
candidate in solid mechanics from Hohai University, China, since 2014.
In 2006, he joined the college of mathematics and physics, Huanggang Normal
University, China, as a tutor, and in 2009 became a lecturer. Since December 2017, he has
been with the college of mathematics and physics, Huanggang Normal University, China, where he was
an associated professor. His current research interests include numerical study on large deformation of
geomaterials, and assessment of slope stability.
Mr. Zhou was a membership of the college of mathematics and physics, Huanggang Normal
University, China, for life.