A Numerical Method for Solving 3D Elasticity Equations with Sharp-Edged Interfaces
Abstract
Interface problems occur frequently when two or more materials meet. Solving elasticity equations with sharp-edged interfaces in three dimensions is a very complicated and challenging problem for most existing methods. There are several difficulties: the coupled elliptic system, the matrix coefficients, the sharp-edged interface, and three dimensions. An accurate and efficient method is desired. In this paper, an efficient nontraditional finite element method with nonbody-fitting grids is proposed to solve elasticity equations with sharp-edged interfaces in three dimensions. The main idea is to choose the test function basis to be the standard finite element basis independent of the interface and to choose the solution basis to be piecewise linear satisfying the jump conditions across the interface. The resulting linear system of equations is shown to be positive definite under certain assumptions. Numerical experiments show that this method is second order accurate in the L∞ norm for piecewise smooth solutions. More than 1.5th order accuracy is observed for solution with singularity (second derivative blows up).
1. Introduction
The macroscopic mechanical response of most elastic materials, such as wood, metal, rubber, rock, and bone, can be described by the elasticity theory. However, the numerical solution for an elasticity problem with interface is highly nontrivial, because the coefficients in the partial differential equation for elasticity system are discontinuous, and the solution to the PDE system also needs to satisfy the jump conditions across each material interface. Examples of elasticity interface problem include the minimum-compliance-design problems [1], the microstructural evolution [2], and the atomic interactions [3]. Designing an accurate and efficient method for these problems is a difficult job, especially when the interface is not smooth.
In this paper, we consider a three-dimensional elasticity problem with sharp-edged interfaces and matrix coefficients. The model of interest is as follows.
Consider an open bounded domain Ω ⊂ Rd. Let Γ be an interface of codimension d − 1, which divides Ω into disjoint open subdomains, Ω− and Ω+, hence Ω = Ω− ⋃ Ω+ ⋃ Γ. Assume that the boundary ∂Ω and the boundary of each subdomain ∂Ω± are Lipschitz continuous as submanifolds. Since ∂Ω± are Lipschitz continuous, so is Γ. A unit normal vector of Γ can be defined as a.e. on Γ; see Section 1.5 in [4].
The “±” superscripts refer to limits taken from within the subdomains Ω±.
The setup of the problem is illustrated in Figure 1.

We consider the three-dimensional elasticity interface problem (d = 3) in this paper. Although the real problem would have a three-by-three coupled PDE system and six jump conditions, for simplicity of coding, we use two-by-two PDE system to demonstrate the effectiveness of our method. Note that the mathematical challenge is in the 3D geometry when generalized from the corresponding 2D problem. Changing the system from two-by-two to three-by-three does not bring in new mathematical challenge.
Interface problems have been studied by many researchers and several techniques have been developed. Finite element methods with body-fitted grid use a mesh triangulation to capture the boundary [5–8]. However, in many situations, such as when the boundary is moving, the mesh generation may be both computationally expensive and challenging. A uniform Cartesian grid is preferred.
In [9, 10], to simulate the flow patten of blood in the heart, Peskin proposed the “immersed boundary” method, which used numerical approximation of δ-function for singular sources on the interface. In [11], in order to compute two-phase flow, a level-set method was combined with the “immersed boundary” method. These methods are simple to be used but difficult to achieve high-order accuracy.
In addition, a large class of finite difference methods have been proposed. The main idea is to use difference scheme and stencils carefully near the interface to incorporate jump conditions and achieve high-order local truncation error using Taylor expansion. Using finite difference scheme typically requires taking high-order derivatives of jump conditions and interface in Taylor expansion. Also property of the discretized linear system is hard to analyze for interface problem with general jump condition. The “immersed interface” method was proposed in [12]. This method incorporates the interface conditions into the finite difference scheme near the interface to achieve second-order accuracy based on a Taylor expansion in a local coordinate system. Second-order differentiation of the interface is needed. The Matched Interface and Boundary (MIB) method was developed in [13] and improved to handle sharp-edged interfaces in two dimensions in [14] and in three dimensions in [15]. With an elegant treatment, second-order accuracy was achieved in the L∞ norm.
The existing finite element schemes on unfitted meshes are usually designed by modifying the finite element basis near the interface. Examples are immersed finite element method [16, 17], adaptive immersed interface method [18], and extended finite element method [19–21].
An elasticity system can be solved by both finite difference and finite element methods. In [22, 23], a finite difference method called immersed interface method is proposed to solve elasticity problems with nonhomogeneous jump conditions. While second-order accuracy was achieved, the condition number of the discrete system is quite large especially in the nearly incompressible case (λ is large) compared with that obtained from finite element formulations.
In [17], an immersed-interface finite element method was developed for scalar elliptic interface problems with nonhomogeneous jump conditions. In [24], the immersed-interface finite element method was developed for the elasticity system with homogeneous and nonhomogeneous jump conditions. The Soblev space theory provides strong theoretical foundations for convergence analysis for finite element methods.
There are some other approaches to solve the elliptic interface problems. In particular, some recent work [14, 25, 26] can handle sharp-edged interfaces. However, these have not been developed to solve the elasticity interface problems.
In [27], a nontraditional finite element method is proposed to solve the 2D elasticity interface problems with sharp-edged interfaces.
In this paper, based on the method in [27–30], we propose a numerical method for solving the 3D elasticity problem with sharp-edged interfaces. Compared with [27], this is not a trivial extension, as the geometry in three dimensions is more complicated. In two dimensions, the interface could only cut a triangle in one way (if not counting the case the interface hits a grid point as a separate case). In three dimension, There are two types of plane segments see Figure 3. We proved that the resulting linear system is nonsymmetric but positive definite under certain assumption. The method is simpler compared with that developed in [24] and can be applied for more general problems since we allow βi to be matrices. The condition number grows with O(h−2), the same as the case without interface. The condition number also grows only linearly with the ratio between β+ and β−.
The rest of the paper is organized as follows: Section 2 presents the weak form of the elasticity system. In Section 3, we discuss our new numerical method and some theoretical analysis. In Section 4, some examples are presented to demonstrate the performance of our method. We conclude in Section 5.
2. The Weak Formulation
Equation (6) could be thought as a compatibility condition between a and g. To simplify the notation, from now on, we will drop the tildes.
If u ∈ H(a, c), then [u] Γ = a and u|∂Ω = g. Note that can be identified with H(0,0).
Definition 1. A function u ∈ H(a, c) is a weak solution of (1)–(3), if satisfies
Definition 2. A function u ∈ H(a, c) is a weak solution of (1)–(3), if u satisfies, for all ,
A classical solution of (1)–(3), , is necessarily a weak solution. Because all the subdomains’ boundaries ∂Ω± are Lipschitz continuous, the integration by parts is legal in each subdomain, Ω±; see Theorem 1.5.3.1 in [33].
We have the following theorem.
Theorem 3. If f ∈ L2(Ω), and a, b, and c ∈ H1(Ω), then there exists a unique weak solution of (1)–(3) in H(a, c).
Proof. See Theorem 2.1 in [31].
3. Numerical Method
For simplicity, we will discuss the following properties under the form of (14), (15), and (16).
For ease of discussion, Section 3, and for accuracy testing in Section 4, we assume that a, b, and c are smooth on the closure of Ω, β and f are smooth on Ω+ and Ω−, but they may be discontinuous across the interface Γ. However, ∂Ω, ∂Ω−, and ∂Ω+ are kept to be Lipschitz continuous. We assume that there is a Lipschitz continuous and piecewise smooth level-set function ϕ on Ω, where Γ = {ϕ = 0}, Ω− = {ϕ < 0}, and Ω+ = {ϕ > 0}. A unit vector n = ∇ϕ/|∇ϕ| can be obtained on , which is a unit normal vector of Γ at Γ pointing from Ω− to Ω+.
In this paper, we restrict ourselves to a cube cell domain Ω = (xmin , xmax )×(ymin , ymax )×(zmin , zmax ) in 3D space, and β is a 3 × 3 matrix that is uniformly elliptic in each subdomain. Given positive integers I, J, and K, set Δx = (xmax − xmin )/I, Δy = (ymax − ymin )/J, and Δz = (zmax − zmin )/K. We define a uniform Cartesian grid (xi, yj, zk) = (xmin + iΔx, ymin + jΔy, zmin + kΔz) for i = 0, …, I, j = 0, …, J and k = 0, …, K. Each (xi, yj, zk) is called a grid point. For the case i = 0, I, j = 0, J, or k = 0, K, a grid point is called a boundary point, otherwise it is called an interior point. The grid size is defined as h = max (Δx, Δy, Δz) > 0.
We cut every cube cell region [xi, xi+1]×[yj, yj+1]×[zk, zk+1] into six tetrahedron regions. Collecting all those tetrahedron regions, we obtain a uniform tetrahedralization ; see Figure 2.


If ϕ(xi, yj, zk) ≤ 0, we count the grid point (xi, yj, zk) as in ; otherwise we count it as in Ω+. We call an edge (an edge of a tetrahedron in the tetrahedralization) an interface edge if two of its ends (vertices of tetrahedrons in the tetrahedralization) belong to different subdomains; otherwise we call it a regular edge.
We call a cell L an interface cell if its vertices belong to different subdomains. In the interface cell, we write L = L+ ⋃ L−. L+ and L− are separated by a plane segment, denoted by . There are two kinds of plane segment; see Figure 3. The vertices of the plane segment are located on the interface Γ, and their locations can be calculated from the linear interpolations of the discrete level-set functions ϕh = ϕ(xi, yj, zk). The vertices of L+ are located in Ω+ ⋃ Γ and the vertices of L− are located in Ω− ⋃ Γ. L+ and L−are approximations of the regions of L ⋂ Ω+ and L ⋂ Ω−, respectively. We call a cell L a regular cell if all its vertices belong to the same subdomain, either Ω+ or Ω−. For a regular cell, we also write L = L+ ⋃ L−, where L− = {} (empty set) if all vertices of L are in Ω+ and L+ = {} if all vertices of L are in Ω−. Clearly in a regular cell, and L+ and L− are approximations of the regions L ⋂ Ω+ and L ⋂ Ω−, respectively. We use |L+| and |L−| to represent the volumes of L+ and L−, respectively.
Two extension operators are needed. The first one is . For any , Th(ψh) is a standard continuous piecewise linear function, which is a linear function in every tetrahedron cell and Th(ψh) matches ψh on grid points. Clearly such a function set, denoted by , is a finite dimensional subspace of . The second extension operator Uh is constructed as follows. For any uh ∈ H1,h with uh = gh at boundary points, Uh(uh) is a piecewise linear function and matches uh on grid points. It is a linear function in each regular cell, just like the first extension operator Uh(uh) = Th(uh) in a regular cell. In each interface cell, it consists of two pieces of linear functions, one is on L+ and the other is on L−. The location of its discontinuity in the interface cell is the plane segment . Note that the vertices of the plane segment are located on the interface Γ, and hence the interface condition [u] = a is enforced exactly at the vertices of . In each interface cell, the interface condition [β∇u · n] = b is enforced with the value b at the barycenter of for Case 1 and at the points labeled “9” and “10” in Figure 3 for Case 2. Clearly such a function is not continuous in general, and neither is the set of such functions a linear space. We denote the set of such functions as , which should be thought as an approximation of the solution class H(a, c) (see (7)) plus the restriction of [β∇u · n] = b. Similar versions of such extension can be found in the literature [16, 34]. In Case 1, the number of unknowns matches with the number of the equations and the extension Uh is unique. In Case 2, the local construction problem is solved in a least square sense. The values of the points on the interface can be represented as a linear combination of a constant and the 8 unknown value of the vertices on the tetrahedron cell.
We propose the following method.
Method 4. Find a discrete function uh ∈ H1,h such that uh = gh on boundary points and so that for all , we have
Since our solution bases and test function bases are different, the matrix A for the linear system generated by Method 4 is not symmetric in the presence of an interface. However, we can prove that it is positive definite under certain assumptions. In all our numerical examples, A is positive definite numerically.
Theorem 5. If β is continuous and positive definite, then the matrix A for the linear system generated by Method 4 is positive definite.
Proof. For vector c ∈ R2n we have
In some applications [24], the matrix β is only semipositive definite with zero determinant. The previous Theorem does not apply. We prove later that when the matrix β is of certain form that frequently appeared in applications and semipositive definite, the matrix A generated by our method is still positive definite.
Theorem 6. If λ > 0, μ > 0 and , , , and , then the matrix A for the linear system generated by Method 4 is positive definite.
Proof. Suppose for a contradiction that A is not positive definite. Then there is a vector c ∈ R2n and c ≠ 0 such that cTAc ≤ 0. Let
Since for all a = [a1, a2, a3, a4, a5, a6] T ∈ R6,
So aTβa = 0 if and only if a1 = a6 = 0, a2 = −a5, and a3 = −a4. Then , for all .
However, implies that .
Since c = [c1, c2, …, c2n] T ≠ 0, without loss of generality, we assume that c1 ≠ 0. If we choose point such that and , i = 2,3, …, n, then , a contradiction.
Therefore cTAc > 0 for all c ≠ 0; thus, A is positive definite.
Remark 7. A positive definite matrix has positive determinant and is therefore invertible. It also has an LDMT factorization where D = diag (di) and di > 0, and L, M are lower triangular. The linear system Ax = b can be solved efficiently.
4. Numerical Experiments
All errors in solutions are measured in the L∞ norm in the whole domain Ω.
We present three numerical examples to demonstrate the effectiveness of our method.
Example 1. The level-set function ϕ(x, y, z), the coefficients , , , and , and the solution , in Example 1 are given as follows:
Table 1 shows the error on different grids. The numerical result shows second-order accuracy in the L∞ norm for the solution. Table 2 includes the condition number, which grows with order O(h−2), the same as the case without interface.
nx × ny × nz | Err in U | Order |
---|---|---|
11 × 11 × 11 | 0.00664 | |
22 × 22 × 22 | 0.00174 | 1.93 |
44 × 44 × 44 | 0.00046 | 1.90 |
88 × 88 × 88 | 0.00012 | 1.90 |
nx × ny × nz | Err in U | Order | Condition number |
---|---|---|---|
8 × 8 × 8 | 0.00944 | 80.49853 | |
16 × 16 × 16 | 0.00302 | 1.64 | 3.35416e + 002 |
32 × 32 × 32 | 0.00080 | 1.92 | 1.56186e + 003 |
Example 2. The level-set function ϕ(x, y, z), the coefficients , , , and , and the solution , in Example 2 are given as follows:
Table 3 shows the error on different grids. The numerical result shows more than 1.5th order accuracy in the L∞ norm for the solution. The degeneracy is due to the poor regularity of the solution.
nx × ny × nz | Err in U | Order |
---|---|---|
11 × 11 × 11 | 0.00641 | |
22 × 22 × 22 | 0.00210 | 1.61 |
44 × 44 × 44 | 0.00069 | 1.61 |
88 × 88 × 88 | 0.00022 | 1.63 |
Example 3. The level-set function ϕ(x, y, z), the coefficients , , , and , and the solution , in Example 3 are given as follows:
Table 4 shows the error on different grids. The numerical result shows second-order accuracy in the L∞ norm for the solution. This type of examples is also presented in [22, 27] in two dimensions. The coefficient matrices for the PDE meet the assumption in Theorem 6.
nx × ny × nz | Err in U | Order |
---|---|---|
11 × 11 × 11 | 0.11372 | |
22 × 22 × 22 | 0.03207 | 1.83 |
44 × 44 × 44 | 0.00839 | 1.93 |
88 × 88 × 88 | 0.00215 | 1.96 |
Example 4. The level-set function ϕ(x, y, z), the coefficients , , , and , and the solution , in Example 4 are given as follows:
Table 5 shows the error on different grids. The numerical result shows second-order accuracy in the L∞ norm for the solution. Compared with Example 3, the difference is that we have variable coefficient matrices of the same structure as those constant coefficient matrices in Example 3.
nx × ny × nz | Err in U | Order |
---|---|---|
11 × 11 × 11 | 0.13994 | |
22 × 22 × 22 | 0.04011 | 1.80 |
44 × 44 × 44 | 0.01036 | 1.95 |
88 × 88 × 88 | 0.00263 | 1.98 |
Example 5. The level-set function ϕ(x, y, z), the coefficients , , , and , and the solution , in Example 5 are given as follows:
Table 6 shows the error on different grids. The numerical result shows second-order accuracy in the L∞ norm for the solution. Compared with Example 4, the difference is that we used general variable coefficient matrices without the special structure in Example 4 to demonstrate that our method can handle more general problems.
nx × ny × nz | Err in U | Order |
---|---|---|
11 × 11 × 11 | 0.09240 | |
22 × 22 × 22 | 0.02498 | 1.89 |
44 × 44 × 44 | 0.00635 | 1.96 |
88 × 88 × 88 | 0.00160 | 1.99 |
Example 6. The level-set function ϕ(x, y, z), the coefficients β1(x, y, z), β2(x, y, z), β3(x, y, z), and β4(x, y, z), and the solution , in this example are given as follows:
When it is 11 × 11 × 11 grids, we get the result of Table 7. When it is 22 × 22 × 22 grids, we get the result of Table 8. We plot the condition number versus the ratio between β− and β+ for 11-by-11-by-11 grid in Figure 4 and 22-by-22-by-22 grid in Figure 5. The correlation coefficients for 11-by-11-by-11, 22-by-22-by-22 grids are 0.999990 and 0.999987, which are clearly linear relations.
β− = β+ × n | Err in U | Condition number |
---|---|---|
β− = β+ × 1 | 0.07981 | 2.63433e + 002 |
β− = β+ × 50 | 0.20388 | 1.31957e + 004 |
β− = β+ × 100 | 0.39149 | 2.67980e + 004 |
β− = β+ × 150 | 0.54457 | 4.04338e + 004 |
β− = β+ × 200 | 0.67088 | 5.40725e + 004 |
β− = β+ × 250 | 0.77679 | 6.77095e + 004 |
β− = β+ × 300 | 0.86828 | 8.13431e + 004 |
β− = β+ × n | Err in U | Condition number |
---|---|---|
β− = β+ × 1 | 0.02173 | 1.08341e + 003 |
β− = β+ × 50 | 0.08743 | 5.29426e + 004 |
β− = β+ × 100 | 0.15283 | 1.07574e + 005 |
β− = β+ × 150 | 0.21488 | 1.62334e + 005 |
β− = β+ × 200 | 0.27731 | 2.17177e + 005 |
β− = β+ × 250 | 0.33511 | 2.72071e + 005 |
β− = β+ × 300 | 0.38877 | 3.26954e + 005 |


5. Conclusion
In this paper, we modified the method in [27] to solve the 3D elasticity problem with sharp-edged interfaces. Due to the more complicated geometry in 3D, this is not a trivial extension. We proved that the matrix for the linear system generated by our method is positive definite (but not symmetric) under certain assumption. Through numerical experiments, our method achieved close to second-order accuracy in the L∞ norm for piecewise smooth solutions, and we can handle the difficulties of sharp-edged interfaces and singular solutions. The condition number of the large sparse linear system grows with order O(h−2), the same as the case without interface. The condition number also grows only linearly with the ratio between β− and β+.
Acknowledgment
L. Wang’s research is supported by the Science Foundation of China University of Petroleum, Beijing (no. YJRC-2013-48). S. Hou’s research is supported by NSF grant DMS-1317994.