Abstract
The transition from the geometry to the mesh can be rather difficult, manual and time-consuming, especially for the large scale complex structures. The procedure of mesh generation needs massive human intervention making the automatic engineering analyses of structures from CAD geometry models hardly possible. This paper focuses on implementing a polyhedron element with arbitrary convex topology based on the Scaled Boundary Finite Element Method (SBFEM) in ABAQUS on the strength of the interface of UEL (the subroutine to define a general user-defined element) for automatic dynamic analyses of three-dimensional structures. This implementation empowers ABAQUS to analyze any model with arbitrary polyhedron elements. When the geometry of a structure is obtained from CAD, the dynamic analyses can be launched seamlessly and automatically. Cases of a cantilever subjected to a dynamic harmonic excitation with the traditional hexahedron element and this polyhedron element are compared to verify the accuracy of the UEL. Taking a practical example of the Soil-Structure Interaction analysis of a Nuclear Power Plant, the applicability and performance of this implementation are tested. The results of the two examples confirm that this polyhedron element based on SBFEM can be more accurate using much less degrees of freedom and its implementation in ABAQUS is robust and compatible.
Subject terms: Engineering, Civil engineering
Introduction
As the development of the Computer Aided Design (CAD) and Computer Aided Engineering (CAE) tools in the industry, the design, safety assessment, health monitoring of some important modern infrastructures tend to need more and more refined and sophisticated geometry models and mesh models. Nevertheless, there is a gap between the CAD and the CAE holding a barrier between the geometry model for design and the mesh model for engineering analysis. Because except for some rarely used meshless methods, it is a difficult, manual and time-consuming process to generate a fine mesh from a complex geometry. During the manual mesh generation, the balance of accuracy and efficiency should be examined, especially for dynamic analysis in the time domain. A basic requirement is to assign heterogeneous distributed grid densities for the different location of the geometry model to balance the calculation accuracy and efficiency, which are case-sensitive, completely experimental and can be rather tedious. The automatic mesh generation technique with polyhedron elements can break this barrier due to the flexible topology that makes them highly adaptable to the complex shape and smooth transition of mesh density, which is the foundation of the automatic engineering analysis.
Since the arising of numerical methods for the Partial Differential Equation (PDE), the mesh generation has become a primary procedure for these methods that need spatial discretization like the Finite Element Method (FEM) and the Finite Difference Method (FDM). From a geometrical point of view, a mesh is the approximate shape representation of the domains or the media (or can be collectively referred to as configurations) of the original physical problem, which consists of many non-overlapping continuous small domains called elements. These elements have certain topology defined by geometric feature points such as vertices called nodes, where the degrees of freedom are defined on. Except that a numerical analysis cannot be carried on without a mesh, the quality, size and type of the mesh have a great influence on the reliability of the results as well.
For the last four decades, lots of mesh generation technologies have been developed from two-dimension (2D) domain to three-dimension (3D) domain on the strength of the computer graphics. During the 1950s, mesh generation techniques based on coordinate transformations firstly came up, such as the conformal mapping1,2 technique. This technique was extended to simple 3D configurations by South et al.3 and Baker4. Although the methods above can generate structured hexahedral or quadrilateral meshes with high quality, the process of these methods requires lots of time, manual guidance and very specific geometry. In the 1980s, triangulation methods emerged generating unstructured triangular meshes for 2D configurations or tetrahedral meshes for 3D configurations. After the generation of a triangulation mesh, an unstructured hexahedral mesh can be obtained by the domain partition5–8. Unstructured meshes can always be created by triangulation methods for any intricate geometry automatically and efficiently. But these kinds of meshes have low accuracy and additional artificial stiffness, especially the first order ones. On the other hand, for a same domain the degrees of freedom of a triangulation mesh are much more than those of a hexahedral or quadrilateral mesh. If the mesh requirement of conforming the boundary is omitted, the Cartesian methods can automatically generate octree meshes that contain particular polyhedron elements without creating surface meshes. But the mesh created by this method has a poor accuracy on boundary vicinity leading to an inaccurate boundary condition. At the moment, for complex geometries only the polyhedron mesh generation technique can be fully automatic with few human interventions.
Polyhedron meshes such as octree meshes have been widely used in fluid mechanics exhibiting many topological properties that make them highly and automatically adaptable to the complex shape and smooth transition of mesh density9,10. Nevertheless, the application of polyhedron elements for continuum mechanics is few because the topology of a polyhedron is inconstant. Hence it is impossible to construct analytic shape functions for arbitrary polyhedron elements with varying topologies. Some kind of interpolation schemes must be applied. Two kinds of interpolation schemes were developed. The first one was based on natural neighbor interpolations proposed by Sibson11,12. Traversoni13 and Sambridge et al.14 introduced Sibson interpolations modified by Watson15 to the Galerkin-type natural neighbor, which was extended to continuum by Sukumar et al.16,17. Belikov et al. raised the Laplacian and non-Sibson interpolants18,19 and the polygonal finite element interpolants20,21. The other one was built on generalized barycentric coordinates, which was brought up by Wachspress22. This kind of interpolants was further developed by Warren23,24, Meyer et al.25, Floater et al.26,27, Lipman28, and Warren et al.29. However, the interpolation scheme generally needs considerable calculation to get adequate accuracy.
Another approach to constructing polyhedral elements is to utilize SBFEM. In mid-1990s, SBFEM also known as the consistent infinitesimal finite-element-cell method was bought up by Wolf and Song as an extension to FEM to simulate the wave propagation in the unbounded domain30–33. As a similarity-based semi-analytical numerical approach for PDE, SBFEM has many advantages over the traditional FEM and Boundary Element Method (BEM) exhibiting high accuracy and flexibility34,35. SBFEM just needs boundary discretization reducing the problem spatial dimension by one with no need for a fundamental solution and the solution along the radial direction is in a precise closed-form. For the unbounded media, SBFEM can perfectly satisfy the boundary condition of the radiation damping. The unit-impulse response matrix in the time domain and the dynamic-stiffness matrix in the frequency domain of the unbounded media can be directly obtained, which is equivalent to a time and space coupling artificial non-reflecting boundary36. For the bounded media, the SBFEM is derived in a wedge media. The wedge media can be assembled into an arbitrary convex polyhedron (3D) or polygon (2D) super element revolving around the similarity center. If this assembly is not occlusive and the crack tip is positioned in the similarity center, the singularity of the field function can be directly described by the analytical solution along the radical crack surface. This superiority of mesh adaptability can be combined with the automatic mesh generation technique based on polyhedron elements.
The first try was a SBFEM formulation for arbitrary polyhedral elements and a simple method to generate polyhedral meshes based on octree presented by Talebi et al.37. To automatically generate an octree polyhedral mesh from the Standard Tessellation Language (STL) widely used in the 3D printing and Computer Aided Design (CAD), Liu et al.38 came up with a two-steps method. The first step is to generate an octree mesh within the domain enclosed by the surface defined in the STL. The second step is to cut the polyhedral elements with the surface. After the refinement of the second step, the poor boundary accuracy of the octree mesh is improved. Furthermore, Zhang et al.39 applied the SBFEM polyhedral elements to the non-matching meshes by adding nodes to the elements adjacent to the interface. By now, there is a slight limitation when using SBFEM polyhedral elements. Since the boundary is discretized by FEM elements, the facets of a polyhedral element must be a triangle or quadrilateral, which may lead to a facet division process. To resolve this limitation of SBFEM, Ooi et al.40 derived a dual SBFEM formulation over arbitrary faceted star convex polyhedron. On the other hand, Zou et al.41 brought up a FEM polyhedral element formulation with shape functions derived from SBFEM circumventing this limitation as well. The automatic polyhedral element based on SBFEM was applied to dynamic nonlinear analysis of hydraulic engineering42, concrete fracture modelling43, damage modelling44,45, Soil-Structure Interaction (SSI) analysis of NPP46, etc. These applications of SBFEM polyhedral meshes were mostly implemented by self-developed programs. Few of them integrate the SBFEM into the universal FEM software such as ABAQUS43,47. And these integrations is suitable for traditional FEM elements with fixed topologies only. The integration of SBFEM and the universal FEM software can promote each other. Implementation of arbitrary polyhedral elements in ABAQUS is still in need.
In this paper, arbitrary polyhedron elements based on SBFEM for three dimensional continuum is developed and implemented in ABAQUS facilitating automatic dynamic analyses of structures. The governing equation of the bounded 3D elastic continuum in a polyhedron domain is derived from the SBFEM in “SBFEM governing equation for the elastic continuum” section. The FEM-coupled characteristic matrix of a polyhedron element can be obtained from the solution of the governing equation. The topology feature and corresponding data structure of a polyhedron is analyzed in “Topology and data structure of an arbitrary polyhedron element” section. The user element subroutine of UEL is developed associated with the Hilber-Hughes-Taylor (HHT) implicit time integration scheme in “Implementation in ABAQUS’ section. In “Numerical application” section, there are two examples for the UEL. A cantilever subjected to a harmonic excitation with the traditional hexahedron element and the SBFEM-based polyhedron element are compared to confirm the accuracy of the UEL. Then taking a practical example of the soil-structure dynamic interaction analysis of a nuclear power plant, the applicability and performance of this implementation of polyhedron elements is tested.
SBFEM governing equation for the elastic continuum
SBFEM is a numerical method for solving PDE. The PDE is transformed into ordinary differential equations after specific spatial discretization, which is different from FEM, BEM, etc. SBFEM needs boundary discretization only decreasing the spatial dimension by 1 and remains analytical in the radial direction without the need of a foundation solution. The derivation of the SBFEM governing equation of elastic continuum is based on a wedge area defined as W-element. The governing equations of W-elements that shared the same scaling center can be assembled by degrees of freedom of adjacent W-elements (see Fig. 1) leading to a piece-wise boundary of the discretized domain defined as an S-element. The choice of the scaling center location can be pretty casual. The boundary of the discretized domain must be visible from the scaling center is the only geometry requirement that needs to be satisfied. The bounded domain can be divided into multiple S-elements to meet the requirement of the scaling center or to improve the poor geometry of W-elements (see Fig. 2). Apparently, the geometry of the S-element can be rather flexible for any convex polyhedron with only triangle or quadrilateral facets.
Figure 1.
Spatial discretization of SBFEM for (a) S-element in bounded domain, (b) S-element in unbounded domain.
Figure 2.

Bounded domain divided by three S-elements.
The detailed derivation of SBFEM governing equation is well documented in many literatures33,48–52. For the sake of integrity, only key equations are given below. The equations in this section are given in linear algebraic notation for the convenience of reading and programming. The brace symbol of denotes a matrix and the bracket symbol of denotes a column vector.
Partial differential equations of dynamic elastic mechanics
According to the theory of continuum mechanics, three basic equations are derived as
| 1 |
| 2 |
| 3 |
where denotes the spatial partial derivative operator, denotes the stress vector, denotes the strain vector, denotes the body forces that include the inertial force for the dynamic analysis. The detailed definitions of them are
| 4 |
| 5 |
| 6 |
The equilibrium equations (Eq. (1)), the geometric equations (Eq. (2)) and the constitutive equations (Eq. (3)) can be combined into one set of partial differential equations of 3D dynamic elastic mechanics with the displacement vector filed as the unknown variable as
| 7 |
where denotes the displacement vector filed, denotes the material property matrix, denotes the body forces except the d'Alembert inertial force, denotes the density, denotes the spatial partial derivative operator.
The linear elastic material property matrix is given by
| 8 |
where denotes the Lame parameter, denotes the Young’s modulus, denotes the shear modulus, denotes the Poisson’s ratio.
Equation (7) represents a set of second order linear nonhomogeneous partial differential equations with constant coefficients in Cartesian coordinate, namely Navier equations. One way to solve the Navier equations analytically is to transform them into wave equations of potential functions by Helmholtz’s theorem. The other way is to solve the Navier equations numerically by spatial and time discretization.
Two kinds of boundary conditions and one initial condition should be introduced to get the definite solution of the fundamental equation Eq. (7). One boundary condition is the geometry boundary condition on the surface defined as
| 9 |
where is the constant displacement on the surface of
The other one is the surface traction boundary condition on the surface defined as
| 10 |
| 11 |
| 12 |
where is the constant surface traction force per area on , is the orientation cosine matrix, , , and are the orientation cosine of the outer normal vector of the surface .
The initial condition can be defined as
| 13 |
| 14 |
where is the constant displacement of the domain when , is the constant velocity of the domain when .
Coordinate mapping based on scaled boundary transformation
Taking one W-element as an example (see Fig. 3), the boundary is discretized with one plane four nodes linear finite element with circumferential axis of and (see Fig. 4). Other 2D finite elements such as the quadratic element with eight nodes can be used for this boundary discretization as well51.
Figure 3.

Spatial discretization of the W-element.
Figure 4.

Four nodes linear plane finite element.
The origin of the global Cartesian coordinate system of the nodes needs to be translated to the scaling center by
| 15 |
where , , and denote the global coordinates of the nodes, , , and denote the coordinates of the scaling center in global Cartesian coordinate system, , , and denote the translated global coordinates of the nodes.
The mapping function between the global coordinates and the local coordinates of the points on the boundary is given by
| 16 |
where denotes the shape function of the plane finite element, , , and denote the global coordinates of the nodes that have been translated by Eq. (15), , , and denote the global coordinates of arbitrary point on the boundary determined by the local coordinates .
The new local scale boundary coordinate is built for this W-element with the origin at the scaling center. Points on the plane finite element is scaled along the radical direction from the scaling center to the boundary, which is defined as the axis of the local scale boundary coordinate. The mapping function between the global coordinates and the local coordinates of the points in the W-element is given by
| 17 |
where , , and denote the local coordinates of the points in the W-element.
Equation (17) provides a mapping relation between the local and global coordinates. Based on the derivative method for compound function, the corresponding relationship of the derivative operators between two coordinates is given by
| 18 |
where is the Jacobian matrix expressed as
| 19 |
The variable can be isolated from Eq. (19) as
| 20 |
with the Jacobian matrix on the boundary defined as
| 21 |
where denotes differentiating with respect to , denotes differentiating with respect to .
Based on the space analytical geometric theory, the geometry properties in the local coordinate system can be derived. The infinitesimal line vectors in the axis direction are given by
| 22 |
where denotes a vector.
The infinitesimal volume is given by
| 23 |
where denotes the determinant of the matrix.
The normal vectors of the coordinate surfaces are given by
| 24 |
where , , and denote the normal vector of the coordinate surface of , and .
The length of the normal vectors , , and and the unit normal vectors , , and are defined as
| 25 |
| 26 |
where denotes the length of the vector.
The infinitesimal area of the coordinate surfaces is given by
| 27 |
can be expressed as
| 28 |
Substituting Eq. (28) into Eq. (18), the derivative operators in the local coordinates is given by
| 29 |
Substituting Eq. (29) into Eq. (7), the spatial partial derivative operator in local coordinate system is given by
| 30 |
where , , and are defined as
| 31 |
| 32 |
| 33 |
and they satisfy
| 34 |
Substituting Eq. (30) into Eqs. (2) and (3), the stress in local coordinate system is given by
| 35 |
Considering the surface traction boundary condition in Eq. (10) to Eq. (12), the surface traction on the coordinate surface is defined as
| 36 |
| 37 |
| 38 |
where , , and denote the the surface traction on the coordinate surface of , , and respectively.
Compared with Eq. (31) to Eqs. (33), (36) to Eq. (38) can be reformulated as
| 39 |
| 40 |
| 41 |
Spatial discretization of the displacement field on the boundary
Taking the same W-element in “Coordinate mapping based on scaled boundary transformation” section as example (see Fig. 5), the boundary is discretized with a finite element with circumferential axis of and (see Fig. 4).
Figure 5.

Displacement field discretization of the W-element.
The displacement field on the boundary can be expressed as
| 42 |
where denotes the shape function of the finite element, denotes the displacement values of the nodes, denotes a identity matrix.
The interpolation shown in Eq. (42) is applied to any coordinate surface of . The displacement field in the W-element can be expressed as
| 43 |
where denotes the the displacement values along the rays starting from the scaling center to the nodes on the boundary.
Substituting Eq. (43) into Eq. (35), the discretization of the stress is given by
| 44 |
where , are defined as
| 45 |
| 46 |
Equivalent integral equations and Galerkin weighted residual method
The SBFEM governing equation can be derived by the application of the weighted residual method or variation principle. In this section, the procedure of Galerkin weighted residual method is elaborated.
The equivalent integral form of Eq. (7) is given by
| 47 |
where denotes the arbitrary weight function defined in Eq. (48), denotes the transpose of the matrix.
is defined as
| 48 |
where denotes the number of weight functions and .
Substituting Eq. (23) into Eq. (47) results in
| 49 |
Dealing the second term labeled II in Eq. (49) with Green's theorem results in
| 50 |
where denotes the the boudnary of surafce .
Substituting Eq. (39) to Eq. (41) into Eq. (50) results in
| 51 |
where the surface traction boundary condition and is introduced naturally.
Substituting Eq. (34) into Eq. (51) results in
| 52 |
Substituting Eq. (52) into Eq. (47), the equivalent integral weak form of Eq. (47) is given by
| 53 |
where the surface traction boundary condition and is introduced naturally, denotes the the boudnary of surafce .
By applying the weighted residual method, the arbitrary weight function in Eq. (53) is simplified to a particular weight function , the approximate form of Eq. (53) is given by
| 54 |
where denotes the weight functions in the W-element, denotes a row vector.
Considering the Galerkin weighted residual method, the interpolation of is the same as in Eq. (43) as
| 55 |
Substituting Eq. (43), Eqs. (29) and (55) into Eq. (54), the SBFEM governing equation in the time domain for 3D elastic continuum media is given by53
| 56 |
where the constant coefficient matrix is given by
| 57 |
The governing equation of W-elements sharing the same scaling center can be assembled by the degree of freedom contributed by adjacent W-elements, which results in the governing equation of the S-element like Eq. (56) but with the assembled , , , , and .
Solution of the SBFEM governing equation
The SBFEM governing equation (Eq. (56)) is a system of second order Ordinary Differential Equations (ODEs) called the Euler-Cauchy equations. The solution of this system is given in a closed form. The first step is to introduce a dual variable to convert the system of second order ODEs to a system of one order with variables doubled in size. Based on the principle of virtual work, the internal node force along the ray starting from the scaling center to the nodes on the boundary resulting from the surface traction on the coordinate surface of is given by
| 58 |
| 59 |
If the body forces vanish, Eq. (56) can be reformulated as
| 60 |
where
| 61 |
and
| 62 |
The eigenvalues and eigenvectors of the matrix can be obtained by
| 63 |
where denotes a matrix consisted of the eigenvectors , denotes the eigenvalues, denotes a diagonal matrix. It is worth to notice that the eigenvalues in should be in descending order, so the eigenvectors in . The eigenvectors and the eigenvalues can be partitioned into two blocks as
| 64 |
| 65 |
where the subscript denotes the block related to , the subscript denotes the block related to .
The solution of Eq. (60) considering boundary conditions is given by
| 66 |
| 67 |
where denotes the arbitrary integration constant, denotes a diagonal matrix expressed as
| 68 |
For the SBFEM polyhedron element, the coefficient matrix representing the stiffness and mass matrix of the S-element need to be derived. Substituting Eq. (67) into Eq. (66) to eliminate , the stiffness matrix is given by51
| 69 |
where denotes the inverse of the matrix.
Based on the virtual work statement, the mass matrix of the S-element can be expressed as51
| 70 |
where denotes the inverse of the transpose of the matrix, the value in the row and column of is defined as
| 71 |
where the is the value in the row and column of defined as
| 72 |
Topology and data structure of an arbitrary polyhedron element
The polyhedron geometry is a 3D shape with straight edges, sharp corners and vertices, and any number greater than 2 of plane polygonal faces with any number greater than 2 of straight edges and vertices. The tetrahedron, pentahedron, hexahedron and heptahedron that widely used in FEM are just the special cases of the convex polyhedron. Vastly different from the FEM element geometry, the first step to construct a polyhedron element is to describe the uncertainty of the topology of varied kinds of polyhedron elements in a model with a uniform data structure that can be recorded in the intermediate file for compatible purpose.
Essential information to describe the topology of an arbitrary polyhedron
For example, Fig. 6 shows a polyhedron element that may be encountered in an octree mesh, which has nine facets, twenty edges and thirteen vertices. The coordinates of the vertices are the basic information as shown in Table 1. In addition, the connectivity of the vertices of each facet needs to be defined as shown in Table 2. These two sets of information are sufficient and necessary for the description of the topology of any polyhedron. It is worth to notice that the order of the vertices and facets of a polyhedron is insignificant and when there are multiple polyhedra, there is no need to record the correspondence between the local and global vertex ID like FEM.
Figure 6.
Topology of a polyhedron element and the treatment of the polygon facet.
Table 1.
Vertex information of the polyhedron element.
| Vertex ID | X coordinates | Y coordinates | Z coordinates |
|---|---|---|---|
| 1 | 0.0 | 0.0 | 0.0 |
| 2 | 0.0 | 10.0 | 0.0 |
| 3 | 10.0 | 10.0 | 0.0 |
| 4 | 10 | 5.0 | 0.0 |
| 5 | 10.0 | 0.0 | 0.0 |
| 6 | 10.0 | 10.0 | 5.0 |
| 7 | 10.0 | 5.0 | 5.0 |
| 8 | 10.0 | 0.0 | 5.0 |
| 9 | 0.0 | 0.0 | 10.0 |
| 10 | 0.0 | 10.0 | 10.0 |
| 11 | 10.0 | 10.0 | 10.0 |
| 12 | 10.0 | 5.0 | 0.0 |
| 13 | 10.0 | 0.0 | 10.0 |
Table 2.
Facet information of the polyhedron.
| Facet ID | Vertex connectivity |
|---|---|
| 1 | 1, 2, 3, 4, 5 |
| 2 | 9, 13, 12, 11, 10 |
| 3 | 2, 10, 11, 6, 3 |
| 4 | 1, 9, 10, 2 |
| 5 | 1, 5, 8, 13, 9 |
| 6 | 7, 6, 11, 12 |
| 7 | 8, 7, 12, 13 |
| 8 | 4, 3, 6, 7 |
| 9 | 5, 4, 7, 8 |
SBFEM discretization of the polyhedron
The geometry of the S-element can be adapted for any convex polyhedron with only triangle or quadrilateral facets which is a special case of the polyhedron defined in “Essential information to describe the topology of an arbitrary polyhedron” section. Nevertheless, the polygonal facet of a polyhedron can always be converted into multiple triangle or quadrilateral facets by adding a vertex on this facet (see Fig. 6). After this treatment of the polyhedron facets, a point inside the polyhedron that can see all the points on the facets is chosen as the scaling center and the vertices are defined as nodes of this polyhedron domain. The scaling center and the nodes of each facet constitute a W-element. All these W-elements are assembled into an S-element representing this polyhedron domain. It is obvious that the number of W-elements is equal to the number of facets of the polyhedron and the number of the nodes of the S-element is equal to the number of vertices of the polyhedron. The data structure to describe any 3D SBFEM polyhedron element is summarized in Table 3.
Table 3.
Data structure of the SBFEM polyhedron element.
| Element ID | k | |
|---|---|---|
| Coordinate of scaling center | x0, y0, z0 | |
| Number of facets | m | |
| Number of nodes | n | |
| Local node ID | Global node ID | Node coordinates |
|---|---|---|
| 1 | N1 | x1, y1, z1 |
| 2 | N2 | x2, y2, z2 |
| … | … | … |
| n | Nn | xn, yn, zn |
| Facets | Number of nodes | Node conectivitya |
|---|---|---|
| 1 | J1 | N11, N12, …, |
| 2 | J2 | N11, N12, …, |
| … | … | … |
| m | Jm | Nm1, Nm2, …, |
| Density | ||
| Young’s modulus | Ek | |
| Poisson’s ratio | vk | |
aThe node sequence should be in a certain order pointing out of the region according to the right-hand rule.
Generation of the SBFEM polyhedron mesh
There are roughly three kinds of tools to obtain a polyhedron mesh: the self-developed program, the open-source or commercial mesh generator. Liu et al. brought up an automatic octree mesh generation algorithm from an STL geometry file in MATLAB for three-dimensional domain38. Besides, at present OPENFOAM, FLUENT and STAR-CCM + provide robust polyhedron mesh generators, the latter two of which are the most convenient. The general procedure to generate a polyhedron mesh from geometry with an out-of-box tool is illustrated in Fig. 7. Because the common FEM software for solid media does not support the polyhedron element, the preprocessor built in them cannot generate polyhedron meshes. Furthermore, the raw polyhedron mesh needs some extra processing steps such as classification, grouping, adding vertices before applied. The flow of geometry and mesh information between various software through files in compatible formats is inevitable. The Initial Graphics Exchange Specification (IGES) for the geometry information and Visualization Toolkit (VTK) for the mesh information are recommended. It should be noted that no matter which polyhedron mesh generator above is chosen or developed, it is required to store the polyhedron mesh in the intermediate file that will be imported into the UEL after the polyhedron mesh is obtained.
Figure 7.
General procedure of SBFEM polyhedron mesh generation by out-of-box tools.
Implementation in ABAQUS
The SBFEM polyhedron element is introduced in ABAQUS/Standard as a user element. The user element is implemented on the element iteration level of the solver in the form of a FORTRAN subroutine named UEL. During each increment of the computation, ABAQUS will invoke the UEL when calculating the coefficient matrix of each user element on and on until the end of the analysis. Assembly of the global coefficient matrix, nonlinear iteration, result output, imposition of contact, constrain, boundary and load conditions are performed by ABAQUS automatically.
Basics of UEL in ABAQUS
UEL is essentially a function to compute specific variables with given variables. The subroutine name, declaration of the input and output variables are fixed (see “Appendix 1”54). During the calculation of each element, the UEL will be called importing information of analysis type, time increment, element type, right-hand-side vectors, etc. to export the mass matrix, stiffness matrix, equivalent nodes force vector, solution-dependent state variables, etc.
There are some conventions of user subroutines in ABAQUS that should be emphasized. All user subroutines and the subroutines created by users must be stored in a single source code file or its compiled object file. By default, the user subroutine can call another subroutine that is built in FORTRAN compiler, created by users or provided by ABAQUS named utility routines. This restriction suggests that some complicated calculations in a user subroutine have to be implemented by source codes provided by users. And if there were multiple user elements, these user elements should be implemented by the same subroutine of UEL with conditional branch statements on element types. Although user subroutines cannot call each other, the data can be transferred through the user-defined COMMON block variables between them.
Associated INP and intermediate file
A convenient characteristic of ABAQUS is that the entire information of a FEM model is stored in an INP file, which is human-readable. This INP file is the only input required by the solver of ABAQUS. The user elements must be declared in the INP file before the calculation (see “Appendix 2”54). The declaration of user elements provide the information of the element type, element set name, number of nodes, node connectivity, node degrees of freedom and element properties such as material parameters, etc. According to the format of the user element declaration in an INP file, the user elements need to be classified into different types based on at least the number of nodes and the material properties and the node connectivity of polygonal facets of a polyhedron cannot be represented.
Due to the limitation of the INP file mentioned before, an intermediate file storing the topology information and material properties of arbitrary polyhedron elements is necessary. This file should be imported once the calculation is started and when iterating through the elements, the corresponding topology information of current user element should be introduced into UEL. With this intermediate file, any polyhedron mesh generator mentioned in “Generation of the SBFEM polyhedron mesh” section can be used and any mesh with arbitrary convex polyhedron shape can be calculated.
Algorithm of UEL for SBFEM polyhedron element
Although UEL has provided a specific interface, it is necessary to understand the calculation process of ABAQUS/Standard to get a clear picture of what information is passed in UEL and what information UEL should return under different circumstances. As shown in Fig. 8, calculation process of ABAQUS/Standard has a hierarchy of three levels. Level 1 denotes the calculation procedure of steps in an analysis. Level 2 denotes the calculation procedure of increments of a step. Level 3 denotes the actual calculation of the polyhedron element matrix and vector in an increment by calling UEL for each element (see the green block in Fig. 8). The utility routine of UEXTERNALDB plays an important role in Level 1 and 2 (see the red blocks in Fig. 8), providing adequate interventions into the different phases of the calculation process, which give us more freedom to realize more complex functions. To coincide with UEL, the intermediate file storing the topology and material information of user polyhedron elements is imported by subroutine UEXTERNALDB at the beginning of the analysis, which is then transferred into UEL by COMMON block variables when the calculation of the polyhedron element starts.
Figure 8.
Hierarchy of the calculation process of ABAQUS/Standard.
The behavior of UEL is controlled by the basic branching structure (see Fig. 9) judged by the variable of LFLAGS. Considering only the general static and direct-integration dynamic analysis, there are five different cases (see colored blocks in Fig. 9) requiring returned values respectively according to the Newton–Raphson Method (NRM) and HHT direct time integration55.
Figure 9.
Basic branching structure of UEL for general static and direct-integration dynamic analysis.
The polyhedron element computation algorithm of UEL based on SBFEM is summarized in “Appendix 3”. The assembly of the coefficient matrix of W-elements in STEP 2.3 and stiffness and mass matrix calculation that include Eigen-decomposition are the major differences from FEM. Subroutines from LAPACK56 is appended to UEL in the code file to perform STEP 3. It is obvious that this UEL is compatible with the traditional FEM element topology built in ABAQUS, considering the tetrahedron, pentahedron and hexahedron as special cases of the polyhedron.
Numerical application
There are two examples for the test and application of the implementation of arbitrary polyhedral elements developed in “Implementation in ABAQUS” section. A cantilever subjected to a harmonic excitation with the traditional hexahedron element and the polyhedron element are compared to confirm the accuracy of the developed UEL. Then the polyhedron element based on SBFEM is applied in the soil-structure dynamic interaction analysis of a nuclear power plant, the applicability and performance of this implementation is tested.
Cantilever subjected to a harmonic excitation
A 5 m long horizontal beam subjected to concentrated forces on the vertices at one end and fixed at the other end is considered (see Fig. 10). The homogenous elastic material properties of Young’s modulus, density and Poisson’s ratio are 20 GPa, 2000 kg/m3, and 0.25 respectively. The harmonic concentrated forces in Y direction on the two vertices follow Eq. (73) defined as
| 73 |
where denoting the period is assuemd to be 0.05 s, denoting the amplitude is assumed to be 1000 N. denotes the concentrated force. The HHT direct time integration calculation is terminated at 0.25 s with a fixed time step of 0.001 s.
Figure 10.

Geometry, load and boundary conditions of the cantilever.
Numerical model
From the geometry, two sets of meshes with varied mesh density are generated. The first set of meshes is made of structured hexahedron elements, namely C3D8 element (3D linear solid element with 8 nodes) built and verified in ABAQUS/Standard and the other is made of unstructured polyhedron elements implemented by UEL based on SBFEM. The details of the meshes are summarized in Table 4, where label P1 to P4 denote the polyhedron meshes with different mesh density (see Fig. 11) that can only be calculated by UEL developed in “Implementation in ABAQUS” section and H1 to H7 denote the hexahedron meshes (see Fig. 12) that can be calculated by C3D8 (built-in element) or the UEL (labeled as H2_UEL and H6_UEL). Model analysis for the first 50 modes of vibration and implicit dynamic analysis are performed.
Table 4.
Mesh information of the cantilever.
| Model name | Element number | Node number | Mesh type | Element type |
|---|---|---|---|---|
| P1 | 2312 | 4663 | Polyhedron | UEL |
| P2 | 4384 | 5977 | Polyhedron | UEL |
| P3 | 17,880 | 28,103 | Polyhedron | UEL |
| H1 | 5 | 24 | Hexahedron | C3D8 |
| H2 | 40 | 99 | Hexahedron | C3D8 |
| H3 | 117 | 224 | Hexahedron | C3D8 |
| H4 | 153 | 288 | Hexahedron | C3D8 |
| H5 | 625 | 936 | Hexahedron | C3D8 |
| H6 | 5000 | 6171 | Hexahedron | C3D8 |
| H7 | 625,000 | 652,851 | Hexahedron | C3D8 |
| H2_UEL | 40 | 99 | Polyhedron | UEL |
| H6_UEL | 5000 | 6171 | Polyhedron | UEL |
Figure 11.
Polyhedron meshes of the cantilever. (a) P1, (b) P2, (c) P3.
Figure 12.

Hexahedron mesh of the cantilever (taken model H6 as an example).
Results and discussion
Model analysis checking the stiffness and mass matrix with specific boundary conditions is the most convenient approach to verify the user element for dynamic analysis, excluding the influence of load conditions and nonlinearity. The results of the first 50 natural frequencies and the displacement response of the dangling end (see Fig. 10) are compared to check the accuracy and efficiency of the UEL for the polyhedron element. As the increasing of the number of elements, the results of model analysis will converge to the true value of this problem. The first 50 natural frequencies of model H1 to H7 are listed in Fig. 13, from which the convergence values of the first 50 natural frequencies of the cantilever are obtained covering more than 95% effective mass in the main direction (97.1% in X and Y direction, 95.1% in Z direction).
Figure 13.

First 50 natural frequencies of the C3D8 meshes of the cantilever.
Figure 13 shows that the difference between the frequencies of models with varied mesh densities is no more than 9% for the first vibration mode and this difference is enlarged to less than 19% for the first 9 vibration modes, which tends to keep on increasing with the order. Even though when the mesh is coarse, the convergence speed is fast with the increasing of the element, the convergence speed is much slower near the convergence values leading to rather poor computation efficiency (see Fig. 14). For example, the highest frequency of model H6 and H7 are 1374.8 Hz and 1392 Hz, the computation times of which are 5 s and 1109 s. More than 220 times the computation time of model H6 brings less than 1.2% improvement of the results of model H7. This is a typical illustration of the need to pay great attention to the balance between mesh density and calculation efficiency. Since it is reasonable to assume that the results of model H7 are close enough to the convergence values, the true fundamental frequency of this cantilever is assumed to be 19.955 Hz.
Figure 14.

Fundamental frequencies of the C3D8 meshes of the cantilever.
To exclude the influence of the meshes, the same hexahedron meshes H2 and H6 are calculated by C3D8 and UEL respectively. Figure 15 shows the frequency comparison of the cantilever model H6_UEL calculated by UEL and H7 by C3D8. The consistency of the results of model H7 and H6_UEL confirms the accuracy of the UEL for the SBFEM-based polyhedron element with error less than 0.6% over the entire calculated frequency range. Figure 16 shows the frequency comparison of the cantilever mesh model H2 calculated by C3D8 and UEL. Compared to model H2 calculated by C3D8, model H2_UEL can get much better results that is almost equal to model H6 calculated by C3D8. In other words, polyhedron element based on SBFEM can get the same level of accuracy with less than 1% of the elements based on FEM, the most immediate advantage of which is the reduction in storage space for large-scale problems.
Figure 15.

Frequency comparison of the C3D8 and UEL for mesh model H6.
Figure 16.

Frequency comparison of the C3D8 and UEL for mesh model H2.
The displacement responses in Y direction from the implicit dynamic analysis of model P1, P2, P3, and H6 are demonstrated in Fig. 17. Except the displacement values that are close to zero, the error between the model calculated by the C3D8 element and the user-defined polyhedron element based on SBFEM is less than 0.5%. The results of model analysis and direct dynamic analysis of the cantilever have proven the accuracy of the UEL implementation of the SBFEM-based polyhedron element and the efficiency of the SBFEM for the solid medium.
Figure 17.

Displacement response in Y direction of models calculated by C3D8 and UEL.
Soil-structure dynamic interaction analysis of a nuclear power plant
To verify the performance and robustness of the implementation that has been primarily validated in “Cantilever subjected to a harmonic excitation” section, the application in the analysis of a practical engineering problem is necessary. A typical numerical elastic SSI analysis of a NPP with direct method in the time domain is taken as an example, which includes the simulation of the structure with traditional FEM elements, near field soil with the polyhedron elements, far field soil with an artificial non-reflecting boundary condition, external excitation input with site response analysis, and interaction between them with constrain or contact. For simplicity, the SSI analysis of a NPP is elastic. But it is enough to demonstrate the merit in automatic mesh generation and ability to be integrated seamlessly with other modules of the polyhedron element based on SBFEM and its implementation by UEL. The nuclear power plant is located on elastic rock soil with the Young’s modulus of 2.63E10 Pa, Poisson’s ratio of 0.25 and density of 1762.06 kg/m3. Two artificial seismic plane waves vibrating along the two horizontal directions with PGA of 0.9806 m/s2 or 0.1 g (see Fig. 18) defined by the U.S. NRC RG 1.6057 response acceleration spectrum (see Fig. 19) are introduced into the SSI system from the bottom of the rock propagating upward along the vertical direction. This earthquake intensity just satisfies the minimum limit recommended by the IAEA guidelines for the SL-2 ground motion hazard level58. The SSI numerical analysis model of NPP based on the direct method is illustrated in Fig. 20.
Figure 18.

Artificial input earthquake in X and Y direction. (a) X direction, (b) Y direction.
Figure 19.

Desigen response acceleration spectrum defined by RG 1.60.
Figure 20.

Numerical SSI model of NPP based on the direct method.
Numerical model
The SSI numerical analysis of NPP can be divided into three individual parts: the structure, the near-field and the far-field. The structure and the near-field are modeled by FEM. The far-field is modeled by the direct method. Benefiting from the FEM for unmatched mesh based on kinematic constraints, the structure and the near-field soil can be meshed separately.
For simplicity, the structures on the nuclear island including the containment and the auxiliary buildings are meshed with shell elements S4R or S3 (see Fig. 21). The containment of this NPP is a double shell structure including an outer reinforced concrete vessel called shield building (SB) and an inner steel vessel. The foundation of the nuclear island is meshed with solid elements embedded in the near-field soil. The connection between the structure and the near-field soil is modeled by the tie constrain defined on the interface.
Figure 21.
FEM model of the NPP structure.
The geometry of the near-field soil can be very complex once geological features must be considered like cracks or faults, etc. Therefore, the solid element is the most reasonable choice to model the near-field soil. Besides, in order to ensure the accuracy, the direct method requires that the size of the near-field soil should be as large as possible and no less than twice of the size of the structure consuming a lot of computing resources. Tremendous efforts for the mesh generation are needed to balance the accuracy and efficiency of the numerical model. In this example, the near-field soil is meshed with octree solid elements automatically (see Fig. 22). Although the geometry of the near-field soil in the example is rather simple, the geological complexity of the soil should not cause any difficulties in the automatic mesh generation process.
Figure 22.

FEM model of the NPP near field with user-defined polyhedron elements.
The SSI effect is considered by applying an artificial non-reflecting boundary condition (NRBC) at the truncation of the near field soil. Specifically, a set of springs and dashpots tied to the ground along the three directions are added to the nodes on the interface between the near-field and far-filed soil representing the approximation of the viscoelastic NRBC59. Unlike the substructure method, the corresponding input of exogenous excitations for a specific NRBC is needed. For viscoelastic boundary, the seismic load is imported by equivalent forces acting on the nodes of the artificial boundary59,60. The Rayleigh damping is applied to keep the damping ratio equal to 0.05 at the frequencies of 2.0 Hz and 15.0 Hz with the coefficient of and .
There are totally 260,499 elements, 167,221 nodes, and 549,177 degrees of freedom in this NPP model, the 13 section properties of which are summarized in Table 5. A transient dynamic analysis based on HHT implicit time integration is performed with a fixed time step of 0.01 s.
Table 5.
Section properties of the SSI model of the nuclear power plant.
| Section name | Thickness (m) | Density (kg/m3) | Young’s modulus (Pa) | Poisson’s ratio | Element type | Additional mass (kg/m2) | Location |
|---|---|---|---|---|---|---|---|
| S1 | 0.38 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 1136.2 | Structure |
| S2 | 0.912 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 2728.88 | Structure |
| S3 | 0.6 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 1794 | Structure |
| S4 | 0.2286 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 683.514 | Structure |
| S5 | 0.762 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 2278.38 | Structure |
| S6 | 3.9768 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 111,889.8 | Structure |
| S7 | 4.6048 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 13,768.3 | Structure |
| S8 | 0.45 | 2300 | 3.35E10 | 0.2 | S4R/S3 | 1345.5 | Structure |
| S9 | 0.048 | 7800 | 2.0E11 | 0.3 | S4R/S3 | 486.72 | Structure |
| S10 | 0.042 | 7800 | 2.0E11 | 0.3 | S4R/S3 | 418.782 | Structure |
| S11 | - | 2300 | 3.35E10 | 0.2 | C3D8R/C3D6 | – | Structure |
| S12 | - | 1762.06 | 2.63E10 | 0.25 | UEL | – | Soil |
Results and discussion
To investigate the detailed acceleration and displacement responses of the NPP, five nodes are selected as monitoring points (see Fig. 23), the locations of which are listed in Table 6.
Figure 23.
Locations of monitoring points of the nuclear power plant.
Table 6.
Locations of monitoring points of the nuclear power plant.
| Node ID | Part | X coordinate (m) | Y coordinate (m) | Z coordinate (m) |
|---|---|---|---|---|
| 18,624 | Structure | 115.5 | 131.355 | 33.576 |
| 9959 | Structure | 115.5 | 131.355 | 69.671 |
| 12,070 | Structure | 115.500 | 122.820 | 116.916 |
| 18,116 | Structure | 73.742 | 109.255 | 33.576 |
| 18,168 | Structure | 151.162 | 117.789 | 33.576 |
The time history of acceleration and displacement response of these nodes is compared. Figures 24 and 25 show the horizontal displacement and acceleration response of the nodes on the NPP foundation at the height of 33.576 m. It appears that the foundation is moving like a rigid plate without any rotation. The peak acceleration of the input movement at the foundation is about 0.09 g, which is a little less than the input movement at the substratum top (or the hard rock bottom). The site hardly changes the input movement due to the thin hard rock soil layer beneath the foundation indicating an insignificant SSI effect. The peak displacement of the nodes at the foundation is about 0.076 m, which can be recognized as a basic motion of the entire NPP. Figures 26 and 27 display the horizontal displacement and acceleration response of the nodes on the NPP foundation at different heights from the foundation to the top of the outer RC containment. It can be found in Fig. 26 that the peak displacement is 0.054 m (X direction) and 0.077 m (Y direction) at the height of 33.567 m, 0.058 m (X direction) and 0.081 m (Y direction) at the height of 69.671 m, 0.069 m (X direction) and 0.085 m (Y direction) at the height of 116.916 m, increasing along the vertical direction from the bottom to the top of the containment structure. In Fig. 27, the same trend that the peak accelerations increase from 0.85 m/s2 (X direction) and 0.81 m/s2 (Y direction) to 2.75 m/s2 (X direction) and 3.43 m/s2 (Y direction) to 5.47 m/s2 (X direction) and 7.9 m/s2 (Y direction) can be found. The geometry asymmetry is the main reason why there are differences in the response along the X and Y direction. The acceleration enlargement ratio from the foundation to the top is about 9.75, which is the result of the stiffness of the soil. Figure 28 illustrates the relative displacement response of the SB top to the SB foundation, eliminating the rigid transition movement due to the global site response. The peak values of the displacement in X direction and Y direction are 1.6 cm and 2.0 cm.
Figure 24.
Horizontal displacement histories of monitoring points at the foundation. (a) X direction, (b) Y direction.
Figure 25.
Horizontal acceleration histories of monitoring points at the foundation. (a) X direction, (b) Y direction.
Figure 26.
Horizontal displacement histories of monitoring points at different heights (33.576 m, 69.671 m, 116.916 m). (a) X direction, (b) Y direction.
Figure 27.
Horizontal acceleration histories of monitoring points at different heights (33.576 m, 69.671 m, 116.916 m). (a) X direction, (b) Y direction.
Figure 28.
Relative horizontal displacement histories of the points on the top of the shield building. (a) X direction, (b) Y direction.
The floor response spectra of monitoring points at different heights with the damping ratio of 0.05 are listed in Fig. 29. The same trend of spectrum enlargement for the two horizontal directions can be observed. The peak spectrum values of the three nodes appear at the same frequency of 2.78 Hz, which is near the fundamental frequency of the SSI system. In the frequency range between 0.25 and 1.0 Hz, the enlargement ratio along the height is less than 1.5. The enlargement ratio increases starting from 1.0 Hz and reaches its peak value of 13.33 at 2.78 Hz. This value decreases to about 9.3 at 100.0 Hz that is nearly equivalent to the acceleration enlargement ratio from the foundation to the top of the shield building.
Figure 29.
Floor response spectrums of monitoring points at different heights (33.576 m, 69.671 m, 116.916 m).
The distribution of the peak acceleration (absolute values) can be seen from Fig. 30. The maximum PGA values arise at the top of the shield building. In general, the PGA values are enlarged along the vertical direction except regions near the foundation. The amplification ratio of the peak acceleration along three paths is detailed in Fig. 31. The nodes of the three paths that are parallel to Z axis are chosen as the monitoring points (see Fig. 23) and the height of the foundation bottom is set as zero. There is an upheaval of amplification ratio at the height of around 75 m where the water tank is located.
Figure 30.
Distribution of the horizontal peak acceleration of the NPP structure. (a) X direction, (b) Y direction.
Figure 31.
Amplification ratio of the peak acceleration along the Z direction.
Conclusion
The results of two examples indicate that the implementation of SBFEM-based arbitrary polyhedron elements can be adapted to the automatic FEM analysis of static and dynamic elastic problems with polyhedron meshes generated by any tool. The first example conforms the accuracy and efficiency of the polyhedron element based on SBFEM and the associated UEL implementation in ABAQUS. Through the second example, it can be found that after the geometry model of a structure is built, automatic dynamic analyses of complex or large structures can be achieved by the combination of polyhedron mesh generation technique and the implementation of arbitrary polyhedron elements in ABAQUS. On one hand, this implementation of SBFEM-based elements dispenses with the development of the pre/post-processor, matrix solver, time integration module, contact analysis module, nonlinear analysis module, etc. extending the usability of SBFEM in engineering analyses of bounded domain. On the other hand, this implementation also enhances the original function of ABAQUS to a great extent allowing engineering analyses with elements of almost any topology.
Acknowledgements
This research was supported by Grant 52178460 from the National Natural Science Foundation of China, Grant 51779222 from the National Natural Science Foundation of China, and DUT20TD209 from the Fundamental Research Funds for the Central Universities of China.
Appendix 1: Interface of UEL and UEXTERNALDB
Appendix 2: INP format to define user elements
Appendix 3: Element computation algorithm of UEL
| Stiffness and mass matrix computation of the polyhedron element based on SBFEM |
|---|
| STEP 1: Prepare S-element data, including shifted coordinates of nodes and scaling center (Eq. (15)), node connectivity of each W-element, etc |
| STEP 2: For each W-element do: |
| STEP 2.1: Prepare W-element data and integration points data; |
| STEP 2.2: For each numerical integration point do: |
| STEP 2.2.1: Compute the shape functions and the their derivatives; |
| STEP 2.2.2: Compute the determinant of the Jacobian matrix on the boundary by Eq. (21); |
| STEP 2.2.3: Compute , , by Eqs. (31)–(33); |
| STEP 2.2.4: Compute , by Eqs. (45), (46); |
| STEP 2.2.5: Compute material property matrix by Eq. (8); |
| STEP 2.2.6: Compute , , , and by Eq. (57); |
| STEP 2.2.7: Accumulate the , , , and ; |
| STEP 2.3: Assemble the , , , and ; |
| STEP 3: Perform eigen-decomposition of in Eq. (62) to get sorted and ; |
| STEP 4: Compute the stiffness matrix by Eq. (69); |
| STEP 5: Compute the mass matrix by Eq. (70)–(72) |
Author contributions
Lei Zhou debugged the program, analyzed the results, and wrote the manuscript. Jianbo Li developed the program. Gao Lin provided the theoretical guide and designed the examples. All authors reviewed the manuscript.
Competing interests
The authors declare no competing interests.
Footnotes
Publisher's note
Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
References
- 1.Moretti, G. Grid generation using classical techniques. In (ed., Langley, V. A.) (1980) [cited 2020 Aug 8]. Available from: http://www.researchgate.net/publication/23912609_Grid_generation_using_classical_techniques.
- 2.Caughey DA. A systematic procedure for generating useful conformal mappings. Int. J. Numer. Methods Eng. 1978;12(11):1651–1657. [Google Scholar]
- 3.South, J. C. & Jameson, A. Relaxation solutions for inviscid axisymmetric transonic flow over blunt or pointed bodies. In A1AA Computational Fluid Dynamics Conference, Palm Springs, California (1973).
- 4.Baker TJ. Mesh generation by a sequence of transformations. Appl. Numer. Math. 1986;2(6):515–528. [Google Scholar]
- 5.Sheehy, D. J., Armstrong, C. G. & Robinson, D. J. Computing the medial surface of a solid from a domain Delaunay triangulation. In Proceedings of the Third ACM Symposium on Solid Modeling and Applications. 201–212 (1995).
- 6.Schneiders R, Bünten R. Automatic generation of hexahedral finite element meshes. Comput. Aided Geom. Des. 1995;12(7):693–707. [Google Scholar]
- 7.Zhu J, Zienkiewicz O, Hinton E, Wu J. A new approach to the development of automatic quadrilateral mesh generation. Int. J. Numer. Methods Eng. 1991;32(4):849–866. [Google Scholar]
- 8.Blacker TD, Stephenson MB. Paving: A new approach to automated quadrilateral mesh generation. Int. J. Numer. Methods Eng. 1991;32(4):811–847. [Google Scholar]
- 9.Dvorak P. New element lops time off CFD simulations. Mach. Des. 2006;78(5):154–155. [Google Scholar]
- 10.Balafas, G. Polyhedral mesh generation for CFD-analysis of complex structures (Technische Universitat Munchen, 2014).
- 11.Sibson, R. A vector identity for the Dirichlet tessellation. In Mathematical Proceedings of the Cambridge Philosophical Society 151–155 (Cambridge University Press, 1980).
- 12.Sibson, R. A brief description of natural neighbour interpolation. Interpreting multivariate data. 21–36 (1981).
- 13.Traversoni, L. Modified natural neighbor interpolant. In Curves and Surfaces in Computer Vision and Graphics III 196–203 (International Society for Optics and Photonics, 1992).
- 14.Sambridge M, Braun J, McQueen H. Geophysical parametrization and interpolation of irregular data using natural neighbours. Geophys. J. Int. 1995;122(3):837–857. [Google Scholar]
- 15.Watson, D. Compound signed decomposition, the core of natural neighbor interpolation in n-dimensional space. See ftp://ftp.iamg.org/Waston/core.ps.gz (2001).
- 16.Sukumar N, Moran B, Yu Semenov A, Belikov V. Natural neighbour Galerkin methods. Int. J. Numer. Methods Eng. 2001;50(1):1–27. [Google Scholar]
- 17.Sukumar N, Moran B, Belytschko T. The natural element method in solid mechanics. Int. J. Numer. Methods Eng. 1998;43(5):839–887. [Google Scholar]
- 18.Hiyoshi, H. & Sugihara, K. An interpolant based on line segment Voronoi diagrams. In Japanese Conference on Discrete and Computational Geometry 119–128 (Springer, 1998).
- 19.Belikov V, Ivanov V, Kontorovich V, Korytnik S, Semenov AY. The non-Sibsonian interpolation: A new method of interpolation of the values of a function on an arbitrary set of points. Comput. Math. Math. Phys. 1997;37(1):9–15. [Google Scholar]
- 20.Sukumar N, Tabarraei A. Conforming polygonal finite elements. Int. J. Numer. Methods Eng. 2004;61(12):2045–2066. [Google Scholar]
- 21.Sukumar N, Malsch E. Recent advances in the construction of polygonal finite element interpolants. Arch. Comput. Methods Eng. 2006;13(1):129. [Google Scholar]
- 22.Hennart J. P. A Rational Finite Element Basis (Taylor and Francis, 1977).
- 23.Warren J. On the uniqueness of barycentric coordinates. Contemp. Math. 2003;334:93–100. [Google Scholar]
- 24.Warren J. Barycentric coordinates for convex polytopes. Adv. Comput. Math. 1996;6(1):97–108. [Google Scholar]
- 25.Meyer M, Barr A, Lee H, Desbrun M. Generalized barycentric coordinates on irregular polygons. J. Graph. Tools. 2002;7(1):13–22. [Google Scholar]
- 26.Hormann K, Floater MS. Mean value coordinates for arbitrary planar polygons. ACM Transactions on Graphics (TOG) 2005;25(4):1424–1441. [Google Scholar]
- 27.Floater MS. Mean value coordinates. Comput. Aided Geom. Des. 2003;20(1):19–27. [Google Scholar]
- 28.Lipman Y, Levin D, Cohen-Or D. Green coordinates. ACM Trans. Graph. (TOG) 2008;27(3):1–10. [Google Scholar]
- 29.Warren J, Schaefer S, Hirani AN, Desbrun M. Barycentric coordinates for convex sets. Adv. Comput. Math. 2007;27(3):319–338. [Google Scholar]
- 30.Wolf JP, Song C. Consistent infinitesimal finite-element cell method: In-plane motion. Comput. Methods Appl. Mech. Eng. 1995;123(1–4):355–370. [Google Scholar]
- 31.Song C, Wolf JP. Consistent infinitesimal finite-element–cell method: Out-of-plane motion. J. Eng. Mech. 1995;121(5):613–619. [Google Scholar]
- 32.Song C, Wolf JP. Consistent infinitesimal finite-element cell method: Three-dimensional vector wave equation. Int. J. Numer. Methods Eng. 1996;39(13):2189–2208. [Google Scholar]
- 33.Song C, Wolf JP. The scaled boundary finite-element method—Alias consistent infinitesimal finite-element cell method—For elastodynamics. Comput. Methods Appl. Mech. Eng. 1997;147(3–4):329–355. [Google Scholar]
- 34.Li M, Zhang Y, Zhang H, Guan H. Numerical stability and accuracy of the scaled boundary finite element method in engineering applications. ANZIAM J. 2015;57(2):114–137. [Google Scholar]
- 35.Wang F, Lin G, Zhou Y, Chen D. Element-free Galerkin scaled boundary method based on moving Kriging interpolation for steady heat conduction analysis. Eng. Anal. Bound. Elem. 2019;1(106):440–451. [Google Scholar]
- 36.Wolf JP, Song C. Finite-Element Modelling of Unbounded Media. Wiley; 1996. [Google Scholar]
- 37.Talebi H, Saputra A, Song C. Stress analysis of 3D complex geometries using the scaled boundary polyhedral finite elements. Comput. Mech. 2016;58(4):697–715. [Google Scholar]
- 38.Liu Y, Saputra AA, Wang J, Tin-Loi F, Song C. Automatic polyhedral mesh generation and scaled boundary finite element analysis of STL models. Comput. Methods Appl. Mech. Eng. 2017;313:106–132. [Google Scholar]
- 39.Zhang J, Song C. A polytree based coupling method for non-matching meshes in 3D. Comput. Methods Appl. Mech. Eng. 2019;349:743–773. [Google Scholar]
- 40.Ooi ET, Saputra A, Natarajan S, Ooi EH, Song C. A dual scaled boundary finite element formulation over arbitrary faceted star convex polyhedra. Comput Mech. 2020;66(1):27–47. [Google Scholar]
- 41.Zou D, Chen K, Kong X, Liu J. An enhanced octree polyhedral scaled boundary finite element method and its applications in structure analysis. Eng. Anal. Bound. Elem. 2017;84:87–107. [Google Scholar]
- 42.Chen K, Zou D, Kong X. A nonlinear approach for the three-dimensional polyhedron scaled boundary finite element method and its verification using Koyna gravity dam. Soil Dyn. Earthq. Eng. 2017;1(96):1–12. [Google Scholar]
- 43.Huang YJ, Yang ZJ, Liu GH, Chen XW. An efficient FE–SBFE coupled method for mesoscale cohesive fracture modelling of concrete. Comput. Mech. 2016;58(4):635–655. [Google Scholar]
- 44.Zhang Z, Dissanayake D, Saputra A, Wu D, Song C. Three-dimensional damage analysis by the scaled boundary finite element method. Comput. Struct. 2018;206:1–17. [Google Scholar]
- 45.Zhang Z, Liu Y, Dissanayake DD, Saputra AA, Song C. Nonlocal damage modelling by the scaled boundary finite element method. Eng. Anal. Bound. Elem. 2019;99:29–45. [Google Scholar]
- 46.Zou D, Sui Y, Chen K. Plastic damage analysis of pile foundation of nuclear power plants under beyond-design basis earthquake excitation. Soil Dyn. Earthq. Eng. 2020;136:106179. [Google Scholar]
- 47.Yang ZJ, Yao F, Huang YJ. Development of ABAQUS UEL/VUEL subroutines for scaled boundary finite element method for general static and dynamic stress analyses. Eng. Anal. Bound. Elem. 2020;1(114):58–73. [Google Scholar]
- 48.Wolf, J. P. & Song, C. The scaled boundary finite-element method—A primer: Derivations. Comput. Struct.78(1–3),191–210 (2000).
- 49.Song, C. & Wolf, J. P. The scaled boundary finite-element method—A primer: Solution procedures. Comput. Struct. 78(1–3), 211–225 (2000).
- 50.Deeks AJ, Wolf JP. A virtual work derivation of the scaled boundary finite-element method for elastostatics. Comput. Mech. 2002;28(6):489–504. [Google Scholar]
- 51.Song, C. & Wolf, J. P. Body loads in scaled boundary finite-element method. Comput. Methods Appl. Mech. Eng.180(1–2), 117–135 (1999).
- 52.Bazyar MH, Song C. A continued-fraction-based high-order transmitting boundary for wave propagation in unbounded domains of arbitrary geometry. Int. J. Numer. Methods Eng. 2008;74(2):209–237. [Google Scholar]
- 53.Song C. The Scaled Boundary Finite Element Method: Introduction to Theory and Implementation. Wiley; 2018. p. 504. [Google Scholar]
- 54.SIMULIA User Assistance 2018. (Dassault Systemes Simulia Corp., 2017).
- 55.Hilber HM, Hughes TJ, Taylor RL. Improved numerical dissipation for time integration algorithms in structural dynamics. Earthq. Eng. Struct. Dyn. 1977;5(3):283–292. [Google Scholar]
- 56.Anderson E, Bai Z, Bischof C, Blackford LS, Demmel J, Dongarra J, et al. LAPACK Users’ Guide. SIAM; 1999. [Google Scholar]
- 57.U.S. Nuclear Regulatory Commission Regulatory Guide 1.60. Design Response Spectra for Seismic Design of Nuclear Power Plants (2014).
- 58.International Atomic Energy Agency (IAEA). SSG-9 Seismic Hazards in Site Evaluation for Nuclear Installations: Safety Guide (2010).
- 59.Liu J, Du Y, Du X, Wang Z, Wu J. 3D viscous-spring artificial boundary in time domain. Earthq. Eng. Eng. Vib. 2006;5(1):93–102. [Google Scholar]
- 60.Li Y, Hu Z, Li Z, Lin G, Zhou L. Practical technique for analysing free-field response of horizontally layered viscoelastic half-space excited by vertically travelling seismic waves. Soil Dyn. Earthq. Eng. 2021;151:106968. [Google Scholar]



















