Example problem: The Young Laplace equation

This document discusses the finite-element-based solution of the Young Laplace equation, a nonlinear PDE that determines the static equilibrium shapes of droplets or bubbles. We start by reviewing the relevant theory and then present the solution of a simple model problem.

Acknowledgement:
This tutorial and the associated driver codes were developed jointly with Cedric Ody (Ecole Polytechnique, Paris; now Rennes).

Theory

The figure below illustrates a representative problem: A small droplet is extruded slowly from the outlet of a cylindrical tube. The air-liquid interface is pinned at the end of the tube. We assume that the size of the droplet and the rate of extrusion are so small that gravitational, viscous and inertial forces may be neglected compared to the interfacial forces acting at the air-liquid interface.

A typical problem: The extrusion of a small droplet from a cylindrical tube.

The shape of the air-liquid interface (the meniscus) is then determined by Laplace's law which expresses the balance between the (spatially constant) pressure drop across the meniscus, $ \Delta p^* $, and the surface tension forces acting at the air-liquid interface,

\[ \Delta p^* = \sigma \kappa^*, \]

where $ \kappa^* $ is the mean curvature and $ \sigma $ the surface tension.

Non-dimensionalising all lengths on some problem-specific lengthscale $ {\cal L} $ (e.g. the radius of the cylindrical tube) and scaling the pressure on the associated capillary scale, $ \Delta p^* = \sigma/{\cal L} \ \Delta p $, yields the non-dimensional form of the Young-Laplace equation

\[ \Delta p = \kappa. \]

This must be augmented by suitable boundary conditions, to be applied at the contact line – the line along which the meniscus meets the solid surface. We can either "pin" the position of the contact line (as in the above example), or prescribe the
contact angle at which the air-liquid interface meets the solid surface.

The mathematical problem may be interpreted as follows: Given the prescribed pressure drop $ \Delta p $ (and thus $ \kappa $), we wish to determine an interface shape of the required mean curvature $ \kappa $ that satisfies the boundary conditions along the contact line.

Cartesian PDE-based formulation

Expressing the (non-dimensional) height of the interface above the $ (x_1, x_2) $-plane as $ x_3 = u(x_1,x_2) $ yields the cartesian form of the Young-Laplace equation:

\[ \Delta p = \kappa = - \nabla \cdot \frac{\nabla u}{\sqrt{1+|\nabla u|^2}}, \]

where $ \nabla = (\partial/\partial x_1,\partial/\partial x_2)^T $ Given the imposed pressure drop across the interface, this equation must be solved for $ u(x_1, x_2) $. Note that this is only possible if the interface can be projected onto the $ (x_1, x_2) $-plane.

The principle of virtual displacements

The interface shape can also be determined from the principle of virtual displacements

\[ \delta \left( \int_S \mathit{\, d} s \right)= \int_S \Delta p {\bf N} \cdot \delta {\bf N} \mathit{\, d} s + \oint_{L} \ \ {\bf T}_n \cdot \delta {\bf R } \mathit{\, d} l \ \ \ \ \ \ \ \ \ \ \ \ (1) \]

which may be derived from energetic considerations. Here the symbol $ \delta $ denotes a variation, $ {\bf R } $ is the position vector to the interface, and the vector $ {\bf N} $ is the unit normal to the meniscus. The left hand side of this equation represents the variation of the interfacial energy during a virtual displacement, and $ ds $ is an infinitesimal element of the meniscus surface, $S$. The terms on the right hand side represent the virtual work done by the pressure and the virtual work done by the surface tension forces acting at the free contact line, respectively. $ dl $ is the length of an element of the contact line $L$, and $ {\bf T}_n $ is the vector tangent to the interface and normal to the contact line. Note that, if the contact line is pinned, the variation of its position is zero, $ \delta {\bf R} = {\bf 0} $, and the line integral vanishes.

The variational formulation of the problem is particularly convenient for a finite-element-based solution; see, e.g. the Solid Mechanics Theory document for a discussion of how to discretise variational principles with finite elements. The variational and PDE-based formulations are, of course, related to each other: The Young-Laplace equation is the Euler-Lagrange equation of the variational principle.

Parametric representation

To deal with cases in which the interface cannot be projected onto the $ (x_1, x_2) $-plane, we parametrise the meniscus by two intrinsic coordinates as $ {\bf R}(\zeta_1,\zeta_2) \in { R}^3$, where $(\zeta_1,\zeta_2) \in D \in { R}^2$. Furthermore, we parametrise the domain boundary, $\partial D$, by a scalar coordinate $\xi$ so that,

\[ {\partial D} = \bigg\{ (\zeta_1,\zeta_2) \ \bigg| \ (\zeta_1,\zeta_2) = \left( \zeta_1^{[\partial D]}(\xi), \ \zeta_2^{[\partial D]}(\xi) \right) \bigg\}. \]

The normal to the meniscus is then given by

\[ {\bf N} = \frac{{\bf R}_{,1} \times {\bf R}_{,2} } {\mathcal{A}^{1/2}}, \]

where the commas denote partial differentiation with respect to the intrinsic coordinates, and $ \mathcal{A}^{1/2}= |{\bf R}_{,1} \times {\bf R}_{,2}| $ is the square root of the surface metric tensor.

The area and length differentials required in variational principle are

\[ d s=\mathcal{A}^{1/2} d \zeta_1 d \zeta_2 \]

and

\[ d l=\left| \frac{d {\bf R}\left( \zeta_1^{[\partial D]}(\xi), \ \zeta_2^{[\partial D]}(\xi) \right)}{d \xi} \right| d \xi, \]

allowing us to write the principle of virtual displacements as

\[ \int_S \left( \frac{\delta \mathcal{A}^{1/2}}{\mathcal{A}^{1/2}} - \kappa \ {\bf N} \cdot \delta {\bf R} \right) \mathcal{A}^{1/2} d \zeta_1 d \zeta_2 = \oint_{L} {\bf T}_n \cdot \delta {\bf R} \ \left| \frac{d {\bf R}\left( \zeta_1^{[\partial D]}(\xi), \ \zeta_2^{[\partial D]}(\xi) \right)}{d \xi} \right| d \xi. \]

The method of spines

In the current form, the variational principle cannot yield a unique solution because there are infinitely many vector fields $ {\bf R}(\zeta_1,\zeta_2) $ that parametrise the same interface shape. To remove this ambiguity, and to allow for interface shapes that cannot be projected onto the $ (x_1,x_2) $-plane, we employ the so-called "Method of Spines". This method was originally proposed by Kistler and Scriven for the computation of free surface flows. We decompose the vector $ {\bf R} $ into two parts by writing it as

\[ {\bf R}(\zeta_1,\zeta_2) = {\bf B}(\zeta_1,\zeta_2) + \mathit{u}(\zeta_1,\zeta_2) \ {\bf S}(\zeta_1,\zeta_2). \]

Here the "spine basis" ${\bf B}(\zeta_1,\zeta_2)$ and the "spines" ${\bf S}(\zeta_1,\zeta_2)$ are pre-determined vector fields that must be chosen by the user. Using this decomposition, the meniscus shape is determined by the scalar function $\mathit{u}(\zeta_1,\zeta_2)$ which represents the meniscus' displacement along the spines ${\bf S}$.

The idea is illustrated in the simple 2D sketch below: the spine basis vectors, $ {\bf B}(\zeta), $ parametrise the straight line corresponding to a flat meniscus. Positive values of $ u $ displace the meniscus along the spines, $ {\bf S}(\zeta) $ (the red vectors), whose orientation allows the representation of meniscus shapes that cannot be represented in cartesian form as $ x_2 = u(x_1). $

Sketch illustrating the parametrisation of the meniscus by the Method of Spines.

The spine basis and the spines themselves must be chosen such that the mapping from $(\zeta_1,\zeta_2)$ to ${\bf R}(\zeta_1,\zeta_2)$ is one-to-one, at least for the meniscus shapes of interest. Pinned boundary conditions of the form $ \left. {\bf R}\right|_{\partial D} = {\bf R}_{\rm pinned} $ are most easily imposed by choosing the spine basis such that $ \left. {\bf B}\right|_{\partial D} = {\bf R}_{\rm pinned}, $ implying that $ \left. u\right|_{\partial D} = 0. $

The simplest possible choice for the spines and spine basis is one that returns the problem to its original cartesian formulation. This is achieved by setting $ {\bf B}(\zeta_1,\zeta_2) = (\zeta_1,\zeta_2,0)^T $ and $ {\bf S}(\zeta_1,\zeta_2) = (0,0,1)^T. $

Displacement Control

The Young-Laplace equation is a highly nonlinear PDE. We therefore require a good initial guess for the solution in order to ensure the convergence of the Newton iteration. In many cases good initial guesses can be provided by a simple, physically motivated continuation method. For instance in the model problem shown above, the computation was started by computing the solution for $ \Delta p = \kappa = 0 $ – a flat interface. This solution was then used as the initial guess for the solution at a small positive value of $ \Delta p $. This process was continued, allowing us to compute strongly deformed meniscus shapes. This method works well, provided small increments in the control parameter $ \Delta p $ (or equivalently, $ \kappa $) create small changes in the interface shape. This is not always the case, however, as we shall see in the example below. In such cases it is often possible to re-formulate the problem, using the displacement control method discussed in the solid mechanics tutorials. Rather than prescribing the pressure drop $ \Delta p $ we prescribe the displacement of a control point on the meniscus and regard the pressure drop required to achieve this displacement as an unknown. Since the implementation of the method is very similar to that used for solid mechanics problems, we shall not discuss it in detail here but refer to the appropriate solid mechanics tutorial.



An example problem: A barrel-shaped meniscus

As an example, we consider the following problem: Fluid is extruded from an infinitely long, parallel-sided slot of width $ 2a $. If we assume that the air-liquid interface is pinned at the edges of the slot, as shown in the sketch below, the problem has an obvious exact solution. The air-liquid interface must have constant mean curvature, so, assuming that its shape does not vary along the slot, the meniscus must be a circular cylinder. If we characterise the meniscus' shape by its vertical displacement along the centreline, $ H $, the (dimensional) curvature of the air-liquid interface is given by

\[ \kappa^* = \frac{2/a}{H/a + a/H}. \]

The plot of this function, shown in the right half of the figure below, may be interpreted as a "load-displacement diagram" as it shows the deflection of the meniscus as a function of the imposed non-dimensional pressure drop across the air-liquid interface, $ \Delta p = a \kappa^*. $

Sketch of the meniscus above a slot of width 2a. The figure on the right illustrates the relation between the meniscus curvature and its vertical displacement along the centreline.

The plot shows that the load-displacement curve is not single-valued. Furthermore, the presence of a limit point at $ a \kappa^* = 1 $ indicates that the maximum curvature of the meniscus is given by $ \kappa_{max}^* = 1/a. $ This implies that the maximum (dimensional) pressure that the meniscus can withstand is given by $ \Delta p^*_{max} = \sigma \kappa_{max}^* = \sigma/a $.

The presence of the limit point makes it impossible to compute the entire solution curve by simply increasing $ \kappa $ in small increments. However, use of a displacement control approach, by prescribing $ H $ while regarding $ \Delta p $ (and thus $\kappa$) as an unknown, yields a single-valued function that can be computed by a straightforward continuation method in which $ H $ is increased in small increments.

This approach was employed to compute the meniscus shapes shown in the plot below. The initial, zero-curvature configuration of the meniscus (corresponding to a vanishing pressure drop across the air-liquid interface) is the unit square. The meniscus is pinned along the lines $ y=0 $ and $ y=1 $, and symmetry (natural) boundary conditions were applied along the lines $ x=0 $ and $ x=1; $ see Comments and Exercises for further details on the natural boundary conditions. As the pressure drop increases, the meniscus is deflected upwards until it reaches the configuration of maximum curvature when $ H/a=1 $. Beyond this point, the pressure drop has to be reduced to compute the "bulging" meniscus shapes obtained for $ H/a > 1. $

Deformation of a meniscus that is pinned along the lines y=0 and y=1.

The comparison of the computed "load-displacement curve" against the exact solution, shown below, indicates that the two agree to within plotting accuracy.

Load-displacement diagram for a meniscus that is pinned along the lines y=0 and y=1.


Implementation

We shall now discuss the solution of the above problem with oomph-lib's Young Laplace elements.

The global namespace

As usual we define the problem parameters in a global namespace. The key parameter is the value of the prescribed control displacement which we initialise to zero. The function get_exact_kappa() returns the exact solution for the mean curvature of the meniscus. We will use this function for the validation of our results.

//===== start_of_namespace========================================
/// Namespace for "global" problem parameters
//================================================================
{
// Displacement control:
//----------------------
/// Height control value
double Controlled_height = 0.0;
/// Exact kappa
double get_exact_kappa()
{
// Mean curvature of barrel-shaped meniscus
return 2.0*Controlled_height/
} //end exact kappa
Namespace for "global" problem parameters.
Definition: barrel.cc:45
double Controlled_height
Height control value.
Definition: barrel.cc:51
double get_exact_kappa()
Exact kappa.
Definition: barrel.cc:54

Next we define the orientation of the spines. Anticipating the shape of the meniscus, we set $ {\bf B}(\zeta_1,\zeta_2)= (\zeta_1,\zeta_2,0) $ so that $ u=0 $ corresponds to a flat meniscus in the $ (x,y) $-plane,

// Spine basis
//------------
/// Spine basis: The position vector to the basis of the spine
/// as a function of the two coordinates x_1 and x_2, and its
/// derivatives w.r.t. to these coordinates.
/// dspine_B[i][j] = d spine_B[j] / dx_i
/// Spines start in the (x_1,x_2) plane at (x_1,x_2).
void spine_base_function(const Vector<double>& x,
Vector<double>& spine_B,
Vector< Vector<double> >& dspine_B)
{
// Bspines and derivatives
spine_B[0] = x[0];
spine_B[1] = x[1];
spine_B[2] = 0.0 ;
dspine_B[0][0] = 1.0 ;
dspine_B[1][0] = 0.0 ;
dspine_B[0][1] = 0.0 ;
dspine_B[1][1] = 1.0 ;
dspine_B[0][2] = 0.0 ;
dspine_B[1][2] = 0.0 ;
} // End of bspine functions
void spine_base_function(const Vector< double > &x, Vector< double > &spine_B, Vector< Vector< double > > &dspine_B)
Spine basis: The position vector to the basis of the spine as a function of the two coordinates x_1 a...
Definition: barrel.cc:72

and rotate the spines in the $ y $ direction by setting

\[ {\bf S}(\zeta_1,\zeta_2) = \left( \begin{array}{c} 0 \\ -\sin\big(\alpha(\zeta_2)\big) \\ \ \ \cos\big(\alpha(\zeta_2)\big) \\ \end{array} \right) \]

where $ \alpha(\zeta_2) = \alpha_{min} + (\alpha_{max}-\alpha_{min}) \zeta_2 $. With this choice, the spines are unit vectors that form an angle $ \alpha $ (varying between $ \alpha_{min} $ and $ \alpha_{max} $) with the y-axis.

// Spines rotate in the y-direction
//---------------------------------
/// Min. spine angle against horizontal plane
double Alpha_min = MathematicalConstants::Pi/2.0*1.5;
/// Max. spine angle against horizontal plane
double Alpha_max = MathematicalConstants::Pi/2.0*0.5;
/// Spine: The spine vector field as a function of the two
/// coordinates x_1 and x_2, and its derivatives w.r.t. to these coordinates:
/// dspine[i][j] = d spine[j] / dx_i
void spine_function(const Vector<double>& x,
Vector<double>& spine,
Vector< Vector<double> >& dspine)
{
/// Spines (and derivatives) are independent of x[0] and rotate
/// in the x[1]-direction
spine[0]=0.0;
dspine[0][0]=0.0;
dspine[1][0]=0.0;
spine[1]=cos(Alpha_min+(Alpha_max-Alpha_min)*x[1]);
dspine[0][1]=0.0;
dspine[1][1]=-sin(Alpha_min+(Alpha_max-Alpha_min)*x[1])
spine[2]=sin(Alpha_min+(Alpha_max-Alpha_min)*x[1]);
dspine[0][2]=0.0;
dspine[1][2]=cos(Alpha_min+(Alpha_max-Alpha_min)*x[1])
} // End spine function
double Alpha_max
Max. spine angle against horizontal plane.
Definition: barrel.cc:99
void spine_function(const Vector< double > &x, Vector< double > &spine, Vector< Vector< double > > &dspine)
Spine: The spine vector field as a function of the two coordinates x_1 and x_2, and its derivatives w...
Definition: barrel.cc:104
double Alpha_min
Min. spine angle against horizontal plane.
Definition: barrel.cc:96


The driver code

We start by preparing an output directory and open a trace file to record the control displacement, and the computed and exact values of the interface curvature $ \kappa $.

//===================start_of_main========================================
/// Driver code
//========================================================================
int main()
{
// Create label for output
DocInfo doc_info;
// Set output directory
doc_info.set_directory("RESLT");
//Open a trace file
ofstream trace_file;
char filename[100];
sprintf(filename,"%s/trace.dat",doc_info.directory().c_str());
trace_file.open(filename);
// Write kappa, exact kappa and height values
trace_file
<< "VARIABLES=\"<GREEK>k</GREEK>\",\"<GREEK>k</GREEK>_{ex}\",\"h\""
<< std::endl;
trace_file << "ZONE" << std::endl;
int main()
Driver code.
Definition: barrel.cc:321

Next we build the problem object and document the initial configuration: a flat meniscus.

// Create the problem
//-------------------
// Create the problem with 2D nine-node elements from the
// QYoungLaplaceElement family.
//Output the solution
problem.doc_solution(doc_info,trace_file);
//Increment counter for solutions
doc_info.number()++;
2D YoungLaplace problem on rectangular domain, discretised with 2D QYoungLaplace elements....
Definition: barrel.cc:140
void doc_solution(DocInfo &doc_info, ofstream &trace_file)
Doc the solution. DocInfo object stores flags/labels for where the output gets written to and the tra...
Definition: barrel.cc:291

Finally, we perform a parameter study by increasing the control displacement in small increments and re-computing the meniscus shapes and the associated interface curvatures.

// Parameter incrementation
//-------------------------
double increment=0.1;
// Loop over steps
unsigned nstep=2; // 10;
for (unsigned istep=0;istep<nstep;istep++)
{
// Increment prescribed height value
// Solve the problem
problem.newton_solve();
//Output the solution
problem.doc_solution(doc_info,trace_file);
//Increment counter for solutions
doc_info.number()++;
}
// Close output file
trace_file.close();
} // end of main


The problem class

The problem class has the usual member functions. (Ignore the lines in actions_before_newton_solve() as they are irrelevant in the current context. They are discussed in one of the exercises in Comments and Exercises.) The problem's private member data include a pointer to the node at which the meniscus displacement is controlled by the displacement control element, and a pointer to the Data object whose one-and-only value contains the unknown interface curvature, $ \kappa. $

//====== start_of_problem_class=======================================
/// 2D YoungLaplace problem on rectangular domain, discretised with
/// 2D QYoungLaplace elements. The specific type of element is
/// specified via the template parameter.
//====================================================================
template<class ELEMENT>
class YoungLaplaceProblem : public Problem
{
public:
/// Constructor:
/// Destructor (empty)
/// Update the problem before solve
{
// This only has an effect if displacement control is disabled
double new_kappa=Kappa_pt->value(0)-0.5;
Kappa_pt->set_value(0,new_kappa);
}
/// Update the problem after solve: Empty
/// Doc the solution. DocInfo object stores flags/labels for where the
/// output gets written to and the trace file
void doc_solution(DocInfo& doc_info, ofstream& trace_file);
private:
/// Node at which the height (displacement along spine) is controlled/doced
/// Pointer to Data object that stores the prescribed curvature
Data* Kappa_pt;
}; // end of problem class
Node * Control_node_pt
Node at which the height (displacement along spine) is controlled/doced.
Definition: barrel.cc:168
YoungLaplaceProblem()
Constructor:
Definition: barrel.cc:180
Data * Kappa_pt
Pointer to Data object that stores the prescribed curvature.
Definition: barrel.cc:171
void actions_after_newton_solve()
Update the problem after solve: Empty.
Definition: barrel.cc:159
void actions_before_newton_solve()
Update the problem before solve.
Definition: barrel.cc:151
~YoungLaplaceProblem()
Destructor (empty)
Definition: barrel.cc:148


The problem constructor

We start by building the mesh, discretising the two-dimensional parameter space $ (\zeta_1,\zeta_2) \in [0,1] \times [0,1]$ with 8x8 elements.

//=====start_of_constructor===============================================
/// Constructor for YoungLaplace problem
//========================================================================
template<class ELEMENT>
{
// Setup mesh
//-----------
// # of elements in x-direction
unsigned n_x=8;
// # of elements in y-direction
unsigned n_y=8;
// Domain length in x-direction
double l_x=1.0;
// Domain length in y-direction
double l_y=1.0;
// Build and assign mesh
Problem::mesh_pt()=new SimpleRectangularQuadMesh<ELEMENT>(n_x,n_y,l_x,l_y);

Next, we choose the central node in the mesh as the node whose displacement is imposed by the displacement control method.

// Check that we've got an even number of elements otherwise
// out counting doesn't work...
if ((n_x%2!=0)||(n_y%2!=0))
{
cout << "n_x n_y should be even" << endl;
abort();
}
// This is the element that contains the central node:
ELEMENT* prescribed_height_element_pt= dynamic_cast<ELEMENT*>(
mesh_pt()->element_pt(n_y*n_x/2+n_x/2));
// The central node is node 0 in that element
Control_node_pt= static_cast<Node*>(prescribed_height_element_pt->node_pt(0));
std::cout << "Controlling height at (x,y) : (" << Control_node_pt->x(0)
<< "," << Control_node_pt->x(1) << ")" << "\n" << endl;

We pass the pointer to that node and the pointer to the double that specifies the imposed displacement to the constructor of the displacement control element. The constructor automatically creates a Data object whose one-and-only value stores the unknown curvature, $ \kappa. $ We store the pointer to this Data object in the private member data to facilitate its output.

// Create a height control element
HeightControlElement* height_control_element_pt=new HeightControlElement(
// Store pointer to kappa data
Kappa_pt=height_control_element_pt->kappa_pt();
Data * Kappa_pt
Pointer to Data object that stores the prescribed curvature.

The meniscus is pinned along mesh boundaries 0 and 2:

// Boundary conditions
//--------------------
// Set the boundary conditions for this problem: All nodes are
// free by default -- only need to pin the ones that have Dirichlet conditions
// here.
unsigned n_bound = mesh_pt()->nboundary();
for(unsigned b=0;b<n_bound;b++)
{
// Pin meniscus displacement at all nodes boundaries 0 and 2
if ((b==0)||(b==2))
{
unsigned n_node = mesh_pt()->nboundary_node(b);
for (unsigned n=0;n<n_node;n++)
{
mesh_pt()->boundary_node_pt(b,n)->pin(0);
}
}
} // end bc

We complete the build of the Young Laplace elements by passing the pointer to the spine functions, and the prescribed curvature.

// Complete build of elements
//---------------------------
// Complete the build of all elements so they are fully functional
unsigned nelement = mesh_pt()->nelement();
for(unsigned i=0;i<nelement;i++)
{
// Upcast from GeneralsedElement to YoungLaplace element
ELEMENT *el_pt = dynamic_cast<ELEMENT*>(mesh_pt()->element_pt(i));
//Set the spine function pointers
el_pt->spine_base_fct_pt() = GlobalParameters::spine_base_function;
el_pt->spine_fct_pt() = GlobalParameters::spine_function;
// Set the curvature data for the element
el_pt->set_kappa(Kappa_pt);
}

Finally, we add the displacement control element to the mesh and assign the equation numbers.

// Add the height control element to mesh (comment this out
// if you're not using displacement control)
mesh_pt()->add_element_pt(height_control_element_pt);
// Setup equation numbering scheme
cout <<"\nNumber of equations: " << assign_eqn_numbers() << endl;
} // end of constructor


Postprocessing

We document the exact and computed meniscus curvatures in the trace file and output the meniscus shape.

//===============start_of_doc=============================================
/// Doc the solution: doc_info contains labels/output directory etc.
//========================================================================
template<class ELEMENT>
ofstream& trace_file)
{
// Output kappa vs height of the apex
//------------------------------------
trace_file << -1.0*Kappa_pt->value(0) << " ";
trace_file << GlobalParameters::get_exact_kappa() << " ";
trace_file << Control_node_pt->value(0) ;
trace_file << endl;
// Number of plot points: npts x npts
unsigned npts=5;
// Output full solution
//---------------------
ofstream some_file;
char filename[100];
sprintf(filename,"%s/soln%i.dat",doc_info.directory().c_str(),
doc_info.number());
some_file.open(filename);
mesh_pt()->output(some_file,npts);
some_file.close();
} // end of doc


Comments and Exercises

  1. Choice of spines:

    We discussed earlier that the spine basis and the spines themselves must be chosen such that the mapping from $(\zeta_1,\zeta_2)$ to ${\bf R}(\zeta_1,\zeta_2)$ is one-to-one, at least for the meniscus shapes of interest. This requires some prior knowledge of the expected interface shapes.

    The spine basis and the spines must be defined via function pointers that are passed to the Young Laplace elements. If the function pointers are not specified, the Young-Laplace elements revert to a cartesian formulation.

    Experiment with different spine orientations and explore the interface shapes that are obtained if no spines are specified (by commenting out the lines in the constructor that pass the relevant function pointers to the Young Laplace elements).


  2. Natural boundary conditions:

    As usual in any finite-element computation, we only enforced the essential boundary conditions by pinning the meniscus displacement along the "pinned contact lines" at $ y=0 $ and $ y=1. $ No constraints were applied along the two other domain boundaries (at $ x=0 $ and $ x=1 $), indicating that these boundaries are controlled by implied, "natural" boundary conditions. The variational principle (1) shows what these are: since we neglected the boundary integral on the right hand side of equation (1), the meniscus shape must satisfy $ {\bf T}_n \cdot \delta {\bf R} = \delta u \ {\bf T}_n \cdot {\bf S} = 0, $ implying that outer unit normal to the meniscus boundary, $ {\bf T}_n, $ must be orthogonal to the direction of the spines. Since the spines do not have an $ x $ - component, the meniscus must therefore have zero slope in that direction – just what we need for our problem.

    To convince yourself that the this argument is correct, rotate the spines in the $ x $ -direction, e.g. by changing their definition to

    \[ {\bf S}(\zeta_1,\zeta_2) = \left( \begin{array}{c} 1/2 \\ -\sin\big(\alpha(\zeta_2)\big) \\ \ \ \cos\big(\alpha(\zeta_2)\big) \\ \end{array} \right). \]

    The natural boundary condition will still force the meniscus to be normal to the spines along the "free" contact line, resulting in interface shapes similar to the one shown in the figure below.
    Meniscus shape created by the natural boundary conditions when the spines (shown as vectors) are rotated in the x-direction.
    This demonstrates yet again that the orientation of spines must reflect the relevant features of the problem. We refer to another tutorial for a more detailed discussion of the boundary condition and its relation to contact angles.

  3. Displacement control:

    Explore what happens if you disable displacement control and prescribe the pressure drop (i.e. $ \kappa $) directly. The relevant code is already contained in the driver code. You'll have to comment out the lines in the problem constructor that create the displacement control element and the line that adds it to the problem's mesh. Replace them by the lines

    // Comment out the previous two commands and uncomment the following two
    // to prescribe the pressure drop (the curvature) directly
    //Kappa_pt=new Data(1);
    //Kappa_pt->pin(0);


    which create the Data object that stores the prescribed curvature. (Note that the value of $ \kappa $ is already incremented in actions_before_newton_step(). With displacement control this step has no real effect as the Newton method will overwrite this assignment). Check what happens if the prescribed curvature exceeds the maximum possible curvature of the meniscus.

  4. Inefficient implementation:

    Note that the current implementation of the Young Laplace elements
    is inefficient as the elemental Jacobian matrices are computed by finite-differencing. You are invited to implement the analytical computation of the Jacobian matrix as an exercise.

  5. Other problems:

    We provide a number of additional demo driver codes that demonstrate the solution of other, related problems.



Source files for this tutorial



PDF file

A pdf version of this document is available.