Next Article in Journal
From Neural Command to Robotic Use: The Role of Symmetry/Asymmetry in Postural and Locomotor Activities
Previous Article in Journal
Semantic Features with Contextual Knowledge-Based Web Page Categorization Using the GloVe Model and Stacked BiLSTM
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A SPH-GFDM Coupled Method for Elasticity Analysis

1
State Key Laboratory of Fluid Power and Mechatronic Systems, Zhejiang University, Hangzhou 310027, China
2
School of Mechanical Engineering, Zhejiang University, Hangzhou 310027, China
*
Authors to whom correspondence should be addressed.
Submission received: 24 June 2021 / Revised: 8 September 2021 / Accepted: 10 September 2021 / Published: 24 September 2021
(This article belongs to the Section Mathematics)

Abstract

:
SPH (smoothed particle hydrodynamics) is one of the oldest meshless methods used to simulate mechanics of continuum media. Despite its great advantage over the traditional grid-based method, implementing boundary conditions in SPH is not easy and the accuracy near the boundary is low. When SPH is applied to problems for elasticity, the displacement or stress boundary conditions should be suitably handled in order to achieve fast convergence and acceptable numerical accuracy. The GFDM (generalized finite difference method) can derive explicit formulae for required partial derivatives of field variables. Hence, a SPH–GFDM coupled method is developed to overcome the disadvantage in SPH. This coupled method is applied to 2-D elastic analysis in both symmetric and asymmetric computational domains. The accuracy of this method is demonstrated by the excellent agreement with the results obtained from FEM (finite element method) regardless of the symmetry of the computational domain. When the computational domain is multiply connected, this method needs to be further improved.

1. Introduction

Smoothed particle hydrodynamics (SPH) is a Lagrangian and mesh-free technique for computational modeling of continuum systems such as solids and fluids. The SPH method, which was originally introduced by Gingold and Monaghan [1] and Lucy [2] in astrophysics, has been extended to many research fields including fluid dynamics, heat transfer, and high velocity impact problems in computational domains of various kinds.
With the increasing application of SPH to more and more engineering problems, many challenges have emerged in dealing consistently with boundary conditions. These difficulties are mainly caused by two aspects. Firstly, the shape of the boundary of the computational domain is usually complicated in practical engineering problems. Secondly, for those particles near the boundary, their support domain will be truncated. Due to these difficulties, the accuracy of the SPH approximation is reduced dramatically near the boundary and then these will have an influence on the overall accuracy of the simulation. In view of this, proper boundary treatments have been an ongoing concern for the successful implementation of the SPH method.
In the last few years, many approaches have been proposed to improve the boundary condition implementation in SPH method for fluid problems. In the existing literature, there are mainly two kinds of methods to treat the boundary conditions (namely, virtual particle methods and semi-analytical methods). The virtual particle methods consist of boundary particle force methods, the image particle method, and the dynamic particle method. The main idea of the boundary particle force method [3] is that some specified boundary particles are placed on the boundary and these particles exert repulsive forces to the inner fluid particles to prevent the fluid particles from penetrating the wall. This method is easy to implement, but unfortunately, it contains some empirical parameters which cannot be determined in advance.
In the image particle method [4], image particles are placed outside of the fluid region. These particles have the same pressure, density, and temperature as the inner fluid particles. When there is an external force acting on the fluid particles, the pressure of the image particles must be adjusted. These image particles have the same perpendicular component of the corresponding fluid particle velocity but the opposite tangential component. The image particles are generated through reflecting or mirroring the corresponding fluid particles along the wall in each time step. The disadvantage of this model is that when the boundary changes with time, it is difficult to determine how the image particle can be quickly generated and placed.
The dynamic particle method was firstly introduced by Liu [5]. In this model, the dynamic particles are introduced and fixed outside the solid boundary to approximate the field variables of the fluid particle. Hence, the accuracy is improved to some extent. In the meantime, the field variables of the dynamic particle are acquired from the governing equation of the fluid particles, such as the state equation and continuity equation. It should be pointed out that though the numerical accuracy is improved, the boundary deficiency of the dynamic particles exists, which may lead to pressure oscillations.
The main idea of the semi-analytical method is based on a so-called renormalizing factor to reestablish the governing equations for the fluid particle near the boundary. This factor depends on the location of the fluid particle relative to the fixed wall and the shape of the boundary. Kulasegaram et al. [6] once proposed a new formula to determine the renormalizing factor of the missing area of the kernel support for the particles near the boundary. This model was later improved by Ferrand [7] through solving an extra dynamic equation for the renormalizing factor. This method is more accurate but too troublesome.
For the mixed finite element method, the displacement field and stress field inside the element are represented by a node displacement vector and internal force vector. Then, the mixed model can be obtained by applying the generalized variational principle. A mixed-type finite element approximation for radiation problems using fictitious domain method written in the form of pseudo-differential operator was proposed by Nasir et al. [8], which is also efficiently applied to compute the solution of the radiation problem outside the computational domain and to compute the far-field pattern. The mixed finite element method utilizes the relatively simple interpolation function, which are also widely applied in thermodynamics [9,10], but the coefficient matrix of the simultaneous equations it derived is not positive definite, which limits the wide application of this method to a certain extent.
When SPH is applied to heat transfer problems and solid mechanics, the support domain truncation problem become harder. This is due to the fact that in these situations, the Neumann and Robin boundary conditions are almost unavoidable. Consequently, the literature on SPH application in solid mechanics is sparse.
M.A. Esmaili Sikarudi et al. [11] proposed smoothing directional derivatives method and manipulated Taylor series method when SPH was applied to heat transfer. Wenxiao Pan et al. [12] proposed a continuous boundary force (CBF) method for SPH to solve the Navier–Stokes equations subjected to the Robin boundary condition. In the CBF method, a volumetric force term is added to the momentum equation and the Robin boundary condition is replaced by the homogeneous Neumann boundary condition. Härdi, Simon, et al. [13,14] enhanced SPH by using the finite particle method to numerically solve the shallow water equations and the results agreed well with the analytical solution.
For elasticity problems, the Dirichlet boundary condition and Neumann boundary condition are commonly encountered due to the displacement and stress boundary conditions. When SPH is applied to elasticity problems, the boundary conditions must be carefully treated.
To ensure the accuracy of the numerical solution, the derivatives of the field function must be approximated as accurate as possible in region near the boundary of the computational domain. In this paper, we developed a SPH-GFDM coupled method and apply it to the analysis of 2D linear elastic problems. The numerical results are compared with commercial FEM software COMSOL to verify its accuracy. This method takes in both advantages of SPH and GFDM, which makes it a relatively more robust meshless method for solving PDEs.

2. Methodology

2.1. Basic Ideas and Differential Operators

The main idea of SPH is based on the integral interpolation. The integral representation of a field function f x can be written as:
f ( x ) = f x δ x x d x
where x = x , y , x is an auxiliary integral coordinate and δ is the Dirac delta function:
δ x x = , x = x 0 , x x
+ δ x x d x = 1
In numerical computation, usually a smooth function W , is used instead of the δ function:
f ( x ) f x W x x , h d x
where < > represents the SPH approximation operator and h represents the smoothing length of the smoothing function. The smoothing function must be normalized over its support domain:
Ω W ( x x ) d x = 1
and the commonly used smooth function are as follows:
(1) Gaussian kernel function:
W ( R , h ) = α d e R 2
where R = x x / h and α d = 1 / π 1 / 2 h , 1 / π h 2   and   1 / π 3 / 2 h 3 in one-, two-, and three-dimensional space, respectively.
(2) Cubic spline function:
W ( R , h ) = α d × 2 3 R 2 + 1 2 R 3 0 R < 1 1 6 ( 2 R ) 3 1 R < 2 0 R 2
where α d = 1 / h , 15 / 7 π h 2   and   3 / 2 π h 3 in one-, two-, and three-dimensional space, respectively.
(3) Quintic spline function:
W ( R , h ) = α d × ( 3 R ) 5 6 ( 2 R ) 5 + 15 ( 1 R ) 5 0 R < 1 ( 3 R ) 5 6 ( 2 R ) 5 1 R < 2 ( 3 R ) 5 2 R < 3 0 R 3
where α d = 120 / h , 7 / 478 π h 2 and 3 / 359 π h 3 in one-, two-, and three-dimensional space, respectively.
In SPH, the computational domain is discretized by a set of particles. Then the above integral form can be replaced by the following summation:
f ( x i ) = j = 1 N m j ρ j f x j W x i x j , h
i W i j = x i x j x i x j W i j r i j = x i x j r i j W i j r i j = x i j r i j W i j r i j
where m j and ρ j are mass and density of particles, respectively. The summation is performed over all the particles inside the support domain.
Similar to Equation (8), the first partial derivatives including gradient and divergence operators can also be expanded by SPH rules:
f x i = j = 1 N m j ρ j f x j i W i j
Unfortunately, the numerical discretization precision of above equation is poor. According to Monaghan [15], the following formula is most widely used in existing literature:
f x i = 1 ρ i j = 1 N m j f x j f x i i W i j
Discretizing the second-order derivative is also important since many PDEs in physics are of second-order. One approach is to use the Formula (4) twice [16,17,18], which involves the summation over all the particles. The other one is to employ second-order derivative of smoothing function [19], but this may result in large error for some specified problems. In order to improve the numerical accuracy of the second-order derivative in SPH, Revenga [20] proposed a flexible approach to discretize the second-order derivative and the general approximate formulas are as follows:
2 f x 2 i = j = 1 N m j ρ j 4 x i j 2 r i j 2 - 1 f i - f j 1 r i j W r
2 f y 2 i = j = 1 N m j ρ j 4 y i j 2 r i j 2 - 1 f i - f j 1 r i j W r
2 f x y i = j = 1 N m j ρ j 4 x i j y i j r i j 2 f i - f j 1 r i j W r
where x i j , y i j = x i x j , y i y j .

2.2. The Governing Equations for Two-Dimensional Elastic Problems and Their Discrete SPH Forms

For plane stress problems, the equilibrium equations are:
σ x x + τ y x y + F x = 0 , τ x y x + σ y y + F y = 0
where σ and τ are normal and shear stresses, respectively, F x and F y are body forces.
The constitutive equations are Hooke’s law:
ε x = 1 E σ x μ σ y , ε y = 1 E σ y μ σ x , γ x y = 2 ( 1 + μ ) E τ x y
and the strain-displacement relations for plane stress problem are:
ε x = u x , ε y = v y , γ x y = v x + u y
where ε is normal strain and γ are shear strain, μ and E are Poisson’s ratio and Young’s modulus, respectively.
Expressing the equilibrium equations by the displacements yields the Navier equations of plane stress problems:
E 1 μ 2 2 u x 2 + 1 μ 2 2 u y 2 + 1 + μ 2 2 v x y + F x = 0 , E 1 μ 2 2 v y 2 + 1 μ 2 2 v x 2 + 1 + μ 2 2 u x y + F y = 0
For a well-posed elasticity problem, appropriate boundary conditions must be specified to ensure a unique solution. There are typically two kinds of boundary conditions in elasticity problems.
(1) Displacement boundary conditions. For these, the displacements are given on the boundary:
u = u ¯ , v = v ¯
where u ¯ and v ¯ are the components of the prescribed displacement on the boundary.
(2) Stress boundary conditions. For these, the tractions are specified on the boundary:
t x = x ¯ , t y = Y ¯
where x ¯ and Y ¯ are the components of the surface tractions on the boundary.
According to Equations (12)–(14), the discrete SPH forms of Equation (18) are as follows:
E 1 μ 2 j = 1 N m j ρ j 4 x i j 2 r i j 2 1 u i u j 1 r i j W r + 1 μ 2 j = 1 N m j ρ j 4 y i j 2 r i j 2 1 u i u j 1 r i j W r + 1 + μ 2 j = 1 N m j ρ j 4 x i j y i j r i j 2 v i v j 1 r i j W r + F x = 0 E 1 μ 2 j = 1 N m j ρ j 4 y i j 2 r i j 2 1 v i v j 1 r i j W r + 1 μ 2 j = 1 N m j ρ j 4 x i j 2 r i j 2 1 v i v j 1 r i j W r + 1 + μ 2 j = 1 N m j ρ j 4 x i j y i j r i j 2 u i u j 1 r i j W r + F y = 0

2.3. Treatment of the Boundary Conditions

In this paper, we propose a SPH-GFDM, namely the SPH-Generalized Finite Difference Method coupled approach to deal with the boundary condition implementation difficulties when SPH is applied to elasticity problems.
The generalized finite difference method (GFDM) is another meshless collocation method. It was first proposed by Liszka et al. [21,22], later improved and extended by many other authors [23,24,25,26]. Before this study, this method has been successfully applied to heat transfer, elastic analysis and other engineering problems [27,28,29,30,31,32,33,34]. The main idea of the method is to combine the moving-least squares (MLS) approximation and the Taylor series expansion to derive explicit formulae for the required partial derivatives of unknown field variables. Without loss of generality, let us consider the following second-order linear differential equation in 2D domain:
a 1 U x + a 2 U y + a 3 2 U x 2 + a 4 2 U y 2 + a 5 2 U x y = f ( x , y )
where f x , y is a known function, U x , y is the field function, a i i = 1 , 2 , 3 , 4 , 5 is the coefficient, and a i is usually a given function or constant.
To obtain the explicit GFDM formulae for partial derivatives in a given differential equation and boundary conditions, a regular or irregular set of nodes is scattered in the computational domain and on the boundary. For a specified node x 0 , y 0 , namely the central node, N nearest nodes x i , y i i = 1 , 2 , , N , called supporting nodes or neighbors, will be identified within a prescribed region (usually a circle with a given radius) to form the support domain. It is similar to the concept of support domain in SPH. Every node inside the computational domain and on the boundary has an associated support domain.
Let U 0 be the value of the field function at the central node x 0 , y 0 and U i i = 1 , 2 , , N are field function values at the rest of the nodes inside the support domain. Expanding the field function value U i around the central node x 0 , y 0 using Taylor series expansion, we will get:
U i = U 0 + h i U 0 x + k i U 0 y + h i 2 2 2 U 0 x 2 + k i 2 2 2 U 0 y 2 + h i k i 2 U 0 x y + , i = 1 , 2 , , N
where h i = x i x 0 , k i = y i y 0 .
By truncating the Taylor series after the second-order derivatives (this depends on the partial differential equation being solved. For example, if the PDE is of forth-order, the Taylor series should be truncated after the forth-order derivatives), we then define the following residual function B(U):
B U = i = 1 N U 0 U i + h i U 0 x + k i U 0 y + h i 2 2 2 U 0 x 2 + k i 2 2 2 U 0 y 2 + h i k i 2 U 0 x y ω i 2
where ω i = ω ( h i , k i ) are the weighting coefficients at point x i , y i with respect to the central node and the weighting coefficients are usually taken to be:
ω i = 1 6 S 2 + 8 S 3 3 S 4 , d i d m
where d i = h i 2 + k i 2 is the distance between points x 0 , y 0 and x i , y i , and d m is the radius of the support domain of the selected node, S = d i / d m . The weighting coefficients are smaller for the nodes far away from the central node within the support domain than those nearby. Other choices of weighting functions are also possible, and the reader can find them in Refs [7,9].
For brevity, we define:
D U = U 0 x , U 0 y , 2 U 0 x 2 , 2 U 0 y 2 , 2 U 0 x y T p i = h i , k i , h i 2 / 2 , k i 2 / 2 , h i k i , i = 1 , 2 , , N P = p 1 , p 2 , , p N T
Then the residual function B U can be written in the following matrix form:
B ( U ) = P D U + U 0 U T W P D U + U 0 U
where
U = U 1 , U 2 , , U N T , U 0 = U 0 , U 0 , , U 0 T , W = diag ω 1 2 , ω 2 2 , , ω N 2
By minimizing B U with respect to the partial derivatives D U :
B U / D U = 0
the following linear equation system will be obtained for node x i , y i in the domain:
A D U = b
where
A = P T W P
and
b = P T W U U 0
According to above equations, the partial derivative vector D U can be expressed as:
D U = A - 1 b = A - 1 P T W U - U 0
For the central node x 0 , y 0 in the computational domain, the partial derivatives of the unknown field function can be approximated by a linear combination of field function values at its neighboring nodes within the support domain. Substituting Equation (33) Into the Governing Equation (22) leads to:
m 0 U 0 + i = 1 N m i U i f x 0 , y 0 = 0
where the coefficients m 0 and m i i = 1 , 2 , , N can be acquired from Equation (22). For all nodes within the computational domain, we repeat the same steps and a system of linear equations can be established. By solving this equation system, we will get the numerical results of the field function U at each node within the computational domain.
Taking advantage of both SPH and GFDM, we propose a SPH-GFDM coupled method to solve PDEs. The main steps of our SPH-GFDM coupled method are as follows:
(1) Discretize the entire computational domain by a set of arbitrarily distributed nodes inside the domain and on the boundaries. The nodes distribution should be as regular as possible.
(2) For the nodes far away from the boundaries whose support domain are complete, the SPH discretization form is accurate enough. SPH will thus be adopted. As for the nodes near and on the boundaries, their support domains are truncated by the boundary. Hence, the GFDM approximation will be used to discretize the governing equation and implement the boundary conditions. Then, every node inside the computational domain and on the boundaries will correspond to an algebraic equation. This results in a large-scale system of linear equations.
(3) Solve the system of linear algebraic equations and we will get the numerical solutions of the problem on all discrete nodes.
It is necessary to note that, however, the approach this paper proposed is based on the condition that the forces in the calculation domain reach an equilibrium state, and the equations are also deduced on this basis. For the transient problems, the smoothed particles in the calculation domain are motioning at an accelerated speed, which is another case for further study.

3. Results and Discussion

In order to verify the accuracy of GFDM-SPH coupled method proposed in the previous section, two benchmark test examples are examined for both symmetric and asymmetric computational domains. The numerical solutions are compared with those obtained by a commercial FEM code (COMSOL), in which a high-quality mesh (small skewness and proper aspect ratio) is adopted to ensure the accuracy of the numerical results. A mesh convergence study was conducted to ensure the results did not vary with mesh size.

3.1. A Rectangular Metal Plate with Two Ends Fixed under Prescribed Uniform Loads

As shown in Figure 1a, a 4 m × 1 m rectangular plate whose two ends are fixed is present, its upper and lower sides are under a uniformly distributed load q = 50 N/m. The material constants are ρ = 7800 kg/m3, E = 80 GPa and μ = 0.32, respectively. This is a mixed-boundary problem; the upper and lower sides of the plate are prescribed for Neumann boundary conditions and the left and right sides of it are assigned with Dirichlet boundary conditions. As shown in Figure 1d, the blue points in the inner region represent the nodes in which the governing equations are discretized by SPH, and the red points near and on the boundary are those in which the governing equations and boundary conditions are discretized by GFDM. Figure 1b shows the location of the sample point P(1.0, 0.5) and line AB and Figure 1c is the mesh generated by COMSOL.
Figure 2 shows the contours of stress and displacement obtained by FEM. Figure 3 shows those by SPH-GFDM. Figure 4 shows the y-direction displacement v and x-direction displacement u on line AB obtained by SPH-GFDM and FEM. Table 1 displays the absolute value of the maximum displacement in x and y-direction given by SPH-GFDM and FEM and Table 2 shows the stress values in sample point P obtained by these two methods.
As show in these figures and tables, the numerical results of the displacement field and stress field obtained by the SPH-GFDM coupled method in this simple case are accurate compared to the results obtained by FEM of a high-quality mesh. The maximum relative errors are not more than 3%.

3.2. A L-Shape Plate with Two Ends Fixed under Prescribed Uniform Loads

As shown in Figure 5a, a L-shape plate whose left and upper ends are fixed is present, its right and lower sides are under a uniformly distributed load q = 50 N/m. The material constants are ρ = 7800 kg/m3, E = 80 GPa and μ = 0.32, respectively. As shown in Figure 5d, the blue points in the inner region represent the nodes in which the governing equations are discretized by SPH, and the red points near and on the boundary are those in which the governing equations and boundary conditions are discretized by GFDM. Figure 5b shows the location of the sample points A(0.0, 1.0), B(4.0, 1.0), P1(2.0, 1.8), P2(2.2, 1.8), P3(2.2, 2.0) and line AB and Figure 5c is the mesh generated by COMSOL.
Figure 6 shows the contours of stress and displacement obtained by FEM. Figure 7 shows those by SPH-GFDM. Figure 8 shows the y-direction displacement u and x-direction displacement v on line AB obtained by SPH-GFDM and FEM. Table 3 displays the absolute value of the maximum displacement in x and y-direction given by SPH-GFDM and FEM and Table 4, Table 5 and Table 6 show the stress values in sample points P1, P2, and P3 obtained by these two methods.
As the figures and data in the tables illustrated, for L-shape plate, the y-direction displacement u and x-direction displacement v on line AB and the normal stress at sample points P1, P2, and P3 obtained by SPH-GFDM match well with the results obtained by FEM, within the maximum relative error at 5.8%. However, the deviation of shear stresses and Von-Mises stresses obtained by these two methods can reach 16.1%, probably due to the asymmetry of this L-shape plate, which will be further analyzed in the later section.

3.3. A Square Plate with A Hole in the Center Whose Left Side Is Fixed and the Right Side Is under Uniform Normal Loads

As shown in Figure 9a, a 4 m × 4 m square plate with a 1 m × 1 m hole in the center is under a uniform loads q = 50 N/m on its right side, its left side is totally fixed and the surface of the inner hole is free. The material constants are ρ = 7800 kg/m3, E = 80 GPa and μ = 0.32, respectively. For simplicity, the influence of the gravity is neglected and the distribution of scattered nodes is shown in Figure 9d. The blue points in the inner region represent the nodes in which the governing equations are discretized by SPH. The red points near the boundary are those in which the governing equations. and boundary conditions are discretized by GFDM. Figure 9b shows the location of the sample points A(2, 3.25) and B(0.75, 2) and Figure 9c is the mesh generated by COMSOL.
Compared with the previous test examples, this problem is relatively more complex. The computational domain of this problem is a multiple connected region. The left side of the plate is fixed, which is a Dirichlet boundary condition. The other sides of the plate are assigned with Neumann boundary conditions, including the free boundaries on which the tractions are zero.
Figure 10a–f are the contours of stress and displacement obtained by FEM and Figure 11a–f are those given by SPH-GFDM. Table 7 shows the absolute value of the maximum displacement in x and y-direction given by SPH-GFDM and FEM. Table 8 and Table 9 shows the stress values in sample points A and B obtained by SPH-CFDM and FEM, respectively. Roughly speaking, the numerical results obtained by the SPH-GFDM method are similar to those given by FEM with a high-quality mesh, as shown in Figure 2, Figure 3, Figure 6, Figure 7, Figure 10, and Figure 11. But there still exist some differences: the maximum x-direction displacement given by SPH-GFDM is relatively smaller than that given by COMSOL, and the y-direction normal stress near the left side of the square hole obtained by SPH-GFDM is also smaller than that given by FEM. The possible reasons for this may result from two aspects: Firstly, there exist stress singularities in this example. Theoretically speaking, when the plastic behaviors of the material are not considered here, the stress values in the four corner points of the inner square hole are infinite. Secondly, the numerical results given by COMSOL (a FEM-based software) are ‘weak’ solutions and those obtained by SPH-GFDM are ‘strong’ solutions. As we know, FEM does not directly discretize the governing equation and the boundary conditions. Instead, it depends on the equivalent integral weak forms of the problem. However, both SPH and GFDM are meshless direct collocation methods and in SPH-GFDM coupled method. We discretize the partial derivatives in the governing equation and the boundary conditions by a linear combination of the field function values of the nodes within the support domain. For elastic problems, the ‘weak’ solutions are usually more stable and accurate than the ‘strong’ solutions. These two reasons may result in the differences.

4. Conclusions

In this study, we demonstrate the applicability of the SPH–GFDM coupled method for the analysis of 2-D elastic problems. The main idea of this method is to numerically solve PDEs with prescribed boundary conditions. The partial derivatives of the field functions at nodes within the interior region of the computational domain and near the boundary are discretized by the SPH and GFDM approximations, respectively. Results are obtained by solving the combined algebra equations associated with the two approximations. Due to the least square essence of GFDM, Dirichlet and Neumann boundary conditions in GFDM can be easily implemented with relatively high accuracy. This improves the overall numerical accuracy of the SPH-GFDM coupled method. Two benchmark examples of both symmetric and asymmetric computational domains are given to verify the stability and accuracy of the SPH-GFDM coupled method. It is demonstrated that, as the results and comparisons show, this method behaves as reliable as FEM with high-quality meshes in some simple cases in which the computational domains are simply connected, which means better computational efficiency and less time consuming. Yet, considering to the relatively high deviation of shear stresses and Von-Mises stresses obtained by SPH-GFDM and FEM in some cases, the proposed method still needs to be improved, especially when applied to the case where the computational domains are multiply connected and the boundary shapes are more complex.

Author Contributions

Z.T., Z.P., and Y.Y.: Conceptualization, methodology, writing; Z.T., Z.P., Y.Y., and Z.C.: writing—reviewing and editing. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by the National Key R&D Program of China (2019YFB2004604), Natural Science Foundation of China (52075481), and the Zhejiang Provincial Natural Science Foundation (LR19E050002).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Gingold, R.A.; Monaghan, J.J. Smoothed particle hydrodynamics: Theory and application to non-spherical stars. Mon. Not. R. Astron. Soc. 1977, 181, 375–389. [Google Scholar] [CrossRef]
  2. Lucy, L. A numerical approach to the testing of the fission hypothesis. Astron. J. 1977, 82, 1013–1024. [Google Scholar] [CrossRef]
  3. Monaghan, J.J. Simulating free surface flows with SPH. Comput Phys. 1994, 110, 399–406. [Google Scholar] [CrossRef]
  4. Bierbrauer, F.; Bollada, P.C.; Phillips, T.N. A consistent reflected image particle approach to the treatment of boundary conditions in smoothed particle hydrodynamics. Comput. Methods Appl. Mech. Eng. 2009, 198, 3400–3410. [Google Scholar] [CrossRef]
  5. Liu, M.; Shao, J.; Chang, J. On the treatment of solid boundary in smoothed particle hydrodynamics. Sci. China 2012, 1, 248–258. [Google Scholar] [CrossRef]
  6. Kulasegaram, S.; Bonet, J.; Lewis, R.W.; Profit, M.A. variational formulation based contact algorithm for rigid boundaries in two-dimensional SPH applications. Comput. Mech. 2004, 33, 316–325. [Google Scholar] [CrossRef]
  7. Ferrand, M.; Laurence, D.R.; Rogers, B.D.; Violeau, D.; Kassiotis, C. Unified semi-analytical wall boundary conditions for inviscid, laminar or turbulent flows in the meshless SPH method. Int. J. Numer. Methods Fluids 2013, 71, 446–472. [Google Scholar] [CrossRef] [Green Version]
  8. Nasir, H.M.; Kako, T.; Koyama, D. A mixed-type finite element approximation for radiation problems using fictitious domain method. Comput. Appl. Math. 2003, 152, 377–392. [Google Scholar] [CrossRef] [Green Version]
  9. Fülöp, T.; Kovács, R.; Szücs, M.; Fawaier, M. Thermodynamical Extension of a Symplectic Numerical Scheme with Half Space and Time Shifts Demonstrated on Rheological Waves in Solids. Entropy 2020, 22, 155. [Google Scholar] [CrossRef] [Green Version]
  10. Pozsár, Á.; Szücs, M.; Kovács, R.; Fülöp, T. Four Spacetime Dimensional Simulation of Rheological Waves in Solids and the Merits of Thermodynamics. Entropy 2020, 22, 1376. [Google Scholar] [CrossRef]
  11. Sikarudi, M.E.; Nikseresht, A.H. Neumann and Robin boundary conditions for heat conduction modeling using smoothed particle hydrodynamics. Comput. Phys. Commun. 2016, 198, 1–11. [Google Scholar] [CrossRef]
  12. Pan, W.; Bao, J.; Tartakovsky, A.M. Smoothed particle hydrodynamics continuous boundary force method for Navier–Stokes equations subject to a Robin boundary condition. J. Comput. Phys. 2014, 259, 242–259. [Google Scholar] [CrossRef]
  13. Härdi, S.; Schreiner, M.; Janoske, U. Enhancing smoothed particle hydrodynamics for shallow water equations on small scales by using the finite particle method. Comput. Methods Appl. Mech. Eng. 2019, 344, 360–375. [Google Scholar] [CrossRef]
  14. Härdi, S.; Schreiner, M.; Janoske, U. Simulating thin film flow using the shallow water equations and smoothed particle hydrodynamics. Comput. Methods Appl. Mech. Eng. 2020, 358, 112639. [Google Scholar] [CrossRef]
  15. Monaghan, J.J. Smoothed particle hydrodynamics. Annu. Rev. Astron. Astrophys. 1992, 30, 543–574. [Google Scholar] [CrossRef]
  16. Jin, H.B.; Ding, X. On criterions for smoothed particle hydrodynamics kernels in stable field. Comput. Phys. 2005, 202, 699–709. [Google Scholar]
  17. Flebbe, O.; Muenzel, S.; Herold, H.; Riffert, H.; Ruder, H. Smoothed particle hydrodynamics: Physical viscosity and the simulation of accretion disks. Astrophys. J. 1994, 431, 754–760. [Google Scholar] [CrossRef]
  18. Watkins, S.J.; Bhattal, A.S.; Francis, N.; Turner, J.A.; Whitworth, A.P. A new prescription for viscosity in smoothed particle hydrodynamics. Astron. Astrophys. Suppl. Ser. 1996, 119, 177–187. [Google Scholar] [CrossRef]
  19. Takeda, H.; Miyama, S.M.; Sekiya, M. Numerical simulation of viscous flow by smoothed particle hydrodynamics. Prog. Theor. Phys. 1994, 92, 939–960. [Google Scholar] [CrossRef]
  20. Espanol, P.; Revenga, M. Smoothed dissipative particle dynamics. Phys. Rev. E 2003, 67, 126–140. [Google Scholar] [CrossRef] [PubMed]
  21. Liszka, T. An interpolation method for an irregular net of nodes. Int. J. Numer. Methods Eng. 1984, 20, 1599–1612. [Google Scholar] [CrossRef]
  22. Liszka, T.; Orkisz, J. The finite difference method at arbitrary irregular grids and its application in applied mechanics. Comput. Struct. 1980, 11, 83–95. [Google Scholar] [CrossRef]
  23. Payre, G.M.J. Influence graphs and the generalized finite difference method. Comput. Methods Appl. Mech. Eng. 2007, 196, 1933–1945. [Google Scholar] [CrossRef]
  24. Benito, J.J.; Urena, F.; Gavete, L. Influence of several factors in the generalized finite difference method. Appl. Math. Model. 2001, 25, 1039–1053. [Google Scholar] [CrossRef]
  25. Benito, J.J.; Urena, F.; Gavete, L.; Alvarez, R. An h-adaptive method in the generalized finite differences. Comput. Methods Appl. Mech. Eng. 2003, 192, 735–759. [Google Scholar] [CrossRef]
  26. Gavete, L.; Gavete, M.L.; Benito, J.J. Improvements of generalized finite difference method and comparison with other meshless method. Appl. Math. Model. 2003, 27, 831–847. [Google Scholar] [CrossRef] [Green Version]
  27. Gu, Y.; Qu, W.; Chen, W.; Song, L.; Zhang, C. The generalized finite difference method for long-time dynamic modeling of three-dimensional coupled thermoelasticity problems. J. Comput. Phys. 2019, 384, 42–59. [Google Scholar] [CrossRef]
  28. Gu, Y.; Hua, Q.; Zhang, C.; He, X. The generalized finite difference method for long-time transient heat conduction in 3D anisotropic composite materials. Appl. Math. Model. 2019, 71, 316–330. [Google Scholar] [CrossRef]
  29. Wang, Y.; Gu, Y.; Fan, C.; Chen, W.; Zhang, C. Domain-decomposition generalized finite difference method for stress analysis in multi-layered elastic materials. Eng. Anal. Bound. Elem. 2018, 94, 94–102. [Google Scholar] [CrossRef]
  30. Chen, J.; Gu, Y.; Wang, M.; Chen, W.; Liu, L. Application of the generalized finite difference method to three-dimensional transient electromagnetic problems. Eng. Anal. Bound. Elem. 2018, 92, 257–266. [Google Scholar] [CrossRef]
  31. Li, Y.; Tong, Z. Development of real-time adaptive model-free extremum seeking control for CFD-simulated thermal environment. Sustain. Cities Soc. 2021, 70, 102903. [Google Scholar]
  32. Chen, Z.; Jiang, Y.; Tong, Z.; Tong, S. Residual Stress Distribution Design for Gear Surfaces Based on Genetic Algorithm Optimization. Materials 2021, 14, 366. [Google Scholar] [CrossRef]
  33. Tong., Z.; Miao, J.; Tong, S.; Lu, Y. Early prediction of remaining useful life for Lithium-ion batteries based on a hybrid machine learning method. J. Clean. Prod. 2021, 317, 128265. [Google Scholar] [CrossRef]
  34. Tong, Z.; Xin, J.; Ling, C. Many-Objective Hybrid Optimization Method for Impeller Profile Design of Low Specific Speed Centrifugal Pump in District Energy Systems. Sustainability 2021, 13, 10537. [Google Scholar]
Figure 1. (a) Schematic of the problem and the loads. (b) The location of the sample point P and line AB. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Figure 1. (a) Schematic of the problem and the loads. (b) The location of the sample point P and line AB. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Symmetry 13 01774 g001
Figure 2. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Figure 2. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g002
Figure 3. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Figure 3. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g003
Figure 4. (a) The distribution of x–direction displacement u in line AB (Unit: m). (b) The distribution of y–direction displacement v in line AB (Unit: m).
Figure 4. (a) The distribution of x–direction displacement u in line AB (Unit: m). (b) The distribution of y–direction displacement v in line AB (Unit: m).
Symmetry 13 01774 g004
Figure 5. (a) Schematic of the problem and the loads. (b) The location of the sample points and line AB. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Figure 5. (a) Schematic of the problem and the loads. (b) The location of the sample points and line AB. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Symmetry 13 01774 g005
Figure 6. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Figure 6. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g006
Figure 7. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Figure 7. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g007
Figure 8. (a) The distribution of x–direction displacement u in line AB (Unit: m). (b) The distribution of y–direction displacement v in line AB (Unit: m).
Figure 8. (a) The distribution of x–direction displacement u in line AB (Unit: m). (b) The distribution of y–direction displacement v in line AB (Unit: m).
Symmetry 13 01774 g008
Figure 9. (a) Schematic of the problem and the load. (b) The location of the sample points A and B. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Figure 9. (a) Schematic of the problem and the load. (b) The location of the sample points A and B. (c) The mesh generated by COMSOL. (d) The distribution of the nodes.
Symmetry 13 01774 g009
Figure 10. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τx. (f) The Von-Mises stress σSig_eq.
Figure 10. The contours of stress and displacement obtained by FEM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τx. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g010
Figure 11. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Figure 11. The contours of stress and displacement obtained by SPH-GFDM. (a) The x–direction displacement u. (b) The y–direction displacement v. (c) The x–direction normal stress σx. (d) The y–direction normal stress σy. (e) The shear stress τxy. (f) The Von-Mises stress σSig_eq.
Symmetry 13 01774 g011
Table 1. The x and y-direction maximum displacements (Unit: m).
Table 1. The x and y-direction maximum displacements (Unit: m).
SPH-GFDMFEM
u m a x 4.08 × 10−94.12 × 10−9
v m a x 1.75 × 10−81.76 × 10−8
Table 2. The stress values in sample point P (Unit: Pa).
Table 2. The stress values in sample point P (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM2.28 × 10−67.30 × 10−7−148.82257.76
FEM0.000.00−149.45263.76
Table 3. The x and y-direction maximum displacements (Unit: m).
Table 3. The x and y-direction maximum displacements (Unit: m).
SPH-GFDMFEM
u m a x 2.20 × 10−92.21 × 10−9
v m a x 2.20 × 10−92.21 × 10−9
Table 4. The stress values in sample point P1 (Unit: Pa).
Table 4. The stress values in sample point P1 (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM40.2837.4116.2348.28
FEM42.7737.0818.2551.16
Table 5. The stress values in sample point P2 (Unit: Pa).
Table 5. The stress values in sample point P2 (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM43.2543.259.9345.17
FEM42.4642.4411.8347.14
Table 6. The stress values in sample point P3 (Unit: Pa).
Table 6. The stress values in sample point P3 (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM37.4140.2816.2348.28
FEM37.0742.7418.1751.06
Table 7. The x and y-direction maximum displacements (Unit: m).
Table 7. The x and y-direction maximum displacements (Unit: m).
SPH-GFDMFEM
u m a x 3.26 × 10−93.32 × 10−9
v m a x 6.33 × 10−106.34 × 10−10
Table 8. The stress values in sample point A (Unit: Pa).
Table 8. The stress values in sample point A (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM−62.57−4.212.5760.25
FEM−63.29−4.322.7661.43
Table 9. The stress values in sample point B (Unit: Pa).
Table 9. The stress values in sample point B (Unit: Pa).
σxσyτxyσSig_eq
SPH-GFDM−21.68−9.800.0018.41
FEM−22.81−10.000.0019.80
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Tong, Z.; Peng, Z.; Yue, Y.; Chen, Z. A SPH-GFDM Coupled Method for Elasticity Analysis. Symmetry 2021, 13, 1774. https://0-doi-org.brum.beds.ac.uk/10.3390/sym13101774

AMA Style

Tong Z, Peng Z, Yue Y, Chen Z. A SPH-GFDM Coupled Method for Elasticity Analysis. Symmetry. 2021; 13(10):1774. https://0-doi-org.brum.beds.ac.uk/10.3390/sym13101774

Chicago/Turabian Style

Tong, Zheming, Zezhao Peng, Yuqing Yue, and Zhou Chen. 2021. "A SPH-GFDM Coupled Method for Elasticity Analysis" Symmetry 13, no. 10: 1774. https://0-doi-org.brum.beds.ac.uk/10.3390/sym13101774

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop