A Shape Newton Scheme for Deforming Shells with Application to Capillary Bridges
Abstract
We present a second order numerical scheme to compute capillary bridges between arbitrary solids by minimizing the total energy of all interfaces. From a theoretical point of view, this approach can be interpreted as the computation of generalized minimal surfaces using a Newton-scheme utilizing the shape Hessian. In particular, we give an explicit representation of the shape Hessian for functionals on shells involving the normal vector without reverting back to a volume formulation or approximating curvature. From an algorithmic perspective, we combine a resolved interface via a triangulated surface for the liquid with a level set description for the constraints stemming from the arbitrary geometry. The actual shape of the capillary bridge is then computed via finite elements provided by the FEniCS environment, minimizing the shape derivative of the total interface energy.
keywords:
Shape Optimization, Shape Newton, Shape Hessian, Shells, Capillary Bridges49M05, 49M15, 49M37, 65D18, 65K10
1 Introduction
In process engineering the behavior of particle systems is essential for the design of many processes such as particle agglomeration and separation, powder handling and granular flow [7, 16, 24]. A well developed method for the simulation of particle systems is the discrete element method, which calculates the system parameters by solving Newton’s equation of motion for each particle. Thus, suitable force models for the particle interaction are indispensable. Besides Van-der-Waals forces and electrostatic forces, capillary forces play a dominant role in wet materials [40], as liquid bridges form between particles. These bridges add forces to the system due to the pressure difference between the liquid and gas phase, as well as due to surface tension. For very small particles, even condensation out of humid air may lead to capillary bridges, which cause a significant attractive force, typically exceeding other inter-particle forces. The curved phase boundary between the liquid and the surrounding gas leads to a pressure difference over the interface. The mean curvature and the pressure difference are directly connected by the surface tension . This relation is described by the Young-Laplace-Equation
(YLE) |
where is the spatial variable. This relationship can be derived by the balance of forces [25, 48] or by minimizing the system energy [17]. In case of negligible gravity, becomes spatially independent and a constant mean curvature (CMC) surface describes the equilibrium state.
From an application oriented point of view, the methods can be divided into general methods for arbitrary geometries and two dimensional axisymmetric methods. Most of the literature focuses on axisymmetric bridges between two ideal spheres, a sphere and a plane or other very specific geometries. This also implies a constant contact angle and negligence of gravity [43]. Surfaces of revolution with a constant mean curvature have already been studied in 1841 by Delaunay [10], who expressed them in terms of a non-linear ordinary differential equation, which is derived by rolling a conic along a straight line. The theory of CMC surfaces was first applied to capillary bridges by Plateau [32]. He showed that with rising the volume of the liquid, a sequence of different CMC surface types occurs. This sequence was also analyzed by Orr, Scriven and Rivas [29], who solved (YLE) in two dimensions using elliptic integrals for a sphere and a plate. Later, Rubinstein and Fel [39] proofed that the classical Plateau sequence is only valid if the sphere and the plate are touching each other. In case of a non-zero distance, the sequence might change. Moreover, for special parameter combinations, the solution of the elliptic integrals might get complex, which leads to multiple solutions of the system that require further stability analysis. Besides solving (YLE) in terms of elliptic integrals, shooting methods have been presented in [12, 34]. Moreover, several methods requiring simplification beyond rotational symmetry, such as the toroidal approximation [15] and the parabolic approximation [31] are described in the literature. Methods not tailor made to exploit the axisymmetric situation can still require or exploit specific settings. For example, molecular dynamic methods [23, 26] are restricted to very small bridges with a manageable number of molecules, whereas computation of the bridge as the steady state of a free surface computational fluid dynamics approach requires an accurate representation of the surface [21, 46].
The general idea of energy based approaches is to find the steady state solution of the system by minimizing its surface energy. Treating the formation of capillary bridges via variational formulation and optimization has been discussed in [19]. Most, if not all of the energy minimization methods first discretize the unknown surface of the capillary bridge via triangles and then seek to minimize the discrete reformulation of the system energy as a function of the finite vertex positions. However, very often the continuous or “classical” formulation of (YLE) is still utilized in these schemes, resulting in the necessity to somehow find an approximation of the mean curvature, which is not readily available when using triangulated meshes. There are several discretized energy minimization methods for the calculation of CMC surfaces in general geometries, see, e.g. [9, 13, 33]. Nevertheless, successful application of any of these methods strongly depends on a high mesh quality including a uniform vertex distribution and minor triangle deformation. Thus, the minimization can also be done on a least square functional which is easier to handle compared to the surface area functional and allows to use an extended centroidal Voronoi tessellation [30]. Using this method, the mesh can be optimized simultaneously with the surface area. A modified approach is presented by Renka [37, 36], who derived a non-linear least square system by using a different energy functional. The major advantage of his method is the robustness in the presence of low mesh quality. Another option of solving the capillary bridge problem by energy minimization is the direct evaluation of virtual displacements [20]. Additionally, Ardito et al. [1] applied the mechanical concept of an ideal stiff thin membrane. Based on the total potential energy, the problem is expressed according to the classical principle of virtual power. The results of axisymmetric bridges agree well with CMC calculations of Kenmotsu [22] while deviations from molecular dynamic simulations can be found in Ko et al. [23]. Although this method is capable of calculating asymmetric cases no examples are outlined.
A frequently used open source code following this paradigm is The Surface Evolver [4], which also features a Newton scheme using the Hessian of the optimization problem in terms of vertex coordinates [5]. The surface energy might include surface tension, gravity or other energy forms. In addition, surface constraints, such as a specific geometry or body volume, can be specified. The general implementation of The Surface Evolver is a fundamental advantage and consequently it has been used to study different aspects of the capillary bridge problem such as non-symmetric bridges [3, 6, 8, 14, 47], stability [2] and the influence of gravity [45].
As part of this work, we present a novel method for minimizing (YLE) using a shape Newton scheme. To this end, we use shape calculus to derive a variational reformulation of (YLE), which does not involve curvature and is hence better suited for the lower regularity of triangulated surfaces. Indeed, in comparison to most works using discrete surfaces to minimize the total energy by moving vertices, we derive an explicit, curvature-free expression of the first and second order derivatives of the energy with respect to shape perturbations. Furthermore, we seek expressions on shell meshes only, which still adhere to the low regularity of a constant outer normal per facet of the mesh, that is the concentration of curvature to edges. This leads to several novel expressions for the shape Hessian of surface integrals and the second material derivative of the outer normal, which are also of considerable interest for general problems beyond capillary bridges. Indeed, we provide a general expression of the shape Hessian for boundary integrals involving the outer normal. The shape Hessian for the much simpler iso-perimeter problem has previously been considered in [42], albeit using either curvature or volume integrals.
The resulting variational, curvature-free alternative representation of (YLE) and the corresponding shape Hessian can then be solved by any kind of finite element software offering continuous Lagrange elements on shells. To this end, we use the FEniCS environment [27], which has full support for shell meshes [38]. In particular, FEniCS also offers the automatic computation of discrete shape derivatives for vertex motions, provided they do not involve cross-terms such as in the off-diagonal blocks of the shape Hessian [18]. We use this functionality to confirm that the “optimize-then-discretize” approach presented here commutes with the “discretize-then-optimize” paradigm for all first and second order partial derivatives with respect to the shape only, irrespective of mesh resolution.
This paper is structured as follows. Section 2 summarizes shape calculus simultaneously to deriving a curvature free variational reformulation of the Young-Laplace equation for triangulated meshes, which corresponds to the shape derivative of the energy of the system without additional geometric constraints such as the touch constraint of the liquid to the solid body surfaces. Section 3 then focuses on the shape Hessian of the problem and we derive the second order shape derivative of the Lagrangian of the energy minimization problem. Special attention is again given to the fact that no curvature and no volume integrals arise. This necessitates the computation of second order material derivatives of the normal, but consequently also leads to several novel expressions of the shape Hessian for boundary integrals, which are also of interest in general problems beyond capillary bridges. Section 4 then discusses our numerical implementation in detail, in particular with respect to possible rank deficiencies in the shape Hessian. Finally, we test our numerical implementation by revisiting several standard test cases for capillary bridges from the literature in Section 5.
2 Problem Formulation
2.1 Capillary Bridges as Generalized Minimal Surfaces
We assume that is the surface of some volume of fluid . This capillary surface can be disjointly decomposed into , the liquid air interface, and , the interface between the liquid and solid body . The resulting interface lines, or solid-gas-liquid triple phase lines are subsumed as boundaries . The geometrical setting is shown in Figure 1.
In particular, we use to denote the outer normal of the volume and to denote co-normals of , i.e., unit vectors that are orthogonal to and to . In order to reduce the computational workload and to avoid additional rank deficits of the Hessian, we are in particular interested in problem formulations that are tailor made for shell meshes, i.e., grids of topological dimension two and geometrical dimension three, and which do not require volume integrals. Hence, the surface area of each interface and the total volume of fluid are then given by the following surface integrals
(1) |
Furthermore, the gravitational force acting on the liquid is given by
(2) |
where is the gravitational vector and .
The formation of the capillary surface follows the minimization of the total interface energy, leading to the problem
(3) | ||||
s.t. | ||||
where, is the non-dimensional relative adhesion coefficient of solid and is the Bond number, the non-dimensional gravitational influence. Finally, denotes the surface of solid body .
The interface condition is not directly numerically tractable and can also not readily be addressed via shape calculus. Suppose the discretization of the subdomain consists of the vertices , . We then replace the analytic subset condition with the constraint of minimal distance for each vertex , namely
(4) |
where is some signed distance measure from any point in to , the surface of the solid body . We follow the convention of the distance being negative if the point is in the interior of .
2.2 Shape Calculus
To find the surface solving (3), we employ techniques from shape optimization, in particular shape calculus. Following the approach of perturbation of identity, a deformed surface is defined via
where is a suitably smooth vector field and . Following [11, 44], the Eulerian-Semi Derivative of a shape functional
is then given by
(5) | ||||
(6) | ||||
(7) |
provided the shape is of sufficient regularity, with (5) requiring the least. Here, is the divergence in the tangent space of and is the additive curvature, with being the outer normal to and being the normal to , which also fulfills and is also called the co-normal. Finally, is the material derivative and is the local derivative. Due to the chain rule, the identity
holds, if both local and material derivative exist. Here, is the classical spatial Jacobian. Hence, for the spatial coordinates themselves, one arrives at
It is worth mentioning that, contrary to local derivatives, the material derivative and spatial differentiation do not commute, meaning
(8) |
For the outer normal, one has in particular [41, 44]
(9) |
where is the tangential Jacobian of with respect to the spatial coordinate. Hence, (6) is essentially the chain rule relating the material derivative to the local derivative, where the tangential part of the convective part has been merged with the divergence. Furthermore, Equation is created by integration by parts on surfaces, where the curvature term arises because is not tangent to .
2.3 Necessary Optimality Conditions
We revisit the necessary optimality conditions of (3) from [19] using shape calculus, in comparison to a differential geometric perspective used in the former. The Lagrangian of (3) is given by
We now discuss the shape derivative of the Lagrangian term by term. Because the integrand is a constant with respect to shape perturbations, the shape derivative of most terms in the Lagrangian can immediately be found to be
(10) | ||||
where is the Kroenecker delta. The distance function is independent of the deformation parameter . Hence, the shape derivative vanishes and the material derivative is given by transport only, i.e.,
where is the classical spatial Jacobian and is the spatial gradient of the distance field with respect to at point . Picking the respective curvature free expressions from (10) with the least regularity requirements on , one arrives at an alternative variational formulation of (YLE), well-suited for discretization via triangular meshes. Indeed, the following section shows how the respective high-regularity expressions from (10) create (YLE).
2.4 Tangential Motion and the Contact Angle
Omitting the subset constraint, one arrives at
where is the contact line between the liquid to air interface and the contact surface on solid body . In the absence of gravity, i.e. , the above expression can only vanish, if the liquid air interface is a surface of constant mean curvature, i.e., , which is indeed the case where (YLE) is spatially constant. Furthermore,
has to hold on , which is not possible for arbitrary perturbation fields . If is feasible, then is in the tangent space of . Hence, if one restricts the motion to tangent directions only, i.e. , then the necessary optimality condition becomes
(11) |
Because the co-normals need to satisfy and have unit length, the critical surface must form a contact angle of and stationarity is only possible for tangent motions.
3 Shape Hessians
3.1 Shape Hessian for Boundary Integrals
Our desired computational approach is a Newton-iteration to find the roots of . Within the optimization context, this is also called sequential quadratic programming (SQP), because during each update, the second order Taylor-expansion of is minimized. For the problem at hand, this means we require the second order shape derivative of functionals of the types
the latter arising due to our reformulation of volume integrals to surfaces in (1) and (2).
Indeed, it is possible to transform back into a volume integral, which would, however, result in two problems: First, using the volume formulation of the Hessian over necessitates using a tetrahedral mesh, resulting in considerable numerical overhead. Furthermore, the Hessian matrix post discretization would then suffer from an additional rank deficit for vertices in the interior. Second, using a boundary formulation of the volumetric problem description requires the computation of the total curvature , which is an edge concentrated quantity for the shell meshes consisting of planar triangles our code is using. Hence, optimization and discretization would not commute in this situation.
A repeated application of (5) leads to
(12) | ||||
The above expression is more involved than those readily available in the literature, as the consideration of surface integrals here requires the computation of , the material derivative of the tangent divergence, whereas the volume situation is usually considered otherwise. Material derivatives commute with algebraic operations, such that
Due to (8), one arrives at
(13) | ||||
In the last step, the remaining full Jacobian can be replaced with the tangential Jacobian, because
Hence, taking the trace results in
(14) |
To achieve symmetry, we assume here and in the following. This makes the shape Hessian derived via repeated differentiation align with the expressions obtained by enforcing a vector space structure. It is worth mentioning that the latter part of (14) does not appear when volume integrals are considered. Summarizing the above, the shape Hessian of from (1) is given by
3.2 Shape Hessian of the Normal
The shape Hessian of and in (1) and (2) is more involved, as the second material derivative of the normal is needed. For the first Eulerian derivative, Equation (5) is applied to the case above, leading to
(15) |
and the symmetric repeated differentiation second order shape derivative is given by
(16) | ||||
The second material derivative of the normal can be explicitly computed using (9),
(17) | ||||
where we have again used the independency in the last step. Thus, when inserting (17) into (16), one arrives at an explicit expression for the second order shape derivative in a general setting, which can now easily be adapted to the second derivative of and in (1) and (2), using the respective material derivatives and the independency , namely
for and
for . Finally, the second derivative of the -independent distance-function is readily given by
where is the spatial Hessian matrix of the distance field.
4 Numerical Implementation
4.1 Shape Hessian and Finite Elements
To numerically find the shape of the capillary bridge, we use finite elements on a shell mesh of topological dimension two consisting of planar triangles in provided by the FEniCS framework [27]. The classical continuous Galerkin finite element space of order of -dimensional vectors is given by
where is the space of polynomials of order . To include the respective scalar constraints of volume and distance, we augment this space to to include the adjoint multipliers. The Newton update for iteratively finding the capillary bridge is then interpretable as a variational problem, namely to find , such that
(18) |
Post discretization, this variational problem creates the typical Karush-Kuhn-Tucker (KKT) system. Finally, the state is updated via
We use the discrete shape differentiability capabilities of FEniCS [18] to numerically validate the - block in (18), confirming that indeed for our first and second order shape derivatives the “discretize-then-optimize” and “optimize-then-discretize” approach commutes irrespective of mesh size. Including the off-diagonal blocks in this confirmation is unfortunately not conveniently possible, as FEniCS does not provide a means to compute the - off-diagonals discretely.
A straightforward implementation of (18) results in the challenge of globalizing the convergence, i.e., guaranteeing a positive definite Hessian matrix away from the optimum. To address this, we have also implemented an approximative Newton scheme, where the , block in (18) is replaced by the scalar product
(19) |
where is some smoothing parameter. This approach is sometimes also called a Sobolev gradient descent and the resulting KKT-system is positive definite.
There are several reasons for rank deficiencies of the proper KKT system for shapes, also at the optimum. Using a full 3D deformation is indeed too rich. As can be seen from (6) and (7), tangential motions are in the kernel of (18). Furthermore, the second order shape derivatives (12), (15) and (16) only involve spatial derivatives of and , such that translations are also within the kernel. As such, one typically restricts the deformation unknown to , where and is some vertex average of the cell normal . However, as discussed in Section 2.3, the contact angle requirement (11) demands a tangential motion of the vertices constituting and in particular . As such, we restrict the motion fields
(20) |
where , are functions, likewise for . Thus, we admit a motion in normal direction only for the vertices, except for those forming the solid-gas-liquid triple phase lines. There, each vertex is allowed to move in their respective two dimensional subspace spanned locally by the two edge-averaged co-normals and . It is worth mentioning that as a consequence, once feasibility with respect to the distance constraint is achieved, there is no longer any possible motion of the interior vertices of , except for the contact line , which can still move in the plane spanned locally by the vertex co-normals. Hence, if one switches to the Newton-solver too early, the mesh quality and point spacing of is going to degrade. At present, we counter this problem by remeshing, which is necessary as we aim at being able to deal with large scale deformations from the initial guess, anyway. Incorporating equal vertex spacing into the optimization goal to remove the tangential kernel of the Hessian for vertices in the interior of is part of future work.
Depending on the geometrical setup of the solid bodies , translations can also be in the kernel of (18). One such case would be a capillary bridge between two planes. Full rank in this situation is achieved by activating additional centroid constraints. Surface and volume centroid are given by
While using the surface centroid might seem to be the approach of choice for a code operating on the shell alone, we rather choose the volume centroid, as the expression can be considerably simplified by exploiting the volume constraint in this setting. Thus, we constrain the -th component of the centroid via
where is the fixed target volume, and is the Kronecker-Delta. The respective first and second order Eulerian derivatives are again given by (15), (16) and (17), where
More details on these constraints can also be found in [42].
5 Numerical Results
5.1 Sphere-Plate, the unique situation
In order to validate our second order optimization scheme, we consider the case of a spherical body with zero distance from a plane, as this situation is very well understood theoretically. In the following, we base our evaluation on the data available in [29]. In particular, there is a closed form solution of the total force available as
(21) |
where are the wetting angles at the sphere and plane. Furthermore, is the so called filling angle. The available data is given in non-dimensionalized form as the ratio of contact force to radius times surface tension . However, there is no closed form solution for the curvature as a coupled system of non-linear equations has to be solved. Tabularized values are provided in [29] depending on the angles and for the curvature. Because our code requires the desired contact angle and volume as input rather than the angle , we use a volume constraint of as per the tabularized values in [29], corresponding to the angles . Seeing that curvature is not readily available for a discrete surface of planar triangles, we use the adjoint of the volume constraint for comparisons, utilizing the correspondence
as described in Section 2.4 and validate the resulting effective pressure difference as the corresponding quantity. Instead of using the close-form representation of the forces (21) for spheres, we follow the general expression for forces [47] and compute the force acting on obstacle via numerical quadrature of the following integrals
(22) |
with being the resulting force acting on obstacle . The vector is again the co-normal on , e.g. a vector orthogonal to and tangential to . In particular the integrands in and are constants per cell or edge for our mesh consisting of planar triangles. As such, the above integrals can readily be computed by summing the contribution of each triangle and edge individually.
The shapes of the two obstacles, the sphere and plane, enters our code via closed form descriptions for the signed distances in (4), in particular
where is twice the distance between the objects, i.e., here. First and second order spatial derivatives of these functions, which are needed for the shape derivative and shape Hessian, can easily be computed and the non-differentiability of the square root at zero is irrelevant, as the centroid of the sphere is outside of our computational mesh .


Our initial geometry is a cylinder around the -axis of radius , spanning from to , consisting of triangles. Hence, we start infeasible with respect to all constraints. The top cap of the cylinders is subject to the touch condition based on , while the bottom cap has to adhere as a constraint. We first conduct steps using the approximate Newton-Scheme, where the second order partial shape derivative in the KKT-System, i.e., the corresponding diagonal block, is approximated with the -inner product (19) with smoothing . After steps, we remesh using the compounding of gmsh 3.0.6 [28, 35]. After the remeshing, we switch to the proper Newton iteration. As the geometric situation under consideration is rotationally invariant, we also have to restrict the motion of the vertices once we move to the Newton scheme as discussed in (20). As a consequence, interior vertices of the cap and bottom of the original cylinder, or their descendants after remeshing, can no longer slide over the obstacles once we move to the Newton scheme. However, we found that after the first initial gradient steps, where sliding is possible, the unknown surface already clings to the solid bodies in a well-behaved manner.
#Cells | Surface Area | Error in Force | ||
---|---|---|---|---|
- | - | |||
Initial and final mesh are shown in Figure 2 and the respective quantities of interest are listed in Tab. 1. The convergence of the optimization residual is shown in Figure 3.
Our methodology achieves very accurate results in comparison to the reference data in [29]. In particular, the relative error in the computed total force is less than for all meshes considered, in particular including the coarsest grid of only cells. We also observe excellent convergence speed of the Newton method, which is activated after one remeshing in iteration 5 for all grids. Observing the convergence history in Figure 3, one can see that the reduction of the residual with the Newton method is indeed very rapid, but not fully grid independent. A possible source for this slight mesh dependency can possibly found in the subset constraint, which is implemented discretely on a per-vertex level without considering a possible analytic or function space equivalent of the subset constraint.
5.2 Sphere-Plate, Non-Axisymmetric Situation
We also use the same sphere-plate setting to study the non-axisymmetric situation. To this end, we apply gravity in the negative -direction with varying bond numbers of , , and . We did not obtain solutions for bond numbers and up, as these would lead to topological changes with the droplet splitting and detaching in part from the obstacle. The respective shapes are shown in Figure 4.




In particular, [29] states that the gravitational effect is negligible provided that the Bond number satisfies . For comparison, we have tabulated the computed force for different Bond numbers in Table 2.
Bond | |||||
---|---|---|---|---|---|
5.3 Sphere-Plate, the Non-Unique Situation
We revisit the situation of a sphere of unit radius placed over a plane with a non-dimensional distance of . The desired contact angles are on the sphere and on the plane. This setting was studied analytically in [39], where four unduloid bridges are given, all satisfying the same non-dimensional volume of , a constant curvature and the desired touch and angle constraints with the obstacles. Hence, they are critical shapes of (3). However, as mentioned in [39], it is unclear which of these candidates constitutes a physical solution. The respective unduloid bridges do not admit a closed-form description of their geometry. However, the authors of [39] kindly provided us with a polygonal graph of two of their unduloids as a cut through the plane: The unduloid with a meniscus of was given as a plane graph of points and the unduloid with a meniscus angle of was kindly provided as a plane graph of points. We then use the compounding functionality of gmsh 3.0.6 [28, 35] to create a shell mesh of the resulting bodies of revolution with optimal point spacing independent of the original points provided in the graphs. These two shells are then used as the starting geometry in our program.



Due to floating-point inaccuracies, a saddle point cannot be expected to be a stable point for a numerical gradient descent scheme. Indeed, the unduloid shape for a meniscus angle of proved to be almost stationary initially. However, a rapid descent of the objective was eventually achieved with the geometry indicating the desire to split the single capillary bridge into two droplets. This ultimately terminates the program as topological changes are not possible, yet. As expected, the Newton-iteration was unusable for this geometry due to the ill-conditioning of the Hessian. Contrary to this saddle-point, a Newton-scheme is possible for the initial geometry of the unduloid of meniscus angle , where the provided starting guess of the discretized analytical shape quickly converges to a residuum of , numerically identifying this shape as a proper local minimum. The resulting forces on the sphere were computed to be and . The respective shapes are shown in Figure 5.
6 Summary and Conclusion
A novel shape Newton approach for computing capillary bridges has been studied. In particular, we derive a variational formulation of the first and second order derivative of the Lagrangian of the total energy of liquid bridges between solid particles with respect to shape perturbations of the liquid phase. Special attention was paid on variational formulations, which respect the lower regularity of triangulated surfaces. Hence, expressions involving curvature are avoided. Furthermore, the desire to compute all quantities on shell meshes lead to novel expressions for the shape Hessian and the second order material derivative of the normal, which are also of interest for more general problems. The resulting expressions where confirmed to provide the same numerical values as the “discretize-then-optimize” approach, even for coarse meshes. Several test cases for different capillary bridges from the literature were revisited, confirming both the accuracy of the method as well as the performance of the Newton scheme.
References
- [1] R. Ardito, A. Corigliano, A. Frangi and F. Rizzini “Advanced models for the calculation of capillary attraction in axisymmetric configurations” In European Journal of Mechanics - A/Solids 47, 2014, pp. 298–308
- [2] M. Ataei, H. Chen, T. Tang and A. Amirfazli “Stability of a liquid bridge between nonparallel hydrophilic surfaces” In Journal of Colloid and Interface Science 492, 2017, pp. 207–217
- [3] A.l Bedarkar and X.-F. Wu “Capillary torque in a liquid bridge between two angled filaments” In Journal of Applied Physics 106.11, 2009, pp. 113527
- [4] K.. Brakke “The surface evolver” In Experimental Mathematics 1.2, 1992, pp. 141–165
- [5] K.. Brakke “The Surface Evolver and the stability of liquid surfaces” In Philosophical Transactions of the Royal Society of London. Series A: Mathematical, Physical and Engineering Sciences 354.1715, 1997, pp. 2143–2157
- [6] D.. Broesch and J. Frechette “From concave to convex: Capillary bridges in slit pore geometry” In Langmuir: the ACS journal of surfaces and colloids 28.44, 2012, pp. 15548–15554
- [7] Hans-Jürgen Butt and Michael Kappl “Normal capillary forces” In Advances in Colloid and Interface Science 146.1-2, 2009, pp. 48–60
- [8] A. Chau, S. Régnier, A. Delchambre and P. Lambert “Three-dimensional model for capillary nanobridges and capillary forces” In Modelling and Simulation in Materials Science and Engineering 15.3, 2007, pp. 305–317
- [9] W. Chen, Y. Cai and J. Zheng “Constructing Triangular Meshes of Minimal Area” In Computer-Aided Design and Applications 5.1-4, 2008, pp. 508–518
- [10] Charles-Eugène Delaunay “Sur la surface de révolution dont la courbure moyenne est constante” In Journal de Mathématiques Pures et Appliquées 6, 1841, pp. 309–320
- [11] M.. Delfour and J.-P. Zolésio “Shapes and Geometries: Metrics, Analysis, Differential Calculus, and Optimization”, Advances in Design and Control 22 SIAM Philadelphia, 2011
- [12] M. Dörmann and H.-J. Schmid “Simulation of Capillary Bridges between Particles” In Procedia Engineering 102, 2015, pp. 14–23
- [13] G. Dziuk and J.. Hutchinson “Finite element approximations to surfaces of prescribed variable mean curvature” In Numerische Mathematik 102.4, 2006, pp. 611–648
- [14] T.P. Farmer and J.C. Bird “Asymmetric capillary bridges between contacting spheres” In Journal of Colloid and Interface Science 454, 2015, pp. 192–199
- [15] R.. Fisher “On the capillary forces in an ideal soil; correction of formulae given by W. B. Haines” In The Journal of Agricultural Science 16.3, 1926, pp. 492–505
- [16] A.. Forsyth, S. Hutton and M.. Rhodes “Effect of cohesive interparticle force on the flow characteristics of granular material” In Powder Technology 126.2, 2002, pp. 150–154
- [17] Carl-Friedrich Gauss “Principia generalia theoriae figurae fluidorum” In Commentarii Societ. Regiae Scientiarum Gottingensis, 1830
- [18] David A. Ham, Lawrence Mitchell, Alberto Paganini and Florian Wechsung “Automated shape differentiation in the Unified Form Language” In Structural and Multidisciplinary Optimization 60.5, 2019, pp. 1813–1820 DOI: 10.1007/s00158-019-02281-z
- [19] Ulrich Hornung and Hans D. Mittelmann “A Finite Element Method for Capillary Surfaces with Volume Constraints” In Journal of Computational Physics 87, 1990, pp. 126–136
- [20] S.. Iliev “Iterative method for the shape of static drops” In Computer Methods in Applied Mechanics and Engineering 126.3-4, 1995, pp. 251–265
- [21] E. Jettestuen, J.. Helland and M. Prodanović “A level set method for simulating capillary-controlled displacements at the pore scale with nonzero contact angles” In Water Resources Research 49.8, 2013, pp. 4645–4661
- [22] K. Kenmotsu “Surfaces of revolution with prescribed mean curvature” In Tohoku Mathematical Journal 32.1, 1980, pp. 147–153
- [23] J.-A. Ko, H.-J. Choi, M.-Y. Ha, S.-D. Hong and H.-S. Yoon “A study on the behavior of water droplet confined between an atomic force microscope tip and rough surfaces” In Langmuir: the ACS journal of surfaces and colloids 26.12, 2010, pp. 9728–9735
- [24] G. Landi, D. Barletta and M. Poletto “Modelling and experiments on the effect of air humidity on the flow properties of glass powders” In Powder Technology 207.1-3, 2011, pp. 437–443
- [25] Pierre-Simon Laplace “Supplément au livre X du Traitée de Méchanique Céleste” Paris: Couveier, 1805
- [26] J.. Laube “On the mechanical interactions between TiO2 nanoparticles” Bremen: Produktionstechnik, 2017
- [27] “Automated Solution of Differential Equations by the Finite Element Method” 84, Lecture Notes in Computational Science and Engineering Springer Berlin Heidelberg, 2012
- [28] E. Marchandise, C. Wiart, W.. Vos, C. Geuzaine and J.-F. Remacle “High quality surface remeshing using harmonic maps. Part II: surfaces with high genus and of large aspect ratio” In International Journal for Numerical Methods in Engineering 86.11, 2011, pp. 1303–1321
- [29] F.. Orr, L.. Scriven and A.. Rivas “Pendular rings between solids: meniscus properties and capillary force” In Journal of Fluid Mechanics 67.4 Cambridge University Press, 1975, pp. 723–742 DOI: 10.1017/S0022112075000572
- [30] H. Pan, Y.-K. Choi, Y. Liu, W. Hu, Q. Du, K. Polthier, C. Zhang and W. Wang “Robust modeling of constant mean curvature surfaces” In ACM Transactions on Graphics 31.4, 2012, pp. 1–11
- [31] X. Pepin, D. Rossetti, S.M. Iveson and S.J. Simons “Modeling the Evolution and Rupture of Pendular Liquid Bridges in the Presence of Large Wetting Hysteresis” In Journal of Colloid and Interface Science 232.2, 2000, pp. 289–297
- [32] J. Plateau “The figures of equilibrium of a liquid mass” In The Annual Report of the Smithsonian Institution, 1864, pp. 338–369
- [33] K. Polthier and W. Rossman “Discrete constant mean curvature surfaces and their index” In Journal für die reine und angewandte Mathematik (Crelles Journal) 2002.549, 2002, pp. 13
- [34] L. Qiang-Nian, Z. Jia-Qi and Z. Feng-Xi “Exact solution for capillary bridges properties by shooting method” In Zeitschrift für Naturforschung A 72.4, 2017, pp. 315–320
- [35] J.-F. Remacle, C. Geuzaine, G. Compère and E. Marchandise “High quality surface remeshing using harmonic maps” In International Journal For Numerical Methods in Engineering 79.11, 2009, pp. 1309–1331
- [36] R.. Renka “A Simple and Efficient Method for Modeling Constant Mean Curvature Surfaces” In SIAM Journal on Scientific Computing 37.4, 2015, pp. A2076–A2099
- [37] R.. Renka and J.. Neuberger “Minimal Surfaces and Sobolev Gradients” In SIAM Journal on Scientific Computing 16.6, 1995, pp. 1412–1427
- [38] M.. Rognes, D.. Ham, C.. Cotter and A… McRae “Automating the solution of PDEs on the sphere and other manifolds in FEniCS 1.2” In Geoscientific Model Development 6, 2013, pp. 2099–2119 DOI: 10.5194/gmd-6-2099-2013
- [39] B.Y. Rubinstein and L.G. Fel “Theory of axisymmetric pendular rings” In Journal of Colloid and Interface Science 417, 2014, pp. 37–50
- [40] H. Rumpf “Die Wissenschaft des Agglomerierens” In Chemie Ingenieur Technik - CIT 46.1, 1974, pp. 1–11
- [41] S. Schmidt “Efficient Large Scale Aerodynamic Design Based on Shape Calculus”, 2010
- [42] S. Schmidt “Weak and Strong Form Shape Hessians and Their Automatic Generation” In SIAM Journal on Scientific Computing 40.2, 2018, pp. C210–C233
- [43] Helmar Schubert “Kapillarität in porösen Feststoffsystemen” Berlin, Heidelberg etc.: Springer, 1982
- [44] J. Sokolowski and J.-P. Zolésio “Introduction to Shape Optimization: Shape Sensitivity Analysis” Springer Berlin Heidelberg, 1992
- [45] X. Sun, H.. Lee, S. Michielsen and E. Wilusz “Profile of capillary bridges between two vertically stacked cylindrical fibers under gravitational effect” In Applied Surface Science 441, 2018, pp. 791–797
- [46] X. Sun and M. Sakai “Direct numerical simulation of gas-solid-liquid flows with capillary effects: An application to liquid bridge forces between spherical particles” In Physical review. E 94.6-1, 2016, pp. 063301
- [47] A. Virozub, N. Haimovich and S. Brandon “Three-dimensional simulations of liquid bridges between two cylinders: Forces, energies, and torques” In Langmuir: the ACS journal of surfaces and colloids 25.22, 2009, pp. 12837–12842
- [48] Thommas Young “III. An essay on the cohesion of fluids” In Philosophical Transactions of the Royal Society of London 95, 1805, pp. 65–87