Abstract
The Immersed Boundary (IB) method is a mathematical framework for constructing robust numerical methods to study fluid–structure interaction in problems involving an elastic structure immersed in a viscous fluid. The IB formulation uses an Eulerian representation of the fluid and a Lagrangian representation of the structure. The Lagrangian and Eulerian frames are coupled by integral transforms with delta function kernels. The discretized IB equations use approximations to these transforms with regularized delta function kernels to interpolate the fluid velocity to the structure, and to spread structural forces to the fluid. It is well-known that the conventional IB method can suffer from poor volume conservation since the interpolated Lagrangian velocity field is not generally divergence-free, and so this can cause spurious volume changes. In practice, the lack of volume conservation is especially pronounced for cases where there are large pressure differences across thin structural boundaries. The aim of this paper is to greatly reduce the volume error of the IB method by introducing velocity-interpolation and force-spreading schemes with the properties that the interpolated velocity field in which the structure moves is at least and satisfies a continuous divergence-free condition, and that the force-spreading operator is the adjoint of the velocity-interpolation operator. We confirm through numerical experiments in two and three spatial dimensions that this new IB method is able to achieve substantial improvement in volume conservation compared to other existing IB methods, at the expense of a modest increase in the computational cost. Further, the new method provides smoother Lagrangian forces (tractions) than traditional IB methods. The method presented here is restricted to periodic computational domains. Its generalization to non-periodic domains is important future work.
Keywords: Immersed Boundary method, Fluid–structure interaction, Incompressible flow, Volume conservation, Velocity interpolation, Force spreading
1. Introduction
The Immersed Boundary (IB) method [34] is a general mathematical framework for the numerical solution of fluid-structure interaction problems arising in biological and engineering applications. The IB method was introduced to simulate flow patterns around the heart valves [32,33], and since its success in modeling cardiac fluid dynamics [31,15,16,14], it has been extended and applied to various other applications, including but not limited to motion of biological swimmers [3,30], dynamics of red-blood cells [9] and dry foam [21,22], and rigid body motion [20,43].
The essence of the IB method as a numerical scheme lies in its simple way of coupling an Eulerian representation of the fluid and a Lagrangian representation of the structure. The force spreading linear operator S that spreads forces (stresses) from the structure to the fluid and the velocity interpolation linear operator S⋆ that interpolates velocities from the fluid to the structure are carried out via a regularized delta function δh. One effective way to construct δh is to require the regularized delta function to satisfy a set of moment conditions to achieve approximate grid translation-invariance and desired interpolation accuracy [1,2], thereby avoiding special grid treatment near the fluid–structure interface. In spite of its wide applicability and ease of implementation, the conventional IB method with a collocated-grid discretization (referred to herein as IBCollocated) has two well-known shortcomings in accuracy: it achieves only first-order convergence for problems that possess sharp-interface solutions [26,19], and it can be relatively poor of volume conservation [35]. Much research effort has been put into improving the convergence rate of the IB method to second order or even higher order for problems with singular forcing at the sharp interface. Notable examples include, the Immersed Interface Method (IIM) [28,27], and more recently, a new method known as Immersed Boundary Smooth Extension [37,38]. Our focus here, however, is on improving the volume conservation properties of the IB method.
As an immediate consequence of fluid incompressibility, which is one of the basic assumptions of the IB formulation, the volume enclosed by the immersed structure is exactly conserved as it deforms and moves with the fluid in the continuum setting. Thus, a desirable feature of an IB method is to conserve volume as nearly as possible. In practice, however, it is observed that, even in the simplest case of a quasi-static pressurized membrane [17], the conventional IB method (regardless of collocated- or staggered-grid discretization) produces volume error that persistently grows in time, as if fluid “leaks” through the boundary. An intuitive explanation for this “leak” is that fluid is “squeezing” between the marker points used to discretize the boundary in a conventional IB method; however, this is not the full story, because refining the Lagrangian discretization does not improve the volume conservation of the method for a fixed Eulerian discretization.
In the conventional IB method, we can extend the notion of velocity interpolation to any point in the domain (not restricted to the immersed structure), denoted here with an italic X. The continuous interpolated velocity field can be written as , where denotes the continuous interpolation operator that interpolates the velocity at X from the discrete fluid velocity u. If a closed surface moves with velocity that is continuously divergence-free with respect to the continuum divergence operator, i.e., (∇ · U)(X) = 0, then the volume enclosed by the (deformed) surface will be exactly conserved. However, in the discrete setting, even if the interpolated velocity field is continuously divergence-free, exact volume conservation is generally not achieved because of the time-stepping error from the temporal integrator. Another source of error comes from discretizing the surface itself. In the IB method, only a discrete collection of points on the surface, i.e., the Lagrangian markers, move according to the interpolated velocity field. A closed discretized surface can be constructed by simply connecting the Lagrangian markers defining a facet, and the resulting faceted surface by this construction does not enclose a constant volume. In the absence of temporal integration errors, this kind of volume-conservation error will approach zero as the discretization of the surface is refined. Peskin and Printz realized that the major cause of poor volume conservation of IBCollocated is that the continuous interpolated velocity field given by the conventional IB interpolation operator (denoted by ) is not continuously divergence-free [35], despite that the discrete fluid velocity is enforced to be discretely divergence-free with respect to the discrete divergence operator by the fluid solver.
To improve the volume conservation of the conventional IB method, Peskin and Printz proposed a modified finite-difference approximation to the discrete divergence operator to ensure that the average of the continuous divergence of the interpolated velocity is equal to zero in a small control volume with size of a grid cell [35]. Their IB method with modified finite-difference operators (herein referred to as IBModified) was applied to a two-dimensional model of the heart, and it achieved improvement in volume conservation by one-to-two orders of magnitude compared to IBCollocated. Nevertheless, a major drawback of IBModified that limits its use in applications is its complex, non-standard finite-difference operators that uses coefficients derived from the regularized delta function (but see [21,22] for applications). To address the issue of spurious currents across immersed structure supporting extremely large pressure differences, Guy and Strychalski [39] developed a different extension of the IB method that uses non-uniform Fast Fourier Transform [8,12] (NUFFT) to generate “spectral” approximations to the delta function, which also has superior volume conservation.
Over the past two decades, the staggered-grid (MAC) discretization has been widely adopted by the IB community [15, 14,3,20,43,7]. In addition to its most celebrated feature of avoiding the odd-even decoupling in the Poisson solver that can otherwise occur with collocated-grid discretization, which leads to “checkerboard” instability in the solutions, Griffith [17] concluded from his numerical studies that the improvement in volume conservation of the IB method with staggered-grid discretization (IBMAC) is essentially the same as that of IBModified. In practice, IBMAC is more practical than IBModified in that the improvement in volume conservation directly comes as a byproduct of grid discretization without any modification to the finite-difference operators, and it is relatively straightforward to extend IBMAC to include adaptive mesh refinement [15,36] and physical boundary conditions [13]. However, we emphasize that the nature of Lagrangian velocity interpolation of IBMAC remains the same as that of IBCollocated, and, hence, there is much room for further improvement in volume conservation by ensuring that the interpolated velocity is constructed to be nearly or exactly divergence-free. We note that the methods designed to improve the convergence rate of IB methods, such as IIM [28,27] and the Blob-Projection method [5], also improve volume conservation, because the solution near the interface is computed more accurately. These methods, however, are somewhat more complex and less generalizable than the conventional IB method.
This paper is concerned with further improving volume conservation of IBMAC by constructing a continuous velocity-interpolation operator that is divergence-free in the continuous sense. The discrete IB interpolation operator S⋆ is simply the restriction of to the Lagrangian markers. The key idea introduced in this paper is first to construct a discrete vector potential that lives on an edge-centered staggered grid from the discretely divergence-free fluid velocity, and then to apply the conventional IB interpolation scheme to obtain a continuum vector potential, from which the interpolated velocity field is obtained by applying the continuum curl operator. Note that the existence of the discrete vector potential relies on the fact that the discrete velocity field is discretely divergence-free. The interpolated velocity field obtained in this manner is guaranteed to be continuously divergence-free, since the divergence of the curl of any vector field is zero. We also propose a new force-spreading operator S that is defined to be the new adjoint of the interpolation operator S⋆, so that Lagrangian–Eulerian interaction conserves energy. The Eulerian force density that is the result of applying this force-spreading operator to a Lagrangian force field turns out to be discretely divergence-free, so we refer to this new force-spreading operation as divergence-free force spreading. We name the IB method equipped with the new interpolation and spreading operators as the Divergence-Free Immersed Boundary (DFIB) method. As presented here, the DFIB method is limited to periodic domains.
In contrast to the local nature of interpolation and spreading in the conventional IB method, the spreading and interpolation operators of the DFIB method turn out to be non-local in that their construction requires the solution of discrete Poisson equations, although these operators can be evaluated efficiently using the Fast Fourier Transform (FFT) or multigrid methods. Another new feature of our method is that transferring information between the Eulerian grid and the Lagrangian mesh involves derivatives of the regularized delta function ∇δh instead of only δh. We confirm through various numerical tests in both two and three spatial dimensions that the DFIB method is able to reduce volume error by several orders of magnitude compared to IBMAC and IBModified at the expense of only a modest increase in the computational cost. Moreover, we confirm that the volume error for DFIB decreases as the Lagrangian mesh is refined with the Eulerian grid size held fixed, which is not the case in the conventional IB method [35]. In addition to the substantial improvement in volume conservation, the DFIB method is quite straightforward to realize from an existing modular IB code with staggered-grid discretization, that is, by simply switching to the new velocity-interpolation and force-spreading schemes while leaving the fluid solver and time-stepping scheme unchanged.
The rest of the paper is organized as follows. In Sec. 2, we begin by giving a brief description of the continuum equations of motion in the IB framework. Then we define the staggered grid on which the fluid variables live and introduce the spatial discretization of the equations of motion. Sec. 3 introduces the two main contributions of this paper: divergence-free velocity interpolation and force spreading. In Sec. 4, we present a formally second-order time-stepping scheme that is used to evolve the spatially-discretized equations, followed by a cost comparison of DFIB and IBMAC. Numerical examples of applying DFIB to problems in two and three spatial dimensions are presented in Sec. 5, where the volume-conserving characteristics of the new scheme are assessed.
2. Equations of motion and spatial discretization
2.1. Equations of motion
This section provides a brief description of the continuum equations of motion in the IB framework [34]. We assume a neutrally-buoyant elastic structure Γ that is described by the Lagrangian variables s, immersed in a viscous incompressible fluid occupying the whole fluid domain that is described by the Eulerian variables x. Eqs. (2.1) and (2.2) are the incompressible Navier–Stokes equations describing mass and momentum conservation of the fluid, in which u(x, t) denotes the fluid velocity, p(x, t) is the pressure, and f (x, t) is the Eulerian force density (force per unit volume) exerted by the structure on the fluid. In this formulation, we assume that the density ρ and the viscosity μ of the fluid are constant. The fluid–structure coupled equations are:
(2.1) |
(2.2) |
(2.3) |
(2.4) |
(2.5) |
Eqs. (2.3) and (2.4) are the fluid–structure interaction equations that couple the Eulerian and the Lagrangian variables. Eq. (2.3) relates the Lagrangian force density F(s, t) to the Eulerian force density f (x, t) using the Dirac delta function, where is the physical position of the Lagrangian point s. Eq. (2.4) is simply the no-slip boundary condition of the Lagrangian structure, i.e., the Lagrangian point moves at the same velocity as the fluid at that point. In Eq. (2.5), the system is closed by expressing the Lagrangian force density F(s, t) in the form of a force density functional , which in many cases can be derived from an elastic energy functional by taking the variational derivative, denoted here by , of the elastic energy.
2.2. Spatial discretization
Throughout the paper, we assume the fluid occupies a periodic domain Ω = [0, L]3 that is discretized by a uniform N × N × N Cartesian grid with meshwidth . Each grid cell is indexed by (i, j, k) for i, j, k = 0, …, N − 1. For the Eulerian fluid equations, we use the staggered-grid discretization, in which the pressure p is defined on the cell-centered grid (Fig. 1a), denoted by , i.e., at positions . The discrete fluid velocity u is defined on the face-centered grid (Fig. 1b), denoted by , with each component perpendicular to the corresponding cell faces, i.e., at positions , and for each velocity component respectively. We also introduce two additional shifted grids: the node-centered grid (Fig. 1a) for scalar grid functions, denoted by , i.e., at positions , and the edge-centered grid (Fig. 1c) for vector grid functions, denoted by , with each component defined to be parallel to the corresponding cell edges i.e., at positions , and for each component respectively. In Sec. 3, we will use these half-shifted staggered grids to construct divergence-free velocity interpolation and force spreading.
To discretize the differential operators in Eqs. (2.1) and (2.2), we introduce the central difference operators corresponding to the partial derivatives ∂/∂xα,
(2.6) |
where φ is a scalar grid function and {e1, e2, e3} is the standard basis of . We can use to define the discrete gradient, divergence and curl operators:
(2.7) |
(2.8) |
(2.9) |
where v is a vector grid function, ϵijk is the totally antisymmetric tensor, and the Einstein summation convention is used here. The discrete differential operators may be defined on different pairs of domain and range (half-shifted staggered grids), and therefore, in a slight abuse of notation, we will use the same notation to denote the different operators,
(2.10) |
(2.11) |
(2.12) |
Although the curl operator does not appear in the equations of motion explicitly, we define it here for use in Sec. 3. The discrete scalar Laplacian operator can be defined by Lh = Dh · Gh, which yields the familiar compact second-order approximation to ∇2:
(2.13) |
Note that the range and domain of Lh are a set of grid functions defined on the same grid, and that grid can be or or any of the three subgrids of or on which the different components of vector-valued functions are defined. We will use the notation Lh to denote the discrete vector Laplacian operator that applies (the appropriately shifted) Lh to each component of a vector grid function.
2.2.1. Advection
We follow the same treatment of discretization of the advection term as in earlier presentations of the IB method [7]. From the incompressibility of the fluid flow ∇ · u = 0, we can write the advection term in the skew-symmetric form
(2.14) |
Let N(u) denote the discretization of Eq. (2.14), and we define
(2.15) |
where ũ denotes an averaged collocated advective velocity whose components all live on the same grid as uα. The advective velocity ũ in [7] is obtained by using the same interpolation scheme as the one used for moving the immersed structure. In our work, we simply take the average of u on the grid. For example, the three components of ũ in the x-component equation are
Note that in the y- and z-component equations, we need different averages of u to construct ũ. We choose to use the wide-stencil operators in Eq. (2.15) so that the resulting grid functions are all defined on the same grid as uα. A more compact discretization of the advection term has been previously described in [17,13,42].
2.2.2. Fluid–structure interaction
The immersed structure Γ is discretized by a Lagrangian mesh of M points or markers, denoted here by a non-italic , and the discrete Lagrangian force densities defined on the Lagrangian markers are . As discussed in the introduction, we can extend the notion of velocity interpolation to any point X, in the domain, not just restricted to the Lagrangian markers X, and define a continuous interpolated velocity field . In the conventional IB method, the continuous velocity-interpolation operator can be defined as
(2.16) |
We note that the interpolated velocity field given by Eq. (2.16) is not generally divergence-free with respect to the continuum divergence operator,1 i.e., generally
(2.17) |
even if u is discretely divergence-free with respect to the discrete divergence operator. The restriction of to the collection of Lagrangian markers X defines the discrete IB interpolation operator
(2.18) |
We will also develop a new force-spreading operator S[X] that is the adjoint of the new velocity-interpolation operator S⋆[X]. Here we use the notation [X] to emphasize that these linear operators are parametrized by the position of the markers, as will be important when discussing temporal integration.
The discretization of the interaction equations (Eqs. (2.3) and (2.4)) can be concisely written in the form
(2.19) |
(2.20) |
Where f is the discrete Eulerian force density defined on the appropriate subgrid of for each component, and denotes the interpolated velocities at the Lagrangian markers X. In the conventional IB method, the force-spreading operator SIB and the velocity-interpolation operator are simply discrete approximations of the surface and volume integrals in Eqs. (2.3) and (2.4), i.e.,
(2.21) |
(2.22) |
and they are adjoint operators with respect to the power identity (inner product) defined later in Eq. (3.10). Note that Eq. (2.22) is a vector equation. For each of the three components of the equation, the sum is to be understood here and in similar expressions as the sum over the appropriate subgrid of . In Eqs. (2.21) and (2.22), the Dirac delta function is replaced by a regularized delta function δh to facilitate the coupling between the Eulerian and Lagrangian grids, which is taken to be of the tensor-product form
(2.23) |
where ϕ(r) denotes the one-dimensional immersed-boundary kernel that is constructed from a set of moment conditions to achieve approximate grid translation invariance [34,2].
In the following section, we will develop a new velocity-interpolation operator that produces a continuously divergence-free interpolated velocity field constructed from a discretely divergence-free discrete fluid velocity.
In summary, the spatially-discretized equations of motion are
(2.24) |
(2.25) |
(2.26) |
3. Divergence-free velocity interpolation and force spreading
This section presents the two main contributions of this paper: divergence-free velocity interpolation and force spreading. Familiarity with discrete differential operators on staggered grids and with some discrete vector identities, reviewed and summarized in Appendix A, will facilitate the reading of this section.
3.1. Divergence-free velocity interpolation
Here we introduce a new recipe for constructing an interpolated velocity field that is continuously divergence-free with respect to the continuum divergence operator, i.e., (∇ · U)(X) = 0 for all X. For now we drop the dependence on time and emphasize again that X is an arbitrary position in the domain , not just on the Lagrangian structure Γ. The main idea is first to construct a discrete vector potential a(x) that is defined on the edge-centered staggered grid \mathbb{E}, and then to apply the conventional IB interpolation to a(x) to obtain a continuum vector potential A(X), so that the Lagrangian velocity defined by U(X) = (∇ × A)(X) is automatically divergence-free.
Suppose the discrete velocity field u(x) is defined on and is discretely divergence-free, i.e., Dh · u = 0. Let u0 be the mean of u(x),
(3.1) |
where is the volume of the domain. Using the Helmholtz decomposition, we construct a discrete velocity potential a(x) for that satisfies
(3.2) |
where the requirement that a(x) is discretely divergence-free is an arbitrary gauge condition that makes a(x) uniquely defined up to a constant. If the gauge condition of a(x) is omitted in Eq. (3.2), then the discrete velocity potential a(x) is only uniquely defined up to Ghψ, where ψ is some unknown scalar grid function defined on . Note that Dh · a is a scalar field defined on . In Appendix B, we prove that the discrete vector potential a(x) defined by Eq. (3.2) exists (see Theorem 3). To determine a(x) explicitly, we take the discrete curl of the first equation in Eq. (3.2) and use the identity Eq. (A.3) with the gauge condition of a(x), which leads to a vector Poisson equation for a(x),
(3.3) |
that can be efficiently solved. Note that the solution of the Poisson problem Eq. (3.3) determines a(x) up to an arbitrary constant (it is not necessary to uniquely determine a(x) because the constant term vanishes upon subsequent differentiation).
The next step is to interpolate the discrete vector potential a(x) to obtain the continuum vector potential
(3.4) |
Lastly, we take the continuum curl of A(X) with respect to X,
(3.5) |
and our new interpolation is completed by adding the mean flow u0, that is,
(3.6) |
We note that the interpolation Eq. (3.4) is not performed in the actual implementation of the scheme. Instead, ∇δh is computed on the edge-centered staggered grid in Eq. (3.6). Notice that, by construction, the interpolated velocity in Eq. (3.6) is continuously divergence-free.
There are two important features of our new interpolation scheme that are worth mentioning. First, in comparison to locally interpolating the velocity from the nearby fluid grid in the conventional IB method, our new interpolation scheme is non-local, in that it involves solving the discrete Poisson problem Eq. (3.3). Second, if the regularized delta function δh is , we note that the interpolated velocity field given by Eq. (3.6) is a globally-defined function that is . We can think of the regularized delta function concentrated at X as being defined everywhere with zero outside a cube of fixed edge length (e.g. 6h for the 6-point kernel [2]). Moreover, the continuity of derivatives of δh also applies globally, including at the edges for the cube. Since the continuum vector potential defined by Eq. (3.4) is a finite sum of such functions, and the interpolated velocity field U(X) is obtained by differentiating A(X) once, then the resulting interpolated velocity field must have k − 1 continuous derivatives. Note that if we use an IB kernel that is , then the interpolated velocity U is , and ∇ · U is defined in only a piecewise manner. This naturally brings into question whether the volume of a closed surface is strictly conserved as the surface passes over the discontinuity of the velocity derivatives. Indeed, we observe numerically that the DFIB method offers only marginal improvement in volume conservation for kernel functions, such as the standard 4-point kernel [34], unless the Lagrangian mesh is discretized with impractically high resolution (8 markers per fluid meshwidth, see Fig. 5). By contrast, we will show that with only a moderate Lagrangian mesh size (1 to 2 markers per fluid meshwidth), the DFIB method offers a substantial improvement in volume conservation for kernels of higher smoothness, which gives a continuously differentiable interpolated velocity U. Further, we observe that volume conservation of the DFIB method improves with the smoothness of the interpolated velocity field.
In addition to the standard 4-point kernel (denoted by ϕ4h), the IB kernels considered in this paper include the 5-point and 6-point kernels [1,2] (denoted by and , respectively), and the 4-point B-spline kernel [40],
(3.7) |
and the 6-point B-spline kernel,
(3.8) |
These B-spline kernels are members of a sequence of functions obtained by recursively convolving each successive kernel function against a rectangular pulse (also known as the window function), starting from the window function itself [40]. The limiting function in this sequence is a Gaussian [41], which is exactly translation-invariant and isotropic. The family of IB kernels with nonzero even moment conditions, such as ϕ4h and , also have a Gaussian-like shape, but it is not currently known whether this sequence of functions also converges to a Gaussian.
3.2. The force-spreading operator
The force-spreading operator S is constructed to be adjoint to the velocity-interpolation operator S⋆ so that energy is conserved by the Lagrangian–Eulerian interaction,
(3.9) |
where (·, ·)x and (·, ·)X denote the corresponding discrete inner products on the Eulerian and Lagrangian grids. In other words, the power generated by the elastic body forces is transferred to the fluid without loss,2
(3.10) |
where Um is the Lagrangian marker velocity at Xm, and FmΔs is the Lagrangian force applied to the fluid by the Lagrangian marker Xm. Our goal is to find an Eulerian force density f(x) that satisfies the power identity Eq. (3.10). To see what Eq. (3.10) implies about f(x), we rewrite both sides in terms of a(x). On the left-hand side of Eq. (3.10), we use Eq. (3.2) to obtain
(3.11) |
where the average of f(x) over the domain is
(3.12) |
Note that we have used the summation-by-parts identity Eq. (A.5) to transfer the discrete curl operator Dh× from a(x) to f(x), and thus, the grid on which the summation is performed in Eq. (3.11) is not . On the right-hand side of Eq. (3.10), we substitute for Um by using the divergence-free velocity interpolation Eq. (3.6),
(3.13) |
Since u0 and a(x) are arbitrary (except for Dh · a = 0), the power identity Eq. (3.10) is satisfied if and only if
(3.14) |
and
(3.15) |
where φ is an arbitrary scalar field that lives on the node-centered grid . Note that we have the freedom to add the term Ghφ in Eq. (3.15), since from the identity Eq. (A.4) and Dh · a = 0, we have
Indeed, we are required to include this term since the left-hand side of Eq. (3.15) is discretely divergence-free but there is no reason to expect the first term on the right-hand side of Eq. (3.15) is also divergence-free. Note that it is not required to find φ in order to determine f(x), because we can eliminate φ by taking the discrete curl on both sides of Eq. (3.15),
(3.16) |
By imposing the gauge condition
(3.17) |
we obtain a vector Poisson equation for f(x),
(3.18) |
Note again that ∇δh is computed on , so that the cross-product with Fm is face-centered, which agrees with the left-hand side of Eq. (3.18). Note that the solution of Eq. (3.18) can be uniquely determined by the choice of f0. Like our velocity interpolation scheme, the new force-spreading scheme is also non-local because it requires solving discrete Poisson equations. We remark that the new force-spreading scheme is also constructed so that the resulting force density f(x) is discretely divergence-free. This means that f(x) includes the pressure gradient that is generated by the Lagrangian forces. We do not see a straightforward way to separate the pressure gradient from f(x) in case it is needed for output purposes.
4. Time-stepping scheme
In this section, we present a second-order time-stepping scheme, similar to the ones developed previously [14], that evolves the spatially-discretized system Eqs. (2.24) to (2.26). Let un, Xn denote the approximations of the fluid velocity and Lagrangian marker velocities at time tn = nΔt. To advance the solutions to un+1 and Xn+1, we perform the following steps:
Step 1. First, update the Lagrangian markers to the intermediate time step using the interpolated velocity,
(4.1) |
Step 2. Evaluate the intermediate Lagrangian force density at from the force density functional or the energy functional, and spread it to the Eulerian grid using the force-spreading scheme to get
(4.2) |
Step 3. Solve the fluid equations on the periodic grid [7],
(4.3) |
where the second-order Adams–Bashforth (AB2) method is applied to approximate the nonlinear advection term
(4.4) |
and Nn = N(un).
Step 4. In the last step, update the Lagrangian markers Xn+1 by using the mid-point approximation
(4.5) |
Note that the time-stepping scheme described above requires two starting values because of the treatment of the nonlinear advection term using the AB2. To get the starting value at t = Δt, we can use the second-order Runge–Kutta (RK2) scheme described in [34,7].
In Table 1 we compare the cost of DFIB and IBMAC for the above IB scheme in terms of the number of the two cost-dominating procedures: the scalar Poisson solver which costs using FFT on the periodic domain, where d ∈ {2, 3} is the spatial dimension, and spreading/interpolation of a scalar field between the Eulerian grid and the Lagrangian mesh which costs . In summary, DFIB is only more expensive than IBMAC by 4 scalar Poisson solves for two-dimensional (2D) problems, and is more expensive by 9 scalar Poisson solves and 9 scalar interpolation and spreading for three dimensional (3D) problems. Therefore, the DFIB method is about two times slower than IBMAC per time step in 3D. We point out that if the RK2 scheme [34,7] is employed rather than the scheme above, then we can save one interpolation step per time step, but the fluid equations need to be solved twice.
Table 1.
5. Numerical results
This section presents numerical results of the DFIB method for various benchmark problems in 2D and 3D. We first consider in 2D a thin elastic membrane subject to surface tension of the membrane only. The continuum solution of this simple 2D problem has the special feature that the tangential component of the elastic force vanishes, and therefore, the normal derivative of the tangential fluid velocity does not suffer any jump across the immersed boundary. This has the effect that second-order convergence in the fluid velocity u and the Lagrangian deformation map X can be achieved [19]. In the second set of tests, we compare volume conservation in 2D, i.e., area conservation of DFIB and IBMAC by applying them to a circular membrane under tension, and we discuss the connection between area conservation and the choice of Lagrangian marker spacing relative to the Eulerian grid size. In the third set of computations, we apply the DFIB method to a problem in which a 2D elastic membrane actively evolves in a parametrically-forced system. In the last set of numerical experiments, we extend the surface tension problem to 3D, and compare volume conservation of DFIB with that of IBMAC.
5.1. A thin elastic membrane with surface tension in 2D
It is well-known that the solutions to problems involving an infinitely thin massless membrane interacting with a viscous incompressible fluid possess jump discontinuities across the interface in the pressure and in the normal derivative of the velocity due to singular forcing at the interface [27,25]. These sharp jump discontinuities cannot be fully resolved by the conventional IB method because of the use of the regularized delta function at the interface. Consequently, the numerical convergence rate for the Lagrangian deformation map X. is generally only first order even if the discretization is carried out with second-order accuracy. To achieve the expected rate of convergence, we consider problems with solutions that possess sufficient smoothness.
As a simple benchmark problem with a sufficiently smooth continuum solution we consider a thin elastic membrane that deforms in response to surface tension only. Suppose that the elastic interface Γ is discretized by a collection of Lagrangian markers X = {X1,…,XM}. The discrete elastic energy functional associated with the surface tension of the membrane is the total (polygonal) arc-length of the interface [21],
(5.1) |
where X0 = XM and γ is the surface tension constant (energy per unit length). The Lagrangian force generated by the energy functional at the marker Xm is
(5.2) |
In our tests, we set the initial configuration of the membrane to be the ellipse
(5.3) |
The Eulerian fluid domain Ω = [0, L]2 is discretized by a uniform N × N Cartesian grid with meshwidth in each direction. The elastic interface Γ is discretized by a uniform Lagrangian mesh of size M = [πN] in the Lagrangian variable s, so that the Lagrangian markers X = {X1,…,XM} are physically separated by a distance of approximately in the equilibrium circular configuration. In all of our tests, we set L = 5, ρ = 1, γ = 1, μ = 0.1. The time step size is chosen to be to ensure the stability of all simulations up to t = 20 when the elastic interface is empirically observed to be in equilibrium.
We denote by uN(t) the computed fluid velocity field and by a restriction operator from the finer grid of size 2N × 2N to the coarser grid of size N × N. The discrete lp-norm of the successive error in the velocity component ui is defined by
(5.4) |
To avoid artifacts in the error-norm computation because of Lagrangian markers getting too clustered during the simulation, we reparametrize the interface (for the purpose of the error computation only) from the computed markers using periodic cubic splines after each time step, and compute the lp-norm error of X based on a collection of M′ uniformly sampled markers from the reparametrized interface, that is,
(5.5) |
where M′ does does not change with N. We emphasize that the resampled markers are only used to compute the error norm and are discarded after each time step. In Fig. 2 the successive l∞-norm and l2-norm errors of the x, y-component of the fluid velocity and of the deformation map are plotted as a function of time from t = 0 to t = 20 for grid resolution N = 64, 128 and 256. The number of resampled markers for computing is M′ = 128. To clearly visualize that second-order convergence is achieved by our scheme, we multiply the computed errors for the finer grid resolution N = 128 and 256 by a factor of 4 and 42 respectively, and plot them along with errors for the coarser grid resolution N = 64 in Fig. 2. The observation that all three error curves almost align with each other (as shown in Fig. 2) confirms that second-order convergence in u and X is achieved.
5.2. Area conservation and IB marker spacing
As an immediate consequence of fluid incompressibility, the volume enclosed by a closed immersed boundary should be exactly conserved as it deforms and moves with the fluid. However, it is observed that even in the simplest scenario of a pressurized membrane in its circular equilibrium configuration [17], the volume error of an IB method with conventional interpolation and spreading systematically grows at a rate proportional to the pressure jump across the elastic interface [35]. In this set of tests, we demonstrate that, the “volume” or area enclosed by a 2D membrane is well-conserved by the DFIB method when the Lagrangian interface is sufficiently resolved.
We follow the same problem setup as in the test described in [17]. A thin elastic membrane , initially in a circular equilibrium configuration,
(5.6) |
is immersed in a periodic unit cell Ω = [0, 1]3 with zero initial background flow. The Lagrangian force density on the interface is described by
(5.7) |
in which κ is the uniform stiffness coefficient. The elastic membrane is discretized by a uniform Lagrangian mesh of M points in the variable s. We approximate the Lagrangian force density by
(5.8) |
which corresponds to a collection of Lagrangian markers connected by linear springs of zero rest length with stiffness κ. For this problem, since the elastic interface is initialized in the equilibrium configuration with zero background flow, any spurious fluid velocity and area loss incurred in the simulation are regarded as numerical errors.
In our simulations, we set ρ = 1, μ = 0.1, κ = 1. The size of the Eulerian grid is fixed at 128 × 128 with meshwidth . The size of the Lagrangian mesh M is chosen so that two adjacent Lagrangian markers are separated by a physical distance of hs in the equilibrium configuration, that is, M ≈ 2πR/hs, where R is the radius of the circular membrane. In addition to the Lagrangian markers, we also include a dense collection of passive tracers with Ntracer = 20M to address the limiting case of moving the entire interface. These tracers are initially in the same configuration as the circular membrane in Eq. (5.6), and they move passively with the interpolated velocity according to Eqs. (4.1) and (4.5). The time step size is set to be for stability. In all computations, we use the 6-point IB kernel to form the regularized delta function δh.
In Fig. 3 we compare the computational results of DFIB with those of IBMAC for different hs = 4h, 2h, h and (from left to right in Fig. 3). Each subplot of Fig. 3 shows a magnified view of the same arc of the circular interface along with its nearby spurious fluid velocity field. The interface represented by the Lagrangian markers X(t = 1) is shown in red and the initial configuration X(t = 0) is shown in the blue curve. The interface represented by the passive tracers Xtracer(t = 1) is shown in the yellow curve. In the first column of Fig. 3 in which hs = 4h, we see that the maximum spurious velocity ∥u∥∞ of IBMAC is of the same magnitude as that of DFIB. At such coarse resolution in the Lagrangian mesh, fluid apparently leaks through the gap between two adjacent markers, as can be observed by the wiggly pattern in the passive tracers. As the Lagrangian mesh is refined gradually from hs = 4h to (from left to right in Fig. 3), we see that ∥u∥∞ decreases from 10−3 to 10−7 in the DFIB method, whereas ∥u∥∞ stops improving around 10−4 in IBMAC. Moreover, in the columns where hs = 2h, h, , we see a clear global pattern in the spurious velocity field in IBMAC, while the spurious velocity field of DFIB appears to be much smaller in magnitude and random in pattern.
We define the normalized area error with respect to the initial configuration
(5.9) |
where the area enclosed by the Lagrangian markers A(t; X) is approximated by the area of the polygon formed by the Lagrangian markers X = {X1, …, XM} at time t. Figs. 4 and 5 show the normalized area errors defined by Eq. (5.9) for DFIB and IBMAC with different choices of the IB kernels: , , , and . For the coarse Lagrangian marker spacings, for example, when hs = 2h, 4h, the area errors for IBMAC and DFIB have similar orders of magnitude (compare Fig. 4a, 4b to Fig. 4d, 4e). As the Lagrangian marker spacing is reduced from 2h to h, we see a decrease in ΔA(t;X) for IBMAC by approximately a factor of 10 (see Fig. 4b, 4c) for all the IB kernels we consider in this set of tests. In contrast, the area errors for DFIB improve by at least a factor of 103 for the IB kernels that are at least (see Fig. 4e, 4f), and in the best scenario, ΔA(t; X) for decreases from 10−4 to 10−9. Moreover, as the Lagrangian mesh is refined from h to , area errors for DFIB keep improving, even approaching the machine epsilon in double precision for at and for at (see Fig. 5e, 5f). For a moderate Lagrangian marker spacing, such as hs = h and , area errors for DFIB are several orders of magnitude smaller than those of IBMAC. On the other hand, area errors for IBMAC stop improving around 10−5 for hs ≤ h, no matter how densely the Lagrangian mesh is refined (see Figs. 4c, 5c). We remark that the smoothness of the IB kernel appears to play an important role in volume conservation of DFIB. In this study DFIB achieves the best volume conservation result for hs ≤ h with , and this kernel also has the highest regularity of the kernel functions considered in this work.
The area errors of DFIB shown in Fig. 4 and Fig. 5 can be attributed to two sources of error. The first source of error is the time-stepping error from the temporal integrator, which is relatively small in the quasi-static circle test. The second source of area loss comes from discretizing the continuous curve (circle) as a polygon whose vertices are the IB markers. This kind of error can be substantially reduced by using a high-order representation of the interface, such as a periodic cubic spline. We define a normalized area error with respect to the true initial area of the interface Atrue by using the tracers,
(5.10) |
where we compute A(t; Xtracer) via exact integration of the cubic spline interpolant. Fig. 6 shows that the area enclosed by the passive tracers using the cubic spline approximation is far more accurately preserved than the polygonal approximation. Furthermore, the area error approaches zero as the discretization of the tracer interface is refined, even if the marker and grid spacings are held fixed, as shown in Fig. 6. Indeed, the area of the spline interpolant through the tracers of resolution Ntracer = 20M is conserved to the machine epsilon in double precision.
It is well-known that the traditional IB method produces non-smooth surface tractions, and a number of improvements have been proposed [11,44,45,39,29]. Somewhat unexpectedly, the divergence-free force spreading used in our DFIB method proposed here offers smoother and more accurate tractions without any post-processing such as filtering [11]. This is inherently linked to the reduced spurious flows compared to traditional methods [39]. In Fig. 7, we compare the errors of the tangential and normal components of F(s, t = 1) for DFIB and IBMAC for the quasi-static circle problem. We observe that the DFIB method dramatically improves the accuracy of Lagrangian forces by only refining the Lagrangian mesh, keeping the Eulerian grid fixed. By contrast, in the IBMAC method, the tractions do not improve as the Lagrangian grid is refined.
5.3. A thin elastic membrane with parametric resonance in 2D
In many biological applications, the immersed structure is an active material, interacting dynamically with the surrounding fluid and generating time-dependent motion. It has been reported that the simulation of active fluid–structure interactions using the conventional IB method may suffer from significant loss in the volume enclosed by the structure [35]. A simple prototype problem for active fluid–structure interaction is a thin elastic membrane that dynamically evolves in a fluid in response to elastic forcing with periodic variation in the stiffness parameter [6,23], that is,
(5.11) |
where κ(t) is a periodic time-dependent stiffness coefficient of the form
(5.12) |
It is quite remarkable that such a purely temporal parameter variation can result in the emergence of spatial patterns, but that is indeed the case. We assume that the immersed structure is initially in a configuration that has a small-amplitude perturbation from a circle of radius R,
(5.13) |
where denotes the position vector pointing radially from the origin. For certain choices of parameters, the perturbed mode in the initial configuration may resonate with the driving frequency ω0 in the periodic forcing, leading to large-amplitude oscillatory motion in the membrane. The stability of the parametric resonance has been studied in the IB framework using Floquet linear stability analysis for a thin elastic membrane in 2D [6,23], and recently for an elastic shell in 3D [24]. Motivated by the linear stability analysis of [6,23], we consider two sets of parameters listed in Table 2 for our simulations. The first set of parameters with τ = 0.4 leads to a stable configuration in which the membrane undergoes damped oscillations (Fig. 8a), and the second set with τ = 0.5 leads to an unstable configuration in which the membrane oscillates with growing amplitude (Fig. 8b).
Table 2.
p | μ | L | R | Kc | ω0 | p | ϵ0 | τ |
---|---|---|---|---|---|---|---|---|
1 | 0.15 | 5 | 1 | 10 | 10 | 2 | 0.05 | 0.4 (damped oscillation) |
0.5 (growing oscillation) |
The computational domain Ω = [0, L]2 is discretized by a 128 × 128 uniform Cartesian grid with meshwidth . The number of Lagrangian markers is determined so that the distance between the Lagrangian markers is in the initial configuration. The discretization of the Lagrangian force density Eq. (5.11) is constructed in the same way as Eq. (5.8). The time step size is to ensure the stability of computation. On the left panel of Fig. 8 we show snapshots of the membrane configuration for each case, and on the right panel we plot the time-dependent amplitude ϵ(t) of the ansatz
(5.14) |
by applying the FFT to the Lagrangian marker positions X. In the case of growing oscillation (Fig. 8b), the amplitude of the perturbed mode increases from 0.05 to 0.3 until nonlinearities eventually stabilize the growing mode and the membrane starts to oscillate at a fixed amplitude.
We next give a direct comparison of area conservation of IBModified (with the cosine kernel [35]), IBMAC, and DFIB with the IB kernels , , , and . In this test, the area enclosed the Lagrangian markers is computed by the cubic spline approximation discussed in Sec. 5.2. In Fig. 9 and Fig. 10 we show time-dependent area errors enclosed by the parametric membrane for the damped-oscillation and the growing-amplitude cases respectively. For the damped-oscillation case (Fig. 9), we see that area errors for DFIB are at least two orders of magnitude smaller than those of IBMAC and IBModified for IB kernels that are at least . The volume conservation of IBModified and IBMAC was not directly compared in the previous work [17], but it was anticipated that they are similar. In our comparison, we find that IBModified is only slightly better than IBMAC in volume conservation, yet IBMAC is much simpler to use in practice.
In this set of tests, the choice of IB kernel also plays a role in affecting area conservation. In particular, the area errors for DFIB using and are smaller than those of and by approximately one order of magnitude. Additionally, the error curves of DFIB with and remain oscillating below 10−7 while apparent growth of error in time is observed with and , and in the other IB methods. Unlike the quasi-static circle test in which the time-stepping error is negligible compared to the area loss due to moving a finite collection of Lagrangian markers, the time-stepping error in this example can be observed by considering a dense collection of tracers with different time step sizes. With Ntracer = 4M, we first confirm that the area error of the tracer interface cannot be reduced by further including more tracers, but as we reduce the time step size , we observe an improvement in the area error, as shown in the bottom panel of Fig. 9. The improvements in area conservation of DFIB is consistently more than 104 times over IBCollocated and about 103 times over IBMAC. Similar results are obtained for the growing-amplitude case (see Fig. 10) except that the parametrically-unstable membrane has experienced some area loss due to the growing-amplitude oscillation before its motion is stabilized by the nonlinearities.
5.4. A 3D thin elastic membrane with surface tension
In our final test problem, we examine volume conservation of the DFIB method by extending the surface tension problem to 3D. We consider in 3D a thin elastic membrane that is initially in its spherical equilibrium configuration. The spherical surface of the membrane is discretized by a triangulation consisting of approximately equilateral triangles with edge length approximately equal to hs, constructed from successive refinement of a regular icosahedron by splitting each facet into four smaller equilateral triangles and projecting the vertices onto the sphere to form the refined mesh (see Fig. 11 for the first two levels of refinement). We use {X1, X2, …, XM} and {T1, T2, …, TP } to denote the vertices (Lagrangian markers) and the triangular facets of the mesh respectively. The generalization of discrete elastic energy functional of surface tension in 3D is the product of surface tension constant γ (energy per unit area) and the total surface area of the triangular mesh [22], that is,
(5.15) |
where |Tp| is the area of the pth triangle. The Lagrangian force FkΔs at the kth vertex is minus the partial derivative of E[X1, …, XM] with respect to Xk,
(5.16) |
where nbor(k) denotes the set of indices of triangles that share Xk as a vertex.3 Each component of the term ∂|Tl|/∂Xk in Eq. (5.16) can be computed analytically [22],
(5.17) |
where Xk, , denote the three vertices of the triangle Tl ordered in the counterclockwise direction and is the unit outward normal vector of Tl.
The computation is performed in the periodic box Ω = [0, 1]3 with Eulerian meshwidth using DFIB with . For the quasi-static test, the initial fluid velocity is set to be zero, and for the dynamic test, we set u(x, 0) = (0, sin(4πx), 0). In the computational results shown in Fig. 12, the spherical membrane is discretized by triangulation (as shown in Fig. 11) with 5 successive levels of refinement from the regular icosahedron (Fig. 11a), which results in a triangular mesh with M = 10242 vertices and P = 20480 facets. The radius of the spherical membrane is set to be R ≈ 0.1 which corresponds to . The remaining parameters in the computation are ρ = 1, μ = 0.05, γ = 1 and the time step size . In Fig. 12 we show snapshots of the 3D elastic membrane at t = 0, , and for the dynamic case. The elastic interface is instantaneously deformed by the fluid flow in the y-direction, and due to surface tension, the membrane eventually relaxes back to the spherical equilibrium configuration. Colored markers that move passively with the divergence-free interpolated fluid velocity are added for visualizing the fluid flow in the vicinity of the interface.
The volume enclosed by the triangular surface mesh is approximated by the total volume of tetrahedra formed by each facet and one common reference point (e.g. the origin) using the scalar triple product. To study volume conservation of the DFIB method in 3D, we compare the normalized volume error defined by
(5.18) |
using IBMAC and DFIB with which correspond to triangular meshes with 4, 5, 6 levels of refinement from the regular icosahedron respectively. For the quasi-static case (Fig. 13a), volume errors for DFIB are at least 2 orders of magnitude smaller than those of IBMAC. Further, volume errors for DFIB keep decreasing as the Lagrangian mesh is refined from hs = h to . For the dynamic case (Fig. 13b), both methods suffer a significant amount of volume loss arising from the rapid deformation at the beginning of simulation. The volume error of DFIB with hs = h is similar to those of IBMAC in magnitude, but the volume error of DFIB decreases as the Lagrangian mesh is refined for . It appears that the behavior of volume error changes in nature from hs = h to , which coincides with the conventional recommendation that the best choice of Lagrangian mesh spacing in the IB method is in practice. Similar to the two sources of error that contribute to the area loss in 2D, the volume error observed in Fig. 13 can also be explained by contribution from the time-stepping error, and the volume loss due to only moving the vertices (Lagrangian markers) that constitute the triangular mesh. This kind of error in volume conservation decreases as the discretization of the surface is refined, even on a fixed Eulerian grid (as shown in Fig. 13). Finally, we remark that the improvement in volume conservation does not seem to be as substantial as the improvement in area conservation in 2D. We suspect that this may be attributed to the larger approximation error in computing the volume using the tetrahedral approximation (after the triangular mesh is deformed), whereas in two dimensions we use a higher-order representation of the interface (cubic splines). Nevertheless, the reduction in volume error from the Lagrangian mesh-refinement experiments indeed confirms that the DFIB method can generally achieve better volume conservation if the immersed boundary is sufficiently resolved
6. Conclusions
In this paper, we introduce an IB method with divergence-free velocity interpolation and force spreading. Our IB method makes use of staggered-grid discretization to define an edge-centered discrete vector potential. By interpolating the discrete vector potential in the conventional IB fashion, we obtain a continuum vector potential whose curl directly yields a continuum Lagrangian velocity field that is exactly divergence-free by default. The corresponding force-spreading operator is constructed to be the adjoint of velocity interpolation so that energy is preserved in the interaction between the fluid and the immersed boundary. Both the new interpolation and spreading schemes require solutions of discrete vector Poisson equations which can be efficiently solved by a variety of algorithms. The transfer of information from the Eulerian grid to the Lagrangian mesh (and vice versa) is performed using ∇δh on the edge-centered staggered grid . We have found that volume conservation of DFIB improves with the smoothness of the IB kernel used to construct δh, and we have numerically tested that IB kernels that are at least are good candidate kernels that can be used to construct the regularized delta function in the DFIB method.
We have incorporated the divergence-free interpolation and spreading operators in a second-order time-stepping scheme, and applied it to several benchmark problems in two and three spatial dimensions. First, we have tested that our method achieves second-order convergence in both the fluid velocity and the Lagrangian deformation map for the 2D surface tension problem, which is admittedly a special case, since its continuum solution has a continuous normal derivative of the tangential velocity across the immersed boundary. The highlight of the DFIB is its capability of substantially reducing volume error in the immersed structure as it moves and deforms in the process of fluid–structure interaction. Through numerical simulations of quasi-static and dynamic membranes, we have confirmed that the DFIB method improves volume conservation by several orders of magnitude compared to IBMAC and IBModified. Furthermore, owing to the divergence-free nature of its velocity interpolation, the DFIB method reduces volume error with Lagrangian mesh refinement while keeping the Eulerian grid fixed. A similar refinement study would not yield improved volume conservation when using the conventional IB method. Although the numerical examples considered in this paper only involve thin elastic structures, we note that the DFIB method can also be directly applied to model thick elastic structures without any modification to the method, other than representing the thick elastic structure by a curvilinear mesh of Lagrangian points [19,10,18,4]. We also remark that the current version of the DFIB method is accompanied with a single-fluid Navier–Stokes fluid solver. This is not a fundamental limitation in our approach, and as a direction of future research, the DFIB method may be extended to work with variable-viscosity and variable-density fluid solvers [9].
Unlike other improved IB methods that either use non-standard finite-difference operators (IBModified [35]) that complicate the implementation of the fluid solver, or rely on analytically-computed correction terms (IIM [28,27] or Blob-Projection method [5]) that may not be readily accessible in many applications, the DFIB method is generally applicable, and it is straightforward to implement in both 2D and 3D from an existing IB code that is based on the staggered-grid discretization. Moreover, the additional costs of performing the new interpolation and spreading do not increase the overall complexity of computation and are modest compared to the existing IB methods.
We point out two limitations of our present work. A first limitation of the current version of DFIB method is based on the assumption of periodic boundary conditions. Extending the method to include physical boundary conditions at the boundaries of the computational domain is one possible direction of future work, but there are several challenges to overcome. First, a special treatment of spreading and interpolation is required near the boundaries since the support of the IB kernel can extend outside of the physical domain [16,20]. Second, with non-periodic BCs, instead of FFTs, the resulting linear system needs to be solved by geometric or algebraic multigrid method to achieve high performance. For unbounded domains, a lattice Green’s function technique was recently proposed as an alternative approach [29]. Third, for domains with physical boundaries, the use of projection-based fluid solvers to eliminate pressure introduces splitting errors near the physical boundaries, and instead one ought to solve a coupled velocity-pressure system at every time step [13]. In the DFIB method, it is also nontrivial to specify boundary conditions for the vector potential a(x) at physical boundaries, which would lead to a Poisson equation with non-periodic BCs. It may be that volume conservation as the structure passes near a boundary requires solving a coupled velocity-potential system. A second limitation of our DFIB method is that the pressure gradient generated by the Lagrangian forces is part of the resulting Eulerian force density because force spreading is also constructed to be discretely divergence-free. However, this may also be an important advantage of our method from the standpoint of accuracy, since it means that jumps in pressure across the interface do not require any explicit representation. We do not yet see an obvious way to extract the pressure from the Eulerian force density in case it is needed for output purposes, or for the purposes of imposing physical boundary conditions involving tractions or avoiding splitting errors near boundaries [13].
Acknowledgements
Y. Bao and A. Donev were supported in part by the National Science Foundation under award DMS-1418706, and by the U.S. Department of Energy Office of Science, Office of Advanced Scientific Computing Research, Applied Mathematics program under Award Number DE-SC0008271. B.E. Griffith acknowledges research support from the National Science Foundation (NSF awards ACI 1450327, DMS 1410873, and CBET 1511427) and the National Institutes of Health (NIH award HL117063).
Appendix A. Vector identities of discrete differential operators
Suppose φ(x) is a scalar grid function defined on , and u(x) and a(x) are vector grid functions defined on and respectively. The following discrete vector identities are valid on the periodic staggered grid just as in the continuum case,
(A.1) |
(A.2) |
(A.3) |
(A.4) |
(A.5) |
Eqs. (A.1) and (A.3) are merely discrete analogues of well-known vector identities involving gradient, divergence and curl. These identities can be proved in the same manner as their continuous counterparts. Eqs. (A.4) and (A.5) can be verified via “summation by parts”. Note that Eqs. (A.2) and (A.3) also hold if we replace u (which lives on ) by a (which lives on ).
Appendix B. Existence of discrete vector potential
Lemma 1. Suppose Dh · u = 0 and Dh × u = 0 for , then u(x) is a constant function on .
Proof. To prove this statement, we use Eqs. (A.3) to
Thus,
(B.1) |
Since Dh · u = 0 and Dh × u = 0 by hypothesis, the left-hand side of Eq. (B.1) is also zero. But this implies ui is constant for i = 1, 2, 3.
Lemma 2. If ψ is a scalar grid function that lives on one of the staggered grids, such that
(B.2) |
then there exists a grid function φ such that
(B.3) |
Proof. This lemma states the solvability of the discrete Poisson problem Eq. (B.3). Since Lh = Dh · Gh is symmetric with respect to the inner product on the periodic grid
(B.4) |
what we have to show is that any ψ satisfying Eq. (B.2) is orthogonal to any φ0 in the null space of Lh. But the null space of Lh with periodic boundary conditions contains only the constant function, and hence (ψ, φ0) = 0 because of Eq. (B.2) as required.
Now we are ready to state the theorem that guarantees the existence of a discrete vector potential a(x) for given a discretely divergence-free velocity field u(x) for .
Theorem 3. Suppose u(x) is a periodic grid function for , and u(x) satisfies
(B.5) |
then there exists a grid function a(x) for such that
(B.6) |
Proof. We choose a(x) to be any solution of
(B.7) |
Such an a(x) exists by Lemma 2, because
By applying Dh· to Eq. (B.7) and using the property that Lh and Dh· commute, we also have
(B.8) |
Because the null space of Lh contains only the constant function, it follows that
(B.9) |
If we use Eq. (B.9) and Eq. (A.3) for a, we can rewrite Eq. (B.7) as
(B.10) |
or
(B.11) |
But we also know from Eq. (A.2) and the requirement that Dh · u = 0 that
(B.12) |
From Eqs. (B.11) and (B.12) and Lemma 1, it follows that
(B.13) |
The constant must be zero, however, since Dh ×a has zero sum by “summation by parts”, and u has zero sum by assumption. This completes the proof of the existence of a vector potential satisfying u = Dh × a.
Footnotes
The interpolated velocity given by Eq. (2.16) has the same regularity as the regularized delta function δh which are generally at least in the IB method, and therefore, the divergence of U is well-defined.
Here and in similar expressions, is a shorthand for .
Here Δs is the Lagrangian area associated with each node and Fk is the Lagrangian force density with respect to Lagrangian area, but note that we do not need Fk and Δs separately; only their product is used in the numerical scheme.
References
- [1].Bao Y, Kaiser AD, Kaye J, Peskin CS, Gaussian-like immersed boundary kernels with three continuous derivatives and improved translational invariance, arXiv:1505.07529, 2015. [Google Scholar]
- [2].Bao Y, Kaye J, Peskin CS, A Gaussian-like immersed-boundary kernel with three continuous derivatives and improved translational invariance, J. Comput. Phys 316 (2016) 139–144. [Google Scholar]
- [3].Bhalla APS, Bale R, Griffith BE, Patankar NA, A unified mathematical framework and an adaptive numerical method for fluid–structure interaction with rigid, deforming, and elastic bodies, J. Comput. Phys 250 (2013) 446–476. [Google Scholar]
- [4].Boffi D, Gastaldi L, Heltai L, Peskin C, On the hyper-elastic formulation of the immersed boundary method, Comput. Methods Appl. Mech. Eng 197 (25–28) (2008) 2210–2231. [Google Scholar]
- [5].Cortez R, Minion M, The blob projection method for immersed boundary problems, J. Comput. Phys 161 (2) (2000) 428–453. [Google Scholar]
- [6].Cortez R, Peskin CS, Stockie JM, Varela D, Parametric resonance in immersed elastic boundaries, SIAM J. Appl. Math 65 (2) (2004) 494–520. [Google Scholar]
- [7].Devendran D, Peskin CS, An immersed boundary energy-based method for incompressible viscoelasticity, J. Comput. Phys 231 (14) (2012) 4613–4642. [Google Scholar]
- [8].Dutt A, Rokhlin V, Fast Fourier transforms for nonequispaced data, SIAM J. Sci. Comput 14 (6) (1993) 1368–1393. [Google Scholar]
- [9].Fai TG, Griffith BE, Mori Y, Peskin CS, Immersed boundary method for variable viscosity and variable density problems using fast constant-coefficient linear solvers I: numerical method and results, SIAM J. Sci. Comput 35 (5) (2013) B1132–B1161. [Google Scholar]
- [10].Gao H, Wang H, Berry C, Luo X, Griffith BE, Quasi-static image-based immersed boundary-finite element model of left ventricle under diastolic loading, Int. J. Numer. Methods Biomed. Eng 30 (11) (2014) 1199–1222. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [11].Goza A, Liska S, Morley B, Colonius T, Accurate computation of surface stresses and forces with immersed boundary methods, J. Comput. Phys 321 (2016) 860–873. [Google Scholar]
- [12].Greengard L, Lee J, Accelerating the nonuniform fast Fourier transform, SIAM Rev 46 (3) (2004) 443–454. [Google Scholar]
- [13].Griffith B, An accurate and efficient method for the incompressible Navier–Stokes equations using the projection method as a preconditioner, J. Comput. Phys 228 (20) (2009) 7565–7595. [Google Scholar]
- [14].Griffith B, Immersed boundary model of aortic heart valve dynamics with physiological driving and loading conditions, Int. J. Numer. Methods Biomed. Eng 28 (2012) 317–345. [DOI] [PubMed] [Google Scholar]
- [15].Griffith B, Hornung R, McQueen D, Peskin C, An adaptive, formally second order accurate version of the immersed boundary method, J. Comput. Phys 223 (1) (2007) 10–49, software available at https://github.com/ibamr/ibamr. [Google Scholar]
- [16].Griffith B, Luo X, McQueen D, Peskin C, Simulating the fluid dynamics of natural and prosthetic heart valves using the immersed boundary method, Int. J. Appl. Mech 1 (01) (2009) 137–177. [Google Scholar]
- [17].Griffith BE, On the volume conservation of the immersed boundary method, Commun. Comput. Phys 12 (2) (2012) 401–432. [Google Scholar]
- [18].Griffith BE, Luo X, Hybrid finite difference/finite element immersed boundary method, Int. J. Numer. Methods Biomed. Eng (2017), 10.1002/Cnm.2888. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [19].Griffith BE, Peskin CS, On the order of accuracy of the immersed boundary method: higher order convergence rates for sufficiently smooth problems, J. Comput. Phys 208 (1) (2005) 75–105. [Google Scholar]
- [20].Kallemov B, Bhalla APS, Griffith BE, Donev A, An immersed boundary method for rigid bodies, Commun. Appl. Math. Comput. Sci 11 (1) (2016) 79–141, software available at https://github.com/stochasticHydroTools/RigidBodyIB. [Google Scholar]
- [21].Kim Y, Lai M-C, Peskin CS, Numerical simulations of two-dimensional foam by the immersed boundary method, J. Comput. Phys 229 (13) (2010) 5194–5207. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [22].Kim Y, Lai M-C, Peskin CS, Seol Y, Numerical simulations of three-dimensional foam by the immersed boundary method, J. Comput. Phys 269 (2014) 1–21. [Google Scholar]
- [23].Ko W, Stockie JM, Correction to “Parametric resonance in immersed elastic boundaries”, arXiv:1207.4744, 2012. [Google Scholar]
- [24].Ko W, Stockie JM, Parametric resonance in spherical immersed elastic shells, SIAM J. Appl. Math 76 (1) (2016) 58–86. [Google Scholar]
- [25].Lai M.-c., Li Z, A remark on jump conditions for the three-dimensional Navier–Stokes equations involving an immersed moving membrane, Appl. Math. Lett 14 (2) (2001) 149–154. [Google Scholar]
- [26].Lai M-C, Peskin CS, An immersed boundary method with formal second-order accuracy and reduced numerical viscosity, J. Comput. Phys 160 (2) (2000) 705–719. [Google Scholar]
- [27].Lee L, LeVeque RJ, An immersed interface method for incompressible Navier–Stokes equations, SIAM J. Sci. Comput 25 (3) (2003) 832–856. [Google Scholar]
- [28].Li Z, Lai M-C, The immersed interface method for the Navier–Stokes equations with singular forces, J. Comput. Phys 171 (2) (2001) 822–842. [Google Scholar]
- [29].Liska S, Colonius T, A fast immersed boundary method for external incompressible viscous flows using lattice Green’s functions, J. Comput. Phys 331 (2017) 257–279. [Google Scholar]
- [30].Lushi E, Peskin CS, Modeling and simulation of active suspensions containing large numbers of interacting micro-swimmers, Comput. Struct 122 (2013) 239–248. [Google Scholar]
- [31].McQueen D, Peskin C, Shared-memory parallel vector implementation of the immersed boundary method for the computation of blood flow in the Beating Mammalian Heart, J. Supercomput 11 (3) (1997) 213–236. [Google Scholar]
- [32].Peskin CS, Flow patterns around heart valves: a numerical method, J. Comput. Phys 10 (2) (1972) 252–271. [Google Scholar]
- [33].Peskin CS, Numerical analysis of blood flow in the heart, J. Comput. Phys 25 (3) (1977) 220–252. [Google Scholar]
- [34].Peskin CS, The immersed boundary method, Acta Numer 11 (January 2002) (2003) 479–517. [Google Scholar]
- [35].Peskin CS, Printz BF, Improved volume conservation in the computation of flows with immersed elastic boundaries, J. Comput. Phys 105 (1) (1993) 33–46. [Google Scholar]
- [36].Roma AM, Peskin CS, Berger MJ, An adaptive version of the immersed boundary method, J. Comput. Phys 153 (1999) 509–534. [Google Scholar]
- [37].Stein DB, Guy RD, Thomases B, Immersed boundary smooth extension: a high-order method for solving {PDE} on arbitrary smooth domains using Fourier spectral methods, J. Comput. Phys 304 (2016) 252–274. [Google Scholar]
- [38].Stein DB, Guy RD, Thomases B, Immersed boundary smooth extension (IBSE): a high-order method for solving incompressible flows in arbitrary smooth domains, J. Comput. Phys 335 (2017) 155–178. [Google Scholar]
- [39].Strychalski W, Guy RD, Intracellular pressure dynamics in blebbing cells, Biophys. J 110 (5) (2016) 1168–1179. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [40].Unser M, Splines: a perfect fit for signal and image processing, IEEE Signal Process. Mag 16 (6) (1999) 22–38. [Google Scholar]
- [41].Unser M, Aldroubi A, Eden M, On the asymptotic convergence of B-spline wavelets to Gabor functions, IEEE Trans. Inf. Theory 38 (2) (1992) 864–872. [Google Scholar]
- [42].Usabiaga FB, Bell JB, Delgado-Buscalioni R, Donev A, Fai TG, Griffith BE, Peskin CS, Staggered schemes for fluctuating hydrodynamics, Multiscale Model. Simul 10 (4) (2012) 1369–1408. [Google Scholar]
- [43].Balboa Usabiaga F, Kallemov B, Delmotte B, Bhalla APS, Griffith BE, Donev A, Hydrodynamics of suspensions of passive and active rigid particles: a rigid multiblob approach, Commun. Appl. Math. Comput. Sci 11 (2) (2016) 217–296, software available at https://github.com/stochasticHydroTools/RotationalDiffusion. [Google Scholar]
- [44].Williams HA, Fauci LJ, Gaver III DP, Evaluation of interfacial fluid dynamical stresses using the immersed boundary method, Discrete Contin. Dyn. Syst., Ser. B 11 (2) (2009) 519. [DOI] [PMC free article] [PubMed] [Google Scholar]
- [45].Yang X, Zhang X, Li Z, He G-W, A smoothing technique for discrete delta functions with application to immersed boundary method in moving boundary simulations, J. Comput. Phys 228 (20) (2009) 7821–7836. [Google Scholar]