Skip to main content
PLOS Computational Biology logoLink to PLOS Computational Biology
. 2022 Dec 16;18(12):e1010762. doi: 10.1371/journal.pcbi.1010762

Interacting active surfaces: A model for three-dimensional cell aggregates

Alejandro Torres-Sánchez 1,¤, Max Kerr Winter 1, Guillaume Salbreux 1,2,*
Editor: Saúl Ares3
PMCID: PMC9803321  PMID: 36525467

Abstract

We introduce a modelling and simulation framework for cell aggregates in three dimensions based on interacting active surfaces. Cell mechanics is captured by a physical description of the acto-myosin cortex that includes cortical flows, viscous forces, active tensions, and bending moments. Cells interact with each other via short-range forces capturing the effect of adhesion molecules. We discretise the model equations using a finite element method, and provide a parallel implementation in C++. We discuss examples of application of this framework to small and medium-sized aggregates: we consider the shape and dynamics of a cell doublet, a planar cell sheet, and a growing cell aggregate. This framework opens the door to the systematic exploration of the cell to tissue-scale mechanics of cell aggregates, which plays a key role in the morphogenesis of embryos and organoids.

Author summary

Understanding how tissue-scale morphogenesis arises from cell mechanics and cell-cell interactions is a fundamental question in developmental biology. Here we propose a mathematical and numerical framework to address this question. In this framework, each cell is described as an active surface representing the cell acto-myosin cortex, subjected to flows and shape changes according to active tensions, and to interaction with neighbouring cells in the tissue. Our method accounts for cellular processes such as cortical flows, cell adhesion, and cell shape changes in a deforming three-dimensional cell aggregate. To solve the equations numerically, we employ a finite element discretisation, which allows us to solve for flows and cell shape changes with arbitrary resolution. We discuss applications of our framework to describe cell-cell adhesion in doublets, three-dimensional cell shape in a simple epithelium, and three-dimensional growth of a cell aggregate.

1 Introduction

Tissue morphogenesis relies on the controlled generation of the cellular forces that collectively drive tissue-scale flows and deformation [1, 2]. The interplay between cell-cell adhesion, cellular mechanics and the cytoskeleton plays a key role in determining how biological tissues self-organise [3]. These ingredients are also crucial for the growth of in vitro organoids, organ-like systems derived from stem cells which can self-organise into complex structures reminiscent of actual organs [46].

Several classes of models have been proposed to describe the mechanics of multicellular aggregates, such as cellular Potts models [713], phase field models [1418] and vertex models [19]. Vertex models, and the closely related Voronoi vertex models [20, 21], describe cells in a tissue as polyhedra that share faces, edges and vertices forming a three-dimensional junctional network [19, 2224]. Cell deformations are encoded by the displacement of the vertices Xa of the network. These displacements are dictated by the balance of vertex forces Fa stemming from cell pressures Pc, surface tensions tf, and line tensions Γe that are coupled to virtual changes in cell volume δVc, face area δAf, and edge length δle respectively in a work function

δW=ccells-PcδVc+ffacestfδAf+eedgesΓeδle=aFa·δXa, (1)

where to get to the last expression one needs to express δVc, δAf and δle in terms of a virtual displacement of the vertices δXa. Two and three-dimensional versions of the vertex model have been employed for many applications, for instance to study cell packing [23, 25], cell sorting [26], wound closure [27], cyst formation [28], tumourigenesis in tubular epithelia [29] among many other [19]. However because of their definition, vertex models do not explicitly resolve cortical flows on the cell surface. The effect of cell-cell adhesion is implicitly introduced in the surface tension tf, which mixes together physical processes arising from cell-cell adhesion and surface forces in the cell membrane and in the actomyosin cortex. In vertex models with vertices positions as degrees of freedom, topological transitions leading to cell-neighbour exchange are encoded explicitly by formulating rules to change edges in the network.

At the single cell scale, a number of studies have shown the relevance of coarse-grained, continuum models to describe the mechanics of the cell surface. In animal cells, the cell surface is composed of a lipid membrane surrounding the actin cortex, a layer of cross-linked actin filaments undergoing continuous turnover of its constituents. Because of this turnover, the actin cortex behaves as a viscoelastic material with a characteristic remodelling time of tens of seconds [30, 31]. When looking at dynamics at time-scales beyond this relaxation time, the cortex can be seen as a viscous fluid layer. Because of the large cortical surface tension and effective 2D viscosity compared to the cell membrane [30, 32], models of cell surface mechanics have been focusing on the mechanics of the cortex. In this approach, an active fluid theory taking into account cellular cortical flows, gradients of active cytoskeletal tension and their regulation, and orientation and filament alignment in the actin cortex, has proven successful to describe the mechanics of cell polarisation, cell motility or cell division [3342]. From a computational perspective, there has been a growing attention to the simulation of the dynamics of fluid interfaces both with prescribed [4346] and with time-evolving shape [41, 42, 4753]. In addition, recent discrete deformable cell models have described cellular aggregates by representing cells by triangular meshes with viscoelastic edges [5457].

However, to our knowledge no computational framework has attempted to provide a physical description of three-dimensional cellular aggregates taking into account explicitly the mechanics of a single cell surface described as an active fluid surface, as well as cell-cell adhesions.

Here we bridge this gap and introduce a new modelling and simulation framework, and a freely available code [58], for the mechanics of cell aggregates in three dimensions (Fig 1). We describe cells as interacting active surfaces [59]. The governing equations for the cell surface mechanics are discretised using a finite element method. In this method, each cell is represented by a three-dimensional mesh with vertices positions Xa. In analogy with Eq (1) in vertex models, we start from the virtual work theorem for interfaces (Eq (2)) and find the net forces at the vertices Fa (Eq (11)), which vanish in the absence of inertia. This condition allows us to obtain cortical flows and cell shape changes. In this framework, cell-neighbour exchange appears as a natural output of the remodelling of cell-cell interactions and is not treated explicitely.

Fig 1. Schematic of the interacting active surface framework.

Fig 1

A tissue is described by a collection of triangular meshes representing each cell. The dynamics of the tissue is described by the dynamics of the vertices making the cellular meshes, similar to how the movement of the vertices of a vertex model describe the deformation of a tissue. The motion of the cell mesh is obtained by coarse-graining continuum mechanics equations of a theory of active surfaces via the finite element method. In this theory, cortical flows, cortical tensions, intracellular pressures, bending moments and forces arising from cell-cell interactions are taken into account.

The main benefits of our method are that it (1) can incorporate complex descriptions of the physics of the cell surface, including sources of tension, in-plane and normal moments [59], (2) accounts for cell-cell adhesion explicitly through constitutive laws that can be adapted to represent different biological scenarios, (3) resolves cell shape and cortical flows with arbitrary resolution given by the mesh size of the finite element discretisation with a well-defined continuum limit.

The nonlinear equations of the model are treated computationally with the use of nonlinear solvers. Since we consider only the discretisation of the cell surface, the number of degrees of freedom is considerably smaller than in 3D Cellular Potts or phase-field models, both of which require a 3D discretisation. On the other hand, to capture cell shape, cortical flows and cell-cell interactions accurately, we need to use many more vertices per cell than in a vertex model, which leads to a greater computational cost. To limit computational time, the code is parallelised to allow each cell to be stored on a different partition, each possibly using a pool of cores (hybrid MPI-OpenMP method). As such, it is possible to simulate several tens of cells on a computing cluster.

We now turn to the description of our framework. In Section 2 we describe the mathematical formulation and the discretisation of our method. We show some examples of application in Section 3 and end in Section 4 with conclusions, summary and ideas for future work.

2 Materials and methods

In this section we describe the main elements of our framework. We start by introducing the governing equations for a single, isolated cell described as a fluid active surface. We use a virtual work formulation for the mechanics of a surface, together with a finite element discretisation, to obtain the equations that dictate the movement of the vertices of the mesh. We introduce cell-cell interactions, represented by an interaction potential between pairs of surfaces, that result in a force density and a tension acting on each cell. Finally, we describe a mesh reparametrisation method that allows simulations to handle large tangential deformations of the surface which can arise for continuously flowing fluid interfaces such as the cell cortex.

2.1 Governing equations and discretisation for a single surface

2.1.1 Virtual work for interfaces

Our starting point is the statement of virtual work for a closed interface S representing a single cell. We describe S with a time-dependent Lagrangian parametrisation X(s1, s2) where s1, s2 are two surface coordinates and X a point in the 3D space in which the surface is embedded; here and in the following, we ommit the dependency of X on time for notational simplicity. Since we use a Lagrangian parametrisation, for fixed surface coordinates s*1, s*2, X(s*1,s*2) follows the trajectory of a material particle. We denote the coordinates of the 3D cartesian basis by greek indices α, β, …, and the coordinates on the surface by latin indices i, j…. Here and elsewhere in the manuscript we use Einstein summation convention for repeated indices. Given the tangent vectors ei = ∂iX one can compute the metric tensor gij = eiej and the curvature tensor Cij = −n ⋅ ∂iej, where n = (e1 × e2)/|e1 × e2| is the outer normal to the surface. Other notations of differential geometry are given in S1 Appendix 1. Here and in the following, we consider the limit of low Reynolds number where inertial terms are negligible, a limit relevant to the physics at the cell scale which is of interest here [60]. The mechanics of a single surface can then be described by the following statement of the principle of virtual work for S [59]:

δW=SdS{12t^ijδgij+m¯ijδCij-fαδXα}=0, (2)

where δX is an infinitesimal displacement of the surface, and δgij and δCij the associated infinitesimal variation of the metric and curvature tensors. Expressions for δgij and δCij in terms of δXα are given in S1 Appendix 2. Eq (2) relates infinitesimal variations of geometric quantities of the interface to their work conjugates: the external force density fα coupled to the surface displacement, the tension tensor t^ij related to metric variations, and the bending moment tensor m¯ij coupled to variations of the curvature tensor. Eq (2) is equivalent to the statement of balance of linear and angular momentum at low Reynolds number (S1 Appendix 3). We have neglected external torques and internal normal moments for simplicity, which lead to extra terms in Eq (2) (S1 Appendix 3).

2.1.2 Constitutive laws

To describe the mechanics of a single surface, we need to specify constitutive equations for the mechanical tensors t^ij and m¯ij. We denote by v = ∂tX the velocity field on the cell surface. We assume that the cell surface can be represented as an active viscous layer, with a bending rigidity and a spontaneous curvature. As a result, we use the following constitutive equations:

t^ij=t^dij+t^aij+t^eij,t^dij=2ηvij,t^aij=γgij,t^eij=κ(Ckk-C0)[12(Ckk-C0)gij-2Cij],m¯ij=m¯eij=κ(Ckk-C0)gij, (3)

where vij is the strain-rate tensor on the surface:

vij=12[ivj+jvi+2Cijvn], (4)

with ∇i the covariant derivative operator defined in S1 Appendix 1. Here, η is the surface viscosity; for simplicity we do not explicitly distinguish between the shear and bulk viscosity of the surface. γ is the surface tension of the cell, which is not necessarily homogeneous on the cell surface. As we expect this contribution to largely arise from active forces generated in the actomyosin cortex [30], we later refer to it as the active tension. The contributions t^eij and m¯eij arise from an effective Helfrich free energy penalising the membrane curvature with bending modulus κ and spontaneous curvature C0 (S1 Appendix 4).

The external force density acting on a single cell is split into two contributions

f=fe+fd, (5)

arising respectively from the action of the pressure difference across the surface

feα=Pnα, (6)

and from an effective external friction force density

fdα=-ξvα, (7)

where ξ is a friction coefficient. In the following, the pressure P is adjusted to impose a value of the cell volume. Eq (2), together with the constitutive Eqs (3)(7), leads to a complete set of equations to determine the velocity field v on the cell surface.

The constitutive laws Eqs (3)(7) are a simple choice of physical description of the surface. Other terms, for instance additional viscous or active bending moments, could be introduced: linear irreversible thermodynamics provides with a set of additional possible terms that could play a role in the dynamics of isotropic, polar or nematic active surfaces and could be added to the framework described here [59, 61, 62]. Furthermore, by neglecting possible dependencies of the constitutive laws Eqs (3)(7) on cortical density ρ, we have implicitly assumed that ρ is homogeneous and constant; this is an appropriate approximation if cortical turnover is faster than the characteristic time for the relaxation dynamics of the cortex by flow and deformation. Furthermore, the active tension γ could be a function of the concentration of molecular actuators, such as myosin molecular motors. We describe how cortical density or other concentration fields on the cell surface can be incorporated into our formulation in the Discussion (see Eq (42)).

2.1.3 Finite element discretisation

We now discretise the geometry of the surface using finite elements based on a triangular control mesh of Ne triangles or elements and Nv vertices (Fig 2). The parametrisation of S is of the form

X(s1,s2)=aXaBa(s1,s2), (8)

where the sum is taken over vertices of the control mesh, labelled by a, Xa is the position of vertex a on the control mesh, and Ba(s1, s2) is its basis function, defined in terms of coordinates (s1, s2) on the control mesh. Given that S may have bending or in-plane moments coupled to variations of the curvature tensor and the Christoffel symbols in the differential virtual work (see Eq (2) and Eq. 34 in S1 Appendix 3), the basis functions Ba must be chosen to have second order derivatives that are square-integrable; here we follow [41, 63, 64] and use Loop subdivision surfaces, which lead to smooth surfaces that satisfy this condition by construction. We note that, in practice, a consistent parametrisation (s1, s2) of the entire control mesh is not needed: indeed one can consider the surface S as a union of surface elements associated to each triangle e of the control mesh, which are given in terms of barycentric coordinates se1, se2 of the element e by

X(se1,se2)=aeXaBae(se1,se2), (9)

see Fig 2. Here we have denoted by 〈e〉 the set of vertices whose basis functions are nonzero in element e, and Bae(se1,se2) corresponds to the contribution of the basis function Ba, within element e, parametrised by the barycentric coordinates of e. For Loop subdivision surfaces, 〈e〉 is formed by the vertices in the triangular element e, and all first neighbours of these vertices.

Fig 2. A smooth surface S representing a cell is obtained based on a triangular control mesh with vertex positions Xa (A) and a set of basis functions per vertex a (B).

Fig 2

(A) To define the mapping between the control mesh and the cell surface, the barycentric coordinates of points in a triangular element e in the control mesh se1,se2, which span a reference triangle, are used to define a point on the cell surface S, X(se1,se2) (Eq (9)). Points X(se1,se2) are obtained by summing basis functions Ba(se1,se2), weighted by Xa, over vertices a whose basis functions have a non-zero contribution to this element, an ensemble denoted 〈e〉. (B) Example of the basis function associated to a vertex in the mesh. For Loop subdivision surfaces basis functions, the basis function spans the first and second rows of elements surrounding the vertex (thicker white line). The vertices that interact with vertex a in the same cell, represented by the set 〈〈a〉〉 (green) are formed by the first, second, and third nearest neighbours in the mesh.

The discretisation of the surface (Eq (8)) transforms the virtual work principle (Eq (2)) into an expression of the form

δW=aFa({Xb,X˙b}ba)·δXa=0. (10)

Here Fa, which can be interpreted as the net force on vertex a, can be obtained by substituting, in the differential virtual work, the analytical expressions for the variations δgij and δCij in terms of δX = ∑a Ba(s1, s2)δXa (S1 Appendix 6). We have denoted by 〈〈a〉〉 the set of vertices interacting with vertex a, which for Loop subdivision surfaces is formed by its first, second and third ring of neighbours (Fig 2B). Since Eq (10) has to be satisfied for any δXa, the net forces on the vertices need to vanish

Fa({Xb,X˙b}ba)=0. (11)

Through this discretisation, we transform the original continuum problem into a set of coupled ordinary differential equations (ODEs). These ODEs need to be discretised in time to be resolved computationally; in the following we denote by (n) the n–th time step of the time evolution. Here we employ a semi-implicit Euler discretisation, where terms arising from the effective bending energy and active tension are discretised in a fully implicit manner, whereas viscous and frictional terms are treated explicitly. This particular choice leads to a variational time-integrator that preserves the dissipative structure of the dynamics for a homogeneous and time-independent active tension [41]. This implies that the tension and bending moment tensors at step n are evaluated as:

t^ij(n)=ηgij(n+1)-gij(n)Δt(n)+γgij(n+1)+κ(C(n+1)kk-C0)[12(C(n+1)kk-C0)gij(n+1)-2Cij(n+1)],m¯ij(n)=κ(C(n+1)kk-C0)gij(n+1), (12)

which can be written in terms of Xa(n+1) and Xa(n) through the relation between the surface definition and the position of vertices, Eq (8). To discretise the strain rate tensor, we have used its relation with the rate of change of components of the metric tensor (see S1 Appendix 2). Plugging these expressions in the differential virtual work Eq (2) allows us to transform Eq (11) into a set of (nonlinear) algebraic equations (S1 Appendix 6)

Fa({Xb(n),Xb(n+1)}ba,P(n+1))=0, (13)

which can be solved using a Newton-Raphson method together with the discretisation of the volume constraint, which is imposed through the nonlinear constraint (S1 Appendix 6.2):

FP(Xa(n+1))=V0. (14)

Here P(n+1) is the intracellular pressure, playing the role of a Lagrange multiplier imposing conservation of volume (S1 Appendix 6.2). In this method, the solution is updated by Xa(n+1)Xa(n+1)+ΔXa, P(n+1)P(n+1) + ΔP where ΔXa and ΔP satisfy the linearised equations

FaXb(n+1)ΔXb=-Fa,FaP(n+1)ΔP=-Fa-FPXa(n+1)ΔXa=FP-V0, (15)

until the norm of Fa and FPV0 is below a given tolerance. Here Fa/Xb(n+1), ∂Fa/∂P(n+1), and -FP/Xa(n+1) form the tangent matrix. Because of the way we perform the discretisation, the tangent matrix is symmetric, in particular -FP/Xa(n+1)=Fa/P(n+1), see S1 Appendix (71)-(74), (83) and (84). Because only vertices in 〈〈a〉〉 interact with a, this matrix is sparse and the linear system can be solved efficiently with an iterative solver. Our computational framework makes use of Trilinos [65] to handle all linear algebra objects, including sparse matrices, in parallel. To solve Eq (15), we employ a GMRES solver from the Belos package of Trilinos.

2.2 Forces arising from cell-cell interactions

Cell-cell adhesion modifies the previous equations by introducing interactions between the vertices of interacting surfaces. We now consider a set of surfaces SI, I = 1…N describing N interacting cells. We assume that a pair of distinct cells I, J interact via an effective energy:

FIJ[XI,XJ]=SIdSISJdSJφ(|XI-XJ|), (16)

where φ is an effective adhesion potential. We first give a microscopic motivation of φ in Section 2.2.1 and then discuss how Eq (16) can be used to derive the governing equations of a cell aggregate in Section 2.2.2.

2.2.1 Microscopic motivation

The form of the effective energy (Eq (16)) can be motivated microscopically by considering an ensemble of stretchable linkers connecting pairs of surfaces, which quickly equilibrate by binding and unbinding to cell surfaces, and whose free concentration is set by contact with a reservoir (Fig 3A). We characterise such an ensemble by a two-point concentration field cIJ(XI, XJ), which quantifies the number of bound linkers joining the points XI and XJ per unit area of the first and second surfaces (thus, it has units of the inverse of an area squared). The concentration cI denotes the concentration of unbound, free linkers in cell I, with units of the inverse of an area. In the dilute limit, the free energy of this ensemble can be written as:

Fmicro=ISIdSIkBTcI(logcIc0-1)+I,JSIdSISJdSJcIJ[kBT(logcIJc02-1)+ϕ(|XI-XJ|)], (17)

where kB is the Boltzmann constant and T the temperature. Here and in the following, we denote distinct cell pairs 〈I, J〉, such that in sums taken over 〈I, J〉, each pair is counted only once. The first sum in Eq 17 corresponds to the free energy of free linkers, described as an ideal solution in contact with a reservoir imposing a chemical potential. This chemical potential determines the value of c0. The second sum corresponds to the free energy of bound linkers, described as an ideal solution, with an energy per linker dependent on the linker elongation, quantified by the potential ϕ. The potential is defined such that the force sustained by a linker of length r is −ϕ′(r). One can then show that if linkers quickly relax to their Boltzmann distribution with respect to surfaces I, J with a fixed shape and free linkers are in contact with a reservoir imposing their equilibrium distribution, then cIJ=c02exp[-ϕ(|XI-XJ|)kBT]. With this assumption, the free energy of interaction of two surfaces I, J is (S1 Appendix 5)

FIJ=-kBTc02SIdSISJdSJexp[-ϕ(|XI-XJ|)kBT], (18)

which gives a relation between the microscopic behaviour of the linkers and the potential φ introduced in Eq (16). For the particular choice of ϕ(r)=ϕ0+k(r-rmin)2/2 with k the bond stiffness and rmin its reference length, one obtains:

φ(r)=-kBTc02exp(-ϕ0kBT)exp[-k(r-rmin)22kBT], (19)

which corresponds to an inverted Gaussian with centre at the equilibrium length rmin, width kBT/k and depth D=kBTc02exp(-ϕ0/(kBT)) (Fig 3B and 3C).

Fig 3. (A) Physical picture of two interacting cells, I and J, that adhere via stretchable linkers.

Fig 3

The concentrations cI and cJ describe the number of free linkers in cells I and J per unit area. When free linkers from cells I and J are in close proximity, they can react to generate a linker joining the two cells. The ensemble of connected linkers is characterised by a two-point concentration field cIJ(XI, XJ) with units of inverse of an area squared. (B) Concentration of connected linkers as a function of the distance r = |XIXJ|, for linear elastic bonds with stiffness k and preferred elongation rmin, fast equilibration of linker density and assuming that free linkers are in contact with a reservoir imposing their equilibrium concentration. (C) Green: effective potential of interaction of two points on two surfaces as a function of their distance r. Black: the Morse potential resembles the effective potential of interaction but with additional short-range repulsion.

However, this description still does not take into account short range repulsion between two cell surfaces. This could be taken into account by introducing a second repulsive interaction potential between surfaces. Here we choose instead to introduce a convenient effective potential of interaction, the Morse potential

φMorse(r)=D{[1-exp(rmin-rl)]2-1}, (20)

which like the interaction potential in Eq (18), vanishes for r → ∞, has a minimum at r = rmin with minimum value −D, and is also peaked around its minimum with characteristic length l. To match the second-order expansion of Eq (19) around rmin, one would choose l=2kBT/k (Fig 3C). In addition, for lrmin the Morse potential exhibits a sharp short-range repulsion.

Although φMorse(r) decays with r rapidly, it is convenient to have a strict cut-off on its range, to limit interacting vertices of the meshes. Therefore, we further multiply φMorse(r) by a smooth step function:

φ(r)=φMorse(r)w(r;rmin,rmin+3l). (21)

where

w(r;r1,r2)={1ifrr1,(r2-rr2-r1)3[6(r2-rr2-r1)2-15(r2-rr2-r1)+10]ifr1<r<r2,0ifrr2. (22)

This ensures that the potential φ(r) goes to zero exactly at a distance rmin + 3l with first and second order continuous derivatives; a convenient property to solve numerically the non-linear equations (Eq (27)).

2.2.2 Governing equations of a cell aggregate

The virtual work differential of the cell aggregate can then be written as:

δW=IδWI+cellpairsI,JδFIJ, (23)

where the contribution δWI is given by Eq (2) with infinitesimal displacement (δXI), metric variation (δgIij) and curvature variation (δCIij) of cell I, and with the tension tensor t^ij, bending moment tensor m¯ij, and external force density excluding cell-cell interaction forces f, given by the constitutive Eqs (3)(7).

Variations of the interaction free energy lead to

δFIJ=SIdSISJdSJ{φ(|XI-XJ|)XIα-XJα|XI-XJ|(δXIα-δXJα)+12φ(|XI-XJ|)(gIijδgIij+gJijδgJij)}. (24)

Comparing this expression with Eq (2), each cell interaction with a cell J is contributing an additional external force density on cell I, fIJ, and an additional isotropic tension to cell I, t^IJij:

fIJ=-SJdSJφ(|XI-XJ|)XI-XJ|XI-XJ|, (25)
t^IJij=SJdSJφ(|XI-XJ|)gIij. (26)

In addition, although this point is not directly apparent from Eq (24), the variation δFIJ can be written only in terms of normal displacements, provided that φ only depends on |XIXJ| (Eq. (53) in S1 Appendix 3). This shows that the net driving force from the interaction potential, including the effect of both the force density fIJ and tension t^IJij, has a vanishing tangential component. Intuitively, the interaction energy does not change if cells do not change shape, so it cannot generate a driving force for tangential motion.

Following the same procedure as in the previous section, the condition δW = 0, with δW defined in Eq (23), gives rise to a set of (nonlinear) algebraic equations of the form

FI,a({XJ,b(n),XJ,b(n+1)}J,bI,a,PI(n+1))=0. (27)

Here 〈〈I, a〉〉 identifies the set of vertices (identified as the pair of labels J for the cell considered and b for the vertex considered) that interact with vertex a in cell I.

2.3 Surface reparametrisation

The method discussed in the previous sections is based on a Lagrangian scheme, such that a node of the mesh flows with the material particles of the interface. This, however, can lead to large in-plane distortions, notably if surface tension gradients generate in-plane flows [41, 50]. To compensate for the resulting mesh distortion, we describe here a reparametrisation method, in the spirit of Refs. [63, 64]. In this method, vertices of the control mesh move tangentially to the surface to minimise an effective mesh quality energy. We stress that this step does not bear any physical meaning. Here we discuss again a single cell. Given the mesh of a cell, we define the energy

Fmesh({Xa}a=1N)=ef(Ie,Je), (28)

where the sum is performed over the triangles of the control mesh, and

Ie=32·le12+le22+le32Ae,Je=AeA, (29)

where Ae is the area of the triangle e and le1, le2, le3 its side lengths. Ie and Je represent the invariants (trace and square root of the determinant) of the Cauchy-Green deformation tensor [66] assuming a reference equilateral triangle of size 〈A〉 = ∑e Ae/Ne, where the sum is taken over the Ne triangles of a meshed surface. To specify the free energy f, we use the Neohookean energy f(Ie, Je) = μIe + λ(Je − 1)2 [66]. Note that we define this energy on the mesh rather than on S. We want to minimise Eq (28), but with the restriction that the cell shape S does not change, so that this operation corresponds to a surface reparametrisation without surface deformation. For this, we evolve the position of the vertices of the mesh according to velocities X˙a. These velocities are obtained by introducing a continuous velocity field on the surface v(s1,s2)=aBa(s1,s2)X˙a, and by solving the following equations for the vertices velocities:

FmeshXaα+S[ξmvα+pnα]BadS=0, (30)
SvαnαBadS=0, (31)

where ξm is a fictitious mesh friction coefficient, p(s1, s2) = ∑a paBa(s1, s2) plays the role of a normal pressure, here a field enforcing the condition that the normal flow vanishes in a weak sense, Eq (31). This leads to the relaxation of the free energy Fmesh following a gradient-flow, with vertices constrained to the shape of S, where the constraint is enforced weakly, i.e. in a finite element sense (S1 Appendix 7, S1 Video).

3 Results

We now discuss applications of the interacting active surface framework. We first consider flows in a single spherical cell driven by gradient of cortical tension, a set-up which allows to compare simulation results to an analytical solution. We then examine the shape of the simplest multicellular aggregate, a doublet formed by two cells, when the two participating cells have equal or different tensions. Next, we consider an aggregate of cells assembled in a planar configuration, recapitulating the organisation of a small epithelial island. Finally, we introduce cell divisions in our framework and simulate the growth of a three-dimensional cell aggregate from a single cell. In the following we introduce a reference length scale =(3V*/(4π))13 which corresponds to cell radius of a spherical cell, a reference surface tension γ¯, and a reference time scale τ=η/γ¯, which corresponds to the characteristic time scale of cortical flows. We use these reference quantities for normalisation of other quantities.

3.1 Single cell: Convergence with mesh size

We first consider flows driven by gradients of active tension in a single cell. This allows us to test the convergence of the numerical method for the dynamics of a single spherical cell, since we can compare the velocity field resulting from the method discretisation to an analytical solution using spherical harmonics; we note here that we only consider the velocity field in the initial, undeformed sphere where the solution with spherical harmonics is exact. We consider a pattern of surface tension on a spherical surface of radius , given by

γ=A=0a=-AAγAaYAa, (32)

where YAa is the spherical harmonic of degree A and order a. The volume enclosed by the surface is assumed to be subjected to a uniform pressure difference P. The resulting velocity field can then be written as (S1 Appendix 8, [67, 68])

v=(iϕ)ei+vnn, (33)

where the functions ϕ and vn can also be expanded in spherical harmonics, ϕ=A=0a=-AAϕAaYAa, vn=A=0a=-AAvnAaYAa, and the coefficients read:

ϕAa=γAaξ44η2A(A+1)(1+ξ22η)+(2+ξ22η)(ξ22η-1),A>0, (34)
vnAa=1(2+ξ22η)[A(A+1)ϕAa-2ηγAa+4π32ηδA0(P+κ(2/-C0)C0)]. (35)

In Fig 4, we consider flows resulting from a surface tension profile given by the coefficients γ00=2πγ¯, γAa=γ¯a2/A2 if 1 < A ≤ 4 and γAa = 0 for A > 4, and from the imposed inner pressure P=2γ¯/ (Fig 4A). We obtain the velocity field analytically (v*, Fig 4B) and numerically (v, Fig 4C), for different mesh sizes. We then compute the L2 norm of the error vv*, i.e. L2(|v-v*|)=S|v-v*|2dS, with respect to the L2 norm of v*, L2(|v*|)=S|v*|2dS. We find an excellent agreement between the exact and numerically obtained velocity field (Fig 4B–4D). The corresponding error scales with (h/)2, where h is the average mesh size, in line with the reported convergence rate of subdivision surfaces for other systems of partial differential equations [69] (Fig 4D).

Fig 4. Single cell dynamics and convergence of the numerical framework.

Fig 4

(A) An inhomogeneous pattern of active surface tension γ is imposed on a spherical surface. (B) Analytically computed velocity field generated by the active tension profile in A. The velocity field is decomposed into its normal (colormap) and tangential (arrows) components. (C) Numerical solution for the velocity profile generated by the active tension profile in A. (D) Discretisation error, evaluated here in terms of the L2 norm of the difference between the analytical and numerical solutions for the velocity, as a function of the average mesh size h and for κ˜=κ/(γ¯2)=0 (blue), κ˜=0.1 (orange) and κ˜=1 (green). Other parameters are ξℓ2/η = 4, C0 = 1.

3.2 Shape and dynamics of an adhering cell doublet

We now discuss the equilibrium shape of an adhering cell doublet. In this and the following sections, the cell pressure difference PI is imposed as a Lagrange multiplier enforcing the condition VI = V0, with VI the cell volume and V0=43π3 a reference volume, and we assume that C0 = 0. With these choices, 5 normalised, non-dimensional parameters have to be specified for each simulation: ξ˜=ξ2/η, l˜=l/, r˜min=rmin/, D˜=Drminl/γ¯, and κ˜=κ/(γ¯2).

In the following we set ξ˜=10-3 so that the effect of friction is small. A cadherin bond has a typical length ∼15–30 nm [70] and a typical actomyosin cortex thickness is 200nm [71], both much smaller than the typical radius of a cell, ∼ from a few to tens of μm. Therefore, in the interaction of potential of cell surface we take r˜min,l˜1. For simplicity, in the following we constrain r˜min=3l˜. We typically choose values between r˜min=0.06, l˜=0.02 and r˜min=0.12, l˜=0.04, which for a cell radius of 5μm, correspond to rmin = 300 − 600nm and l = 100 − 200nm.

We note that if the reference cell volume V0 is constant, the system minimises the net effective free energy F=ISI(γ¯+κ(Cii)2/2)dSI+I,JFIJ, subjected to the constraint VI = V0, where the first term represents an effective energy for the active tension γ¯ and FIJ is defined in Eq (16). We thus expect the system to eventually reach an equilibrium state with vanishing cortical flows.

We first analyse the behaviour of a doublet of identical cells. We initialise the simulation by putting two spherical cells close to each other, such that they are within the interaction range of the potential φ(r) (Eq (21)) without touching. As expected, after an initial transient and contact growth, the doublet reaches an equilibrium shape (Fig 5A and 5B). Increasing the relative adhesion strength D˜ leads to an increasing adhesion patch and a lower cell pressure (Fig 5C and 5D and S1B Fig). The value of the normalised distance l˜ modulates the distance between the two cells (Fig 5E). For D˜ beyond a threshold which depends on r˜min and l˜, the adhesion patch develops a buckling instability. We found that this instability eventually leads to self-intersection of the computational mesh, as there is no energy contribution in our framework preventing such self-intersection (S1A Fig). Varying the bending modulus κ˜, but maintaining relatively small values (κ˜10-2), we find slightly smoother shapes at the boundary of the adhesion patch as well as a slight modulation of the threshold for buckling instability of the contact zone, with larger κ˜ leading to higher stability (Fig 5C and 5E).

Fig 5. Dynamics and steady-state shape of a cell doublet.

Fig 5

(A) Normalised area of contact as a function of time (κ˜=10-2, l˜=0.04). (B) Snapshots of deforming doublet at times indicated in (A), with the cell surface velocity field superimposed. (C) Coloured lines: ratio of contact surface area Acontact to cell surface area A, for simulations with different values of l˜ and κ˜. Black dotted line: theoretical approximation valid in the limit of κ˜0,l˜0,r˜min0. (D) Snapshots of doublet equilibrium shape for increasing adhesion strength; different parameters in (D1)-(D3) correspond to points labelled in C. (E) Comparison of a slice for the different simulations, with values of l˜ and κ˜ indicated in C, and D˜=0.14. The value of κ˜ affects the shape smoothness of the edge of the adhesion patch. (F) Convergence of the method evaluated by computing the L2-norm of the error in the initial velocity field for two different D˜ (D˜=0.05 (orange) and D˜=0.15 (blue)), and different average mesh sizes h, and comparing the results with a simulation with h/ ≈ 2 ⋅ 10−2 (finer). (G) Schematic of adhering doublet, with different active tensions γ1 and γ2 for each cell. (H) Position of the cell centre of mass X1 and X2, as a function of active tension asymmetry between the two adhering cells, α = (γ1γ2)/(γ1 + γ2), where γ1 and γ2 are the surface tensions of the two cells. Beyond α = 0.69, the cell with lowest tension completely engulfs the one with highest tension. (I) Snapshots of doublet equilibrium shape, clipped by a plane passing by the line joining the cell centres, for increasing difference of active surface tension; corresponding to points labelled in H. In H, I: D˜=0.072, κ˜=10-2, l˜=0.04.

To interpret these results, we turn to an approximate analysis of the shape of a doublet. Assuming a small bending rigidity κ˜1, we approximate the cell doublet by two spherical caps of height hc and base of radius rc, forming an adhesion patch where the cells are separated by a distance d (Fig 5E). The effective free energy of such a doublet configuration can then be written as

F(rc,hc,d,P)2γ¯π(2rc2+hc2)+πrc2ζ(d)-2P(V-V0), (36)

where V=πhc(3rc2+hc2)/6 is the volume of one cell, P is the cell pressure, and ζ(d) an effective surface tension at the contact arising from cell-cell adhesion. For a sufficiently large patch compared to the interaction distances rmin and l, the effective surface tension can be approximated as (S1 Appendix 9):

ζ(d)=2π0rdrφ(r2+d2), (37)

which can be evaluated numerically for a given potential φ. Minimising the effective free energy (36), one obtains equilibrium values rc*, hc*, d*, P* (S1 Appendix 9), which depend on the effective surface tension of a cell at the contact:

γl=γ¯(1-12β(rminl)D˜), (38)

where the surface tension of the whole interface is 2γl. Here, we have introduced a numerical function β(rminl), whose functional form depends on the potential φ(r). For the value of rmin/l chosen here, β ≃ 10.7. When the net tension at the contact 2γl becomes negative, for

D˜=Drminlγ¯>2β0.187, (39)

we expect the system to develop a buckling instability. Indeed, the corresponding threshold for buckling is well predicted by the simulation with smallest l/ and bending modulus κ (Fig 5C). Before the buckling instability, the ratio between the contact area and the cell surface area as well as the cell pressure P* are well predicted by the approximate analysis, which become more accurate as κ˜,l˜0 (Fig 5C and S1B Fig).

To further check the numerical method, we analyse the convergence of the velocity field at the initial step as a function of the mesh size h and compare it with the result obtained for a fine mesh h/ ≈ 2 ⋅ 10−2, for a fixed value of l˜=0.02 (Fig 5F). We observe, as in the previous section, convergence of the solution with ∼ h2. We also compare the pressure value P in the equilibrium configuration obtained at different values of h and D˜ and observe that here, on average, errors converge as ∼ h3 (S1C Fig).

Finally, we examine an asymmetric doublet system where cells have different tensions γ1 and γ2 (Fig 5G–5I). The corresponding equilibrium state has been considered previously (Ref. [72] and references therein). Fixing a relatively low value of D˜=0.072, we change the ratio α = (γ1γ2)/(γ1 + γ2). As expected from previous studies, we observe that the cell with lowest tension progressively engulfs the cell with highest tension as the ratio α is increased. As a result, their centre of masses approach each other for increasing values of α (Fig 5H and 5I). In our numerical simulations, beyond α ≃ 0.69, the cell with lowest tension self-intersects before completely engulfing the one with highest tension (S1D Fig).

3.3 Epithelial monolayer

We now discuss simulations of aggregates containing a larger number of cells. We start by considering a sheet of cells with free boundary conditions, intended to resemble the organisation of a simple epithelial island. To obtain an initial condition for such a sheet, spherical cells with homogeneous active tension γ¯ are positioned with their centres on a 6x6 hexagonal lattice with side s = 2 + rmin + l. We then let the system relax to its equilibrium state, varying the adhesion parameter D˜, keeping its value below the instability threshold identified in the doublet analysis. To illustrate how the computational load is distributed in a simulation involving several cells, we discuss the computational resources employed in these relaxation simulations in S1 Appendix 11). As the adhesion parameter D˜ is increased, the cellular shapes progressively deviate from loosely adhering spheres to packed columnar cells (Fig 6A and 6B). The reduced volume v=6πV/A3/2 with V the cell volume and A its surface area, a measure of the deviation of the cell shape from a sphere with v = 1 being a sphere, is close to 1 for small D˜ and then decreases (Fig 6B).

Fig 6. (A) Simulation results (equilibrium shapes) for a planar sheet for different values of the adhesion parameter D˜=Drminl/γ¯ (κ˜=10-2, l˜=0.04).

Fig 6

(B) Reduced volume v as a function of D˜. (C) Schematic for the measured apical and basal cell surface area Aab, lateral surface area Al, side length a and cell thickness hc. (D) Results are compared to a simple 3D vertex model with a lateral surface tension γl and apical and basal surface tension γab. (E) Box plots: ratio of apico-basal to lateral surface area 2Aab/Al for the center cells, as a function of the adhesion parameter D˜. Dashed black, blue and green lines: prediction of simplified theories describing the cell shape as an hexagonal prism, a cylinder with two spherical caps, and the union of a hexagonal prism with two spherical caps. Inset: cellular aspect ratio a/hc, with a measuring the side of the hexagonal face and hc the thickness of the sheet, as a function of D˜. Here a=2Aab/(33) and hc = Al/(6a). (F) Schematic for the polar vector P characterising the asymmetry of the cell shape. (G) Box plot for Pz (blue) and |Pz| (red). As adhesion increases, cells deform asymmetrically in the direction orthogonal to the planar sheet.

We compare the simulation results with a theoretical prediction from a 3D vertex model on a perfect hexagonal lattice, i.e. formed by uniform hexagonal prisms with height hc and side length a (Fig 6C and 6D). We consider that cells are subjected to an apico-basal tension γab=γ¯, lateral tension γl=γ¯(1-βD˜/2), and an inner pressure P enforcing the cell volume to be equal to the reference volume V0 = 4πℓ3/3. We then write the corresponding effective free energy for a single cell in the tissue (S1 Appendix 10):

F(a,hc,P)=2γabAab+γlAl-P(V-V0). (40)

For a hexagonal prism, Aab=33a2/2 the apical and basal surface area, Al = 6ahc the lateral surface area, and the cell volume is V=33a2hc/2. Minimising the effective free energy, we obtain the equilibrium ratio Aab/Al which can be compared to simulation results for the 16 inner cells (Fig 6E). This area ratio is related to the cell aspect ratio, with smaller values corresponding to more columnar cells and larger values corresponding to more squamous cells. Although this simplified model captures the qualitative trend of the cell shape dependency on cell adhesion, it underestimates the simulated area ratio.

We now consider alternative simplified descriptions where (i) each cell is considered as a cylinder connected to two spherical caps, or (ii) use an approximation where the surface area and volume of the cell is defined through the union of a hexagonal prism and two spherical caps (S1 Appendix 10). These choices better capture the actual simulated shapes (Fig 6E), showing that taking the apical and basal curvatures play a significant role in the equilibrium cell shape. These refined models however still underestimate the area ratio Aab/Al. This can arise from the fact that these simplified descriptions do not take into account the surface bending modulus, the tissue-scale deformation due to the system finite size and free boundary conditions, and consider approximate cell shapes.

In addition, we noticed that for higher values of D˜, the cellular shapes appear more heterogeneous (Fig 6A). This heterogeneity appears to be linked to an asymmetry in the cell apical and basal surface areas (see zoomed area comparing how lateral faces look for small D˜=0.07 and for larger D˜=0.15 in Fig 6A). To verify this, we introduce a polar order parameter for the shape of cell I (Fig 6F):

PI=1SISIdSIX-1VIVIdVIX, (41)

with VI the volumetric domain enclosed by SI, and SI and VI the surface area and volume of cell I. We calculate the order parameter for all cells in the simulation and consider its projection on the direction orthogonal to the plane containing the initial cell centers, z. We observe that, with increasing adhesion strength D˜, the average projected cell polarity does not clearly deviate from zero, 〈Pz〉 ≃ 0, but the average of the absolute value of the projected cell polarity, 〈|Pz|〉, strongly increases (Fig 6G). This suggests that at high enough adhesion, cells adopt polarised apico-basal shapes orthogonal to the plane of the tissue, with no consistent overall shape polarisation orthogonal to the tissue (Fig 6A). Possibly, such a spatial arrangement favours larger contact areas, which is beneficial at large adhesion.

3.4 Adding cell divisions: Growth of an organoid

We now discuss simulations modelling the growth of a cell aggregate from a single cell, for which we introduce cell divisions in our framework. When a cell divides, the mother cell is replaced by two daughter cells as follows: a randomly oriented plane passing through the mother cell centre is selected, splitting the mother cell in two parts. The two daughter cells are then separated by this plane and simply fill the original shape of the mother, except for a small region that separates the daughter cells by a distance d*, perpendicular to the division plane (Fig 7A). To determine timepoints of cell division, each cell is assigned a cell cycle time tD, which we take equal for all cells.

Fig 7. Growth of small cell aggregates, driven by synchronous cell divisions and cell volume increase (D˜=0.15, κ˜=10-2, ˜=0.04).

Fig 7

(A) Each cell doubles its volume between birth and division, over a cell cycle time tD. Cell division is introduced by splitting the mother cell with a plane passing through the cell centre, and generating two daughter cells separated by a distance d* (d*/2 from the division plane). (B-D) Simulation results for two values of the ratio τ/tD. (B): Largest centre-to-centre cell distance maxI,J RIJ, as a function of time. Jumps correspond to cell division events. (C) Average reduced volume 〈v〉 as a function of time. (D) Snapshots of simulations of two growing aggregates.

We assume that in between divisions, cell volume follows a linear growth law V˙I=V0/tD, where V0 is the volume of the cell at its birth. This effectively leads to cells doubling their volume during their lifetime—we note however that a small volume loss occurs at division due to the initial separation of the daughter cells by a distance d* (Fig 7A). At each time point, cell volume is imposed through the Lagrange multiplier PI.

We then simulate the growth of an aggregate starting from a single cell (Fig 7B–7D, S2 and S3 Videos). The dynamics of the growing aggregate strongly depends on τ/tD, which measures the ratio between a characteristic time scale of cell shape relaxation, and the cell cycle time.

For smaller values of τ/tD, the growing aggregate is more compact (Fig 7B), cells have a smaller reduced volume and have therefore shapes further away from spheres (Fig 7C). Here, the aggregate compactness is measured by calculating the maximum distance between cell centres (Fig 7B). These observations indicate that the shape of a cell aggregate can strongly depend on a competition between its growth rate and internal mechanical relaxation times.

4 Discussion

The framework of interacting active surfaces introduced here is a novel method to study the mechanics of cell aggregates such as early developing embryos or organoids, and opens the door to their systematic modelling and simulation. We have demonstrated here that it can be used to study in detail the shape of adhering cell doublets, simple epithelia, as well as growing cellular aggregates. Our method is well-suited to capture the mechanics of tissues and organoids connecting it to cell level processes such as cortical flows, cortical tension and cellular adhesion in the organisation of a cellular aggregate.

In this study we have restricted ourselves to relatively simple constitutive equations for the tension and bending moment tensors (Eq (3)), and we have considered situations with a uniform and constant surface tension within each cell. Our method is based on using the virtual work principle (Eq (2)), a very general statement of force and torque balance for a surface, to obtain a set of algebraic equations for the cell surface described with finite elements. As such it is versatile and we expect that more complex constitutive equations, corresponding to more detailed physical descriptions of the cell surface, can be easily introduced in our description. We now discuss some of these possible extensions of our framework.

We have not included here apico-basal polarity, an axis of cell organisation which results from a spatially segregated protein distribution and inhomogeneous cytoskeletal structures [73]. To take this into account, one could introduce a polarity field in each cell and consider an active tension γ on the cell surface whose value at each point depends on the polarity field orientation. This could be used to introduce, for instance, differences in apical, basal and lateral surface tension which are taken into account in 3D vertex models [19].

It would be natural to introduce a concentration field on the cell surface, describing a regulator of the cortical tension, such as myosin concentration. At the level of a single surface, such coupling between cortical flows and its regulator can give rise to pattern formation, spontaneous symmetry breaking and shape oscillation [40, 74, 75]. The dynamics of the concentration per unit area, c, of such a regulator can be obtained from the balance equation on the surface:

Dtc+cvii+·j=r, (42)

where Dtc is the material derivative of c (∂tc in a Lagrangian description), j is the flux of c relative to the centre of mass, and r is a reaction rate. A natural choice for the flux would be j = −Dc to represent diffusion according to Fick’s law. A natural choice for the reaction rate would be r = konkoffc for turnover dynamics, with target concentration c0 = kon/koff and typical turnover time τ=koff-1. The discretisation of such fields can be easily introduced in our framework, following the methods detailed in [41, 76]. One could then model the effect of this concentration on the active tension by assuming e.g. γ(c) = γ0c/c0 with γ0 a reference tension at c = c0.

Importantly, the model introduced here is based on an interaction potential between cells, which can be motivated microscopically from a description of cell-cell linkers that equilibrate quickly to their Boltzmann distribution, with free linkers on the surface in contact with a reservoir imposing a constant concentration. From a computational perspective, the exact integration of the interaction potential requires the computation of double integrals, which have a large computational cost. Alternatively, one could approximate the double integrals further in the limit l˜,r˜min1 by considering the interaction of each point on surface SI only with its closest point projection on SJ, following classical numerical approaches for the adhesion between interfaces (Ref. [77] and references therein).

On the other hand, the interplay of adhesive cell-cell linkers such as E-cadherin with cortical dynamics also plays an important role in orchestrating cell adhesion [78]. Unlike the specific adhesion of solid interfaces, cell-cell adhesion dynamics involves a complex interplay between the diffusion, advection and binding dynamics of linkers [79]. Notably, E-cadherin junctions have been shown to be mechanosensitive [80] and to act to regulate the actomyosin levels at junctions [81]. To take these effects into account, an explicit description of E-cadherin concentration on the cell surface might be required. Thus, an extension of our model could introduce explicitly two-point density fields cIJ(XI, XJ) representing the concentration of bound linkers between cells I and J, as well as a concentration field of free linkers on each cell cI. Alternatively, one could introduce cell-cell adhesion by considering a finite number of explicitely described individual linkers [82].

Our model does not account for the friction generated by relative surface flows between cells that adhere to each other, which is likely to play an important role during cell rearrangements. The effective friction stemming from an ensemble of transiently binding and unbinding linkers can be modelled effectively with a friction coefficient motivated by microscopic models such as a Lacker-Peskin model [83], which lead to predictions of force-velocity relations which depend on whether linkers are force-sensitive, e.g. slip or catch bonds [84, 85]. One could include these terms systematically in our finite element discretisation following the ideas in [86, 87].

In its current version and with these additions, we hope that the interacting active surface framework will be a useful tool to investigate the mechanics and self-organisation of cellular aggregates.

Supporting information

S1 Appendix. Details of derivations and computational framework used in the main text.

(PDF)

S1 Fig

(A) Side view, cut by a plane perpendicular to the adhesion patch of an adhering doublet for D˜ larger than the critical value. The system develops a buckling instability that grows with time. The instability eventually leads to self-intersections (right-most image, where the blue cell has collapsed). (B) Coloured lines: pressure for simulations with different values of l˜ and κ˜. Black dotted line: theoretical approximation valid in the limit of κ˜0,l˜0,r˜min0. (C) Convergence of the method evaluated by computing the inner cell pressure P for different average mesh sizes h, and comparing the results with a simulation with h/ ≈ 2 ⋅ 10−2 (finer). For each h, we compute a box plot using different values of D˜ and fixed κ˜=10-2, l˜=0.02. (D) Side view, cut by a plane perpendicular to the adhesion patch of an adhering doublet with asymmetric tension for α = 0.7; the cell with lower tension (blue) engulfing the cell with higher tension (red) develops a self-intersection in our numerical simulations (right-most image).

(PDF)

S1 Video. Comparison of the mesh relaxation method for different values of the tolerance for normal motion (left column: 10−3, right column: 10−4) and different mesh sizes (top row: 4 × 10−2, bottom row: 2 × 10−2).

The colormap represents the distance to the original surface, which is in all cases below 5 × 10−3.

(M4V)

S2 Video. Growth of a cell aggregate driven by cell growth and cell divisions in the case where the cell lifetime tD is ten times larger than the shape relaxation time-scale τ.

(MP4)

S3 Video. Growth of a cell aggregate driven by cell growth and cell divisions in the case where the cell lifetime tD is ten times smaller than the shape relaxation time-scale τ.

(MP4)

Acknowledgments

We thank Quentin Vagne and Guillermo Vilanova for comments on the manuscript.

Data Availability

The source code used to produce the results and analyses presented in this manuscript is available at the Git repository: https://github.com/torressancheza/ias.

Funding Statement

ATS, MKW and GS acknowledge support from the Francis Crick Institute, which receives its core funding from Cancer Research UK (FC001317, https://www.cancerresearchuk.org), the UK Medical Research Council (FC001317, https://www.ukri.org/councils/mrc/), and the Wellcome Trust (FC001317, https://wellcome.org). GS and ATS acknowledge support from a grant to GS, Chris Dunsby, Axel Behrens from the Engineering and Physical Sciences Research Council (EP/T003103/1, https://epsrc.ukri.org). The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.

References

  • 1. Heer NC, Martin AC. Tension, contraction and tissue morphogenesis. Development. 2017;144(23):4249–4260. doi: 10.1242/dev.151282 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2. Stooke-Vaughan GA, Campàs O. Physical control of tissue morphogenesis across scales. Curr Opin Genet Dev. 2018;51:111–119. doi: 10.1016/j.gde.2018.09.002 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3. Lecuit T, Lenne PF. Cell surface mechanics and the control of cell shape, tissue patterns and morphogenesis. Nat Rev Mol Cell Biol. 2007;8:633–644. doi: 10.1038/nrm2222 [DOI] [PubMed] [Google Scholar]
  • 4. Huch M, Knoblich JA, Lutolf MP, Martinez-Arias A. The hope and the hype of organoid research. Development. 2017;144(6):938–941. doi: 10.1242/dev.150201 [DOI] [PubMed] [Google Scholar]
  • 5. Kamm RD, Bashir R, Arora N, Dar RD, Gillette MU, Griffith LG, et al. Perspective: The promise of multi-cellular engineered living systems. APL bioengineering. 2018;2(4):040901. doi: 10.1063/1.5038337 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6. Rossi G, Manfrin A, Lutolf MP. Progress and potential in organoid research. Nat Rev Genet. 2018;19(11):671–687. doi: 10.1038/s41576-018-0051-9 [DOI] [PubMed] [Google Scholar]
  • 7. Graner F, Glazier JA. Simulation of biological cell sorting using a two-dimensional extended Potts model. Phys Rev Lett. 1992;69(13):2013–2016. doi: 10.1103/PhysRevLett.69.2013 [DOI] [PubMed] [Google Scholar]
  • 8. Glazier JA, Graner F. Simulation of the differential adhesion driven rearrangement of biological cells. Phys Rev E.1993;47(3):2128–2154. doi: 10.1103/PhysRevE.47.2128 [DOI] [PubMed] [Google Scholar]
  • 9. Marée AFM, Jilkine A, Dawes A, Grieneisen VA, Edelstein-Keshet L. Polarization and movement of keratocytes: a multiscale modelling approach. Bull Math Biol. 2006;68(5):1169–1211. doi: 10.1007/s11538-006-9131-7 [DOI] [PubMed] [Google Scholar]
  • 10. Marée AFM, Grieneisen VA, Hogeweg P. The Cellular Potts Model and Biophysical Properties of Cells, Tissues and Morphogenesis. In: Anderson ARA, Chaplain MAJ, Rejniak KA, editors. Single-Cell-Based Models in Biology and Medicine. Basel: Birkhäuser Basel; 2007. p. 107–136. [Google Scholar]
  • 11. Scianna M, Preziosi L, Wolf K. A Cellular Potts Model simulating cell migration on and in matrix environments. Math Biosci Eng. 2013;10(1):235–261. doi: 10.3934/mbe.2013.10.235 [DOI] [PubMed] [Google Scholar]
  • 12. Vroomans RMA, Hogeweg P, ten Tusscher KHWJ. Segment-specific adhesion as a driver of convergent extension. PLoS Comput Biol. 2015;11(2):e1004092. doi: 10.1371/journal.pcbi.1004092 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13. Boas SEM, Jiang Y, Merks RMH, Prokopiou SA, Rens EG. Cellular Potts Model: Applications to Vasculogenesis and Angiogenesis. In: Louis PY, Nardi FR, editors. Probabilistic Cellular Automata: Theory, Applications and Future Perspectives. Cham: Springer International Publishing; 2018. p. 279–310. [Google Scholar]
  • 14. Nonomura M. Study on multicellular systems using a phase field model. PLoS ONE. 2012;7(4):e33501. doi: 10.1371/journal.pone.0033501 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15. Löber J, Ziebert F, Aranson IS. Collisions of deformable cells lead to collective migration. Sci Rep. 2015;5:9172. doi: 10.1038/srep09172 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16. Najem S, Grant M. Phase-field model for collective cell migration. Phys Rev E. 2016;93(5):052405. doi: 10.1103/PhysRevE.93.052405 [DOI] [PubMed] [Google Scholar]
  • 17. Moure A, Gomez H. Phase-Field Modeling of Individual and Collective Cell Migration. Arch Computat Methods Eng. 2021;28:311–344. doi: 10.1007/s11831-019-09377-1 [DOI] [Google Scholar]
  • 18. Kuang X, Guan G, Wong MK, Chan LY, Zhao Z, Tang C, et al. Computable early Caenorhabditis elegans embryo with a phase field model. PLoS Comput Biol. 2022;18(1):e1009755. doi: 10.1371/journal.pcbi.1009755 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19. Alt S, Ganguly P, Salbreux G. Vertex models: from cell mechanics to tissue morphogenesis. Phil. Trans. R. Soc. B. 2017;372:20150520. doi: 10.1098/rstb.2015.0520 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20. Bi D, Yang X, Marchetti MC, Manning ML. Motility-Driven Glass and Jamming Transitions in Biological Tissues. Phys Rev X. 2016;6(2):021011. doi: 10.1103/PhysRevX.6.021011 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21. Merkel M, Lisa Manning M. A geometrically controlled rigidity transition in a model for confluent 3D tissues. New J Phys. 2018;20(2):022002. doi: 10.1088/1367-2630/aaaa13 [DOI] [Google Scholar]
  • 22. Nagai T, Kawasaki K, Ohta S. Vertex Model of Cellular Pattern Growth in Two and Three Dimensions. In: Onuki A, Kawasaki K, editors. Dynamics and Patterns in Complex Fluids. Berlin, Heidelberg: Springer Berlin Heidelberg; 1990. p. 179–181. [Google Scholar]
  • 23. Nagai T, Honda H. A dynamic cell model for the formation of epithelial tissues. Philos Mag B. 2001;81(7):699–719. doi: 10.1080/13642810110055328 [DOI] [Google Scholar]
  • 24. Fletcher AG, Osterfield M, Baker RE, Shvartsman SY. Vertex models of epithelial morphogenesis. Biophys J. 2014;106(11):2291–2304. doi: 10.1016/j.bpj.2013.11.4498 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25. Staple DB, Farhadifar R, Röper JC, Aigouy B, Eaton S, Jülicher F. Mechanics and remodelling of cell packings in epithelia. Eur Phys J E. 2010;33(2):117–127. doi: 10.1140/epje/i2010-10677-0 [DOI] [PubMed] [Google Scholar]
  • 26. Landsberg KP, Farhadifar R, Ranft J, Umetsu D, Widmann TJ, Bittig T, et al. Increased Cell Bond Tension Governs Cell Sorting at the Drosophila Anteroposterior Compartment Boundary. Curr Biol. 2009;19(22):1950–1955. doi: 10.1016/j.cub.2009.10.021 [DOI] [PubMed] [Google Scholar]
  • 27. Nagai T, Honda H. Computer simulation of wound closure in epithelial tissues: cell-basal-lamina adhesion. Phys Rev E. 2009;80(6):061903. doi: 10.1103/PhysRevE.80.061903 [DOI] [PubMed] [Google Scholar]
  • 28. Bielmeier C, Alt S, Weichselberger V, La Fortezza M, Harz H, Jülicher F, et al. Interface Contractility between Differently Fated Cells Drives Cell Elimination and Cyst Formation. Curr Biol. 2016;26(5):563–574. doi: 10.1016/j.cub.2015.12.063 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29. Messal HA, Alt S, Ferreira RMM, Gribben C, Wang VMY, Cotoi CG, et al. Tissue curvature and apicobasal mechanical tension imbalance instruct cancer morphogenesis. Nature. 2019;566(7742):126–130. doi: 10.1038/s41586-019-0891-2 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30. Salbreux G, Charras G, Paluch E. Actin cortex mechanics and cellular morphogenesis. Trends Cell Biol. 2012;22(10):536–545. doi: 10.1016/j.tcb.2012.07.001 [DOI] [PubMed] [Google Scholar]
  • 31. Saha A, Nishikawa M, Behrndt M, Heisenberg CP, Jülicher F, Grill SW. Determining Physical Properties of the Cell Cortex. Biophys J. 2016;110(6):1421–1429. doi: 10.1016/j.bpj.2016.02.013 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32. Clark AG, Wartlick O, Salbreux G, Paluch EK. Stresses at the cell surface during animal cell morphogenesis. Curr Biol. 2014;24(10):R484–R494. doi: 10.1016/j.cub.2014.03.059 [DOI] [PubMed] [Google Scholar]
  • 33. Mayer M, Depken M, Bois JS, Jülicher F, Grill SW. Anisotropies in cortical tension reveal the physical basis of polarizing cortical flows. Nature. 2010;467(7315):617–621. doi: 10.1038/nature09376 [DOI] [PubMed] [Google Scholar]
  • 34. Callan-Jones AC, Voituriez R. Active gel model of amoeboid cell motility. New J Phys. 2013;15(2):025022. doi: 10.1088/1367-2630/15/2/025022 [DOI] [Google Scholar]
  • 35. Turlier H, Audoly B, Prost J, Joanny JF. Furrow constriction in animal cell cytokinesis. Biophys J. 2014;106(1):114–123. doi: 10.1016/j.bpj.2013.11.014 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36. Bergert M, Erzberger A, Desai RA, Aspalter IM, Oates AC, Charras G, et al. Force transmission during adhesion-independent migration. Nat Cell Biol. 2015;17(4):524–529. doi: 10.1038/ncb3134 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37. Reymann AC, Staniscia F, Erzberger A, Salbreux G, Grill SW. Cortical flow aligns actin filaments to form a furrow. Elife. 2016;5:e17807. doi: 10.7554/eLife.17807 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38. Callan-Jones AC, Ruprecht V, Wieser S, Heisenberg CP, Voituriez R. Cortical Flow-Driven Shapes of Nonadherent Cells. Phys Rev Lett. 2016;116(2):028102. doi: 10.1103/PhysRevLett.116.028102 [DOI] [PubMed] [Google Scholar]
  • 39. Callan-Jones AC, Voituriez R. Actin flows in cell migration: from locomotion and polarity to trajectories. Curr Opin Cell Biol. 2016;38:12–17. doi: 10.1016/j.ceb.2016.01.003 [DOI] [PubMed] [Google Scholar]
  • 40. Mietke A, Jülicher F, Sbalzarini IF. Self-organized shape dynamics of active surfaces. Proc Natl Acad Sci U S A. 2019;116(1):29–34. doi: 10.1073/pnas.1810896115 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 41. Torres-Sánchez A, Millán D, Arroyo M. Modelling fluid deformable surfaces with an emphasis on biological interfaces. J Fluid Mech. 2019;872:218–271. doi: 10.1017/jfm.2019.341 [DOI] [Google Scholar]
  • 42. da Rocha HB, Bleyer J, Turlier H. A viscous active shell theory of the cell cortex. J Mech Phys Solids. 2022;164;104876. doi: 10.1016/j.jmps.2022.104876 [DOI] [Google Scholar]
  • 43. Reuther S, Voigt A. The Interplay of Curvature and Vortices in Flow on Curved Surfaces. Multiscale Model Simul. 2015;13(2):632–643. doi: 10.1137/140971798 [DOI] [Google Scholar]
  • 44. Gross BJ, Atzberger PJ. Hydrodynamic flows on curved surfaces: Spectral numerical methods for radial manifold shapes. J Comput Phys. 2018;371:663–689. doi: 10.1016/j.jcp.2018.06.013 [DOI] [Google Scholar]
  • 45. Gross B, Atzberger PJ. Spectral Numerical Exterior Calculus Methods for Differential Equations on Radial Manifolds. J Sci Comput. 2018;76(1):145–165. doi: 10.1007/s10915-017-0617-2 [DOI] [Google Scholar]
  • 46. Nestler M, Nitschke I, Voigt A. A finite element approach for vector- and tensor-valued surface PDEs. J Comput Phys. 2019;389:48–61. doi: 10.1016/j.jcp.2019.03.006 [DOI] [Google Scholar]
  • 47. Dziuk G, Elliott CM. Finite element methods for surface PDEs. Acta Numer. 2013;22:289–396. doi: 10.1017/S0962492913000056 [DOI] [Google Scholar]
  • 48. Rodrigues DS, Ausas RF, Mut F, Buscaglia GC. A semi-implicit finite element method for viscous lipid membranes. J Comput Phys. 2015;298:565–584. doi: 10.1016/j.jcp.2015.06.010 [DOI] [Google Scholar]
  • 49. Barrett JW, Garcke H, Nürnberg R. A stable numerical method for the dynamics of fluidic membranes. Numer Math. 2016;134(4):783–822. doi: 10.1007/s00211-015-0787-5 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 50. Sahu A, Omar YAD, Sauer RA, Mandadapu KK. Arbitrary Lagrangian–Eulerian finite element method for curved and deforming surfaces: I. General theory and application to fluid interfaces. J Comput Phys. 2020;407:109253. doi: 10.1016/j.jcp.2020.109253 [DOI] [Google Scholar]
  • 51. Reuther S, Nitschke I, Voigt A. A numerical approach for fluid deformable surfaces. J Fluid Mech. 2020;900:R8. doi: 10.1017/jfm.2020.564 [DOI] [Google Scholar]
  • 52. Omar YAD, Sahu A, Sauer RA, Mandadapu KK. Nonaxisymmetric Shapes of Biological Membranes from Locally Induced Curvature. Biophys J. 2020;119(6):1065–1077. doi: 10.1016/j.bpj.2020.07.021 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 53. Bächer C, Khoromskaia D, Salbreux G, Gekle S. A Three-Dimensional Numerical Model of an Active Cell Cortex in the Viscous Limit. Front Phys. 2021;9. [Google Scholar]
  • 54. Van Liedekerke P, Neitsch J, Johann T, Warmt E, Gonzàlez-Valverde I, Hoehme S, et al. A quantitative high-resolution computational mechanics cell model for growing and regenerating tissues. Biomech Model Mechanobiol. 2020;19(1):189–220. doi: 10.1007/s10237-019-01204-7 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 55. Cuvelier M, Pešek J, Papantoniou I, Ramon H, Smeets B. Distribution and propagation of mechanical stress in simulated structurally heterogeneous tissue spheroids. Soft Matter. 2021;17(27):6603–6615. doi: 10.1039/D0SM02033H [DOI] [PubMed] [Google Scholar]
  • 56. Van Liedekerke P, Gannoun L, Loriot A, Johann T, Lemaigre FP, Drasdo D. Quantitative modeling identifies critical cell mechanics driving bile duct lumen formation. PLoS Comput Biol. 2022;18(2):e1009653. doi: 10.1371/journal.pcbi.1009653 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 57. Cuvelier M, Thiels W, Jelier R, Smeets B. Stability of asymmetric cell division under confinement: A deformable cell model of cytokinesis applied to C. elegans development; 2022. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 58.Torres-Sánchez A, Winter MK, Salbreux G. ias; 2021. https://github.com/torressancheza/ias.
  • 59. Salbreux G, Jülicher F. Mechanics of active surfaces. Phys Rev E. 2017;96(3-1):032404. doi: 10.1103/PhysRevE.96.032404 [DOI] [PubMed] [Google Scholar]
  • 60. Purcell EM. Life at low Reynolds number. Am J Phys. 1977;45(1):3–11. doi: 10.1119/1.10903 [DOI] [Google Scholar]
  • 61. Sahu A, Sauer RA, Mandadapu KK. Irreversible thermodynamics of curved lipid membranes. Phys Rev E. 2017;96(4-1):042409. doi: 10.1103/PhysRevE.96.042409 [DOI] [PubMed] [Google Scholar]
  • 62. Salbreux G, Jülicher F, Prost J, Callan-Jones A. Theory of nematic and polar active fluid surfaces. Phys Rev Research. 2022;4; 033158. doi: 10.1103/PhysRevResearch.4.033158 [DOI] [Google Scholar]
  • 63. Feng F, Klug WS. Finite element modeling of lipid bilayer membranes. J Comput Phys. 2006;220(1):394–408. doi: 10.1016/j.jcp.2006.05.023 [DOI] [Google Scholar]
  • 64. Ma L, Klug WS. Viscous regularization and r-adaptive remeshing for finite element analysis of lipid membrane mechanics. J Comput Phys. 2008;227(11):5816–5835. doi: 10.1016/j.jcp.2008.02.019 [DOI] [Google Scholar]
  • 65.Trilinos;. https://trilinos.github.io/index.html.
  • 66. Marsden JE, Hughes TJR. Mathematical Foundations of Elasticity. New York, New York, USA: Courier Corporation; 1994. [Google Scholar]
  • 67.R. Abraham, J. E. Marsden, T. Ratiu, Manifolds, Tensor Analysis, and Applications, Springer Science & Business Media, 2012.
  • 68. Bhatia H, Norgard G, Pascucci V, Bremer P.-T, The Helmholtz-Hodge decomposition–a survey, IEEE Trans. Vis. Comput. Graph. 19 (8) (2013) 1386–1404. doi: 10.1109/TVCG.2012.316 [DOI] [PubMed] [Google Scholar]
  • 69. Barendrecht PJ, Bartoň M, Kosinka J. Efficient quadrature rules for subdivision surfaces in isogeometric analysis. Comput Methods Appl Mech Eng. 2018;340:1–23. doi: 10.1016/j.cma.2018.05.017 [DOI] [Google Scholar]
  • 70. Brasch J, Harrison OJ, Honig B, Shapiro L. Thinking outside the cell: how cadherins drive adhesion. Trends Cell Biol. 2012;22(6):299–310. doi: 10.1016/j.tcb.2012.03.004 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 71. Clark AG, Dierkes K, Paluch EK. Monitoring actin cortex thickness in live cells. Biophys J. 2013;105(3):570–580. doi: 10.1016/j.bpj.2013.05.057 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 72. Maître JL, Turlier H, Illukkumbura R, Eismann B, Niwayama R, Nédélec F, et al. Asymmetric division of contractile domains couples cell positioning and fate specification. Nature. 2016;536(7616):344–348. doi: 10.1038/nature18958 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 73. Motegi F, Plachta N, Viasnoff V. Novel approaches to link apicobasal polarity to cell fate specification. Curr Opin Cell Biol. 2020;62:78–85. doi: 10.1016/j.ceb.2019.09.003 [DOI] [PubMed] [Google Scholar]
  • 74. Bois JS, Jülicher F, Grill SW. Pattern formation in active fluids. Phys Rev Lett. 2011;106(2):028103. doi: 10.1103/PhysRevLett.106.028103 [DOI] [PubMed] [Google Scholar]
  • 75. Mietke A, Jemseena V, Kumar KV, Sbalzarini IF, Jülicher F. Minimal model of cellular symmetry breaking. Phys Rev Lett. 2019;123(18):188101. doi: 10.1103/PhysRevLett.123.188101 [DOI] [PubMed] [Google Scholar]
  • 76. Torres-Sánchez A, Santos-Oliván D, Arroyo M. Approximation of tensor fields on surfaces of arbitrary topology based on local Monge parametrizations. J Comput Phys. 2020;405:109168. doi: 10.1016/j.jcp.2019.109168 [DOI] [Google Scholar]
  • 77. Sauer RA, De Lorenzis L. A computational contact formulation based on surface potentials. Comput Methods Appl Mech Eng. 2013;253:369–395. doi: 10.1016/j.cma.2012.09.002 [DOI] [Google Scholar]
  • 78. Lecuit T, Yap AS. E-cadherin junctions as active mechanical integrators in tissue dynamics. Nat Cell Biol. 2015;17(5):533–539. doi: 10.1038/ncb3136 [DOI] [PubMed] [Google Scholar]
  • 79. Kaurin D, Bal PK, Arroyo M. Peeling dynamics of fluid membranes bridged by molecular bonds: moving or breaking. J R Soc Interface. 2022; 19; 20220183. doi: 10.1098/rsif.2022.0183 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 80. Iyer KV, Piscitello-Gómez R, Paijmans J, Jülicher F, Eaton S. Epithelial viscoelasticity is regulated by mechanosensitive E-cadherin turnover. Curr Biol. 2019;29(4):578–591. doi: 10.1016/j.cub.2019.01.021 [DOI] [PubMed] [Google Scholar]
  • 81. Sumi A, Hayes P, D’Angelo A, Colombelli J, Salbreux G, Dierkes K, et al. Adherens junction length during tissue contraction is controlled by the mechanosensitive activity of actomyosin and junctional recycling. Dev cell. 2018;47(4):453–463. doi: 10.1016/j.devcel.2018.10.025 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 82. Nestor-Bergmann A, Blanchard GB, Hervieux N, Fletcher AG, Étienne J, Sanson B. Adhesion-regulated junction slippage controls cell intercalation dynamics in an Apposed-Cortex Adhesion Model. PLoS Comput Biol. 2022;18(1):e1009812. doi: 10.1371/journal.pcbi.1009812 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 83. Lacker HM, Peskin CS. A mathematical method for the unique determination of cross-bridge properties from steady-state mechanical and energetic experiments on macroscopic muscle. In: Lecture on Mathematics in the Life sciences. vol. 16. AMS; 1986. p. 121–153. [Google Scholar]
  • 84. Srinivasan M, Walcott S. Binding site models of friction due to the formation and rupture of bonds: state-function formalism, force-velocity relations, response to slip velocity transients, and slip stability. Phys Rev E. 2009;80(4 Pt 2):046124. doi: 10.1103/PhysRevE.80.046124 [DOI] [PubMed] [Google Scholar]
  • 85. Sabass B, Schwarz US. Modeling cytoskeletal flow over adhesion sites: competition between stochastic bond dynamics and intracellular relaxation. J Phys Condens Matter. 2010;22(19):194112. doi: 10.1088/0953-8984/22/19/194112 [DOI] [PubMed] [Google Scholar]
  • 86. Mergel JC, Sahli R, Scheibert J, Sauer RA. Continuum contact models for coupled adhesion and friction. J Adhes. 2019;95(12):1101–1133. doi: 10.1080/00218464.2018.1479258 [DOI] [Google Scholar]
  • 87. Mergel JC, Scheibert J, Sauer RA. Contact with coupled adhesion and friction: Computational framework, applications, and new insights. J Mech Phys Solids. 2021;146:104194. doi: 10.1016/j.jmps.2020.104194 [DOI] [Google Scholar]
PLoS Comput Biol. doi: 10.1371/journal.pcbi.1010762.r001

Decision Letter 0

Douglas A Lauffenburger, Saúl Ares

8 Jul 2022

Dear Dr Salbreux,

Thank you very much for submitting your manuscript "Interacting active surfaces: a model for three-dimensional cell aggregates" for consideration at PLOS Computational Biology.

As with all papers reviewed by the journal, your manuscript was reviewed by members of the editorial board and by several independent reviewers. In light of the reviews (below this email), we would like to invite the resubmission of a significantly-revised version that takes into account the reviewers' comments.

We have now finally received the three reports for your manuscript "Interacting active surfaces: a model for three-dimensional cell aggregates". As you can see, all the Reviewers agree in the importance and interest of the manuscript, and it most definitely would make a great contribution to PLOS Computational Biology. However, the Reviewers have some comments, very specially Reviewer 1. Before the manuscript can be accepted, these comments have to be addressed.

We cannot make any decision about publication until we have seen the revised manuscript and your response to the reviewers' comments. Your revised manuscript is also likely to be sent to reviewers for further evaluation.

When you are ready to resubmit, please upload the following:

[1] A letter containing a detailed list of your responses to the review comments and a description of the changes you have made in the manuscript. Please note while forming your response, if your article is accepted, you may have the opportunity to make the peer review history publicly available. The record will include editor decision letters (with reviews) and your responses to reviewer comments. If eligible, we will contact you to opt in or out.

[2] Two versions of the revised manuscript: one with either highlights or tracked changes denoting where the text has been changed; the other a clean version (uploaded as the manuscript file).

Important additional instructions are given below your reviewer comments.

Please prepare and submit your revised manuscript within 60 days. If you anticipate any delay, please let us know the expected resubmission date by replying to this email. Please note that revised manuscripts received after the 60-day due date may require evaluation and peer review similar to newly submitted manuscripts.

Thank you again for your submission. We hope that our editorial process has been constructive so far, and we welcome your feedback at any time. Please don't hesitate to contact us if you have any questions or comments.

Sincerely,

Saúl Ares, Ph.D.

Guest Editor

PLOS Computational Biology

Douglas Lauffenburger

Deputy Editor

PLOS Computational Biology

***********************

Dear Guillaume,

We have now finally received the three reports for your manuscript "Interacting active surfaces: a model for three-dimensional cell aggregates". As you can see, all the Reviewers agree in the importance and interest of the manuscript, and it most definitely would make a great contribution to PLOS Computational Biology. However, the Reviewers have some comments, very specially Reviewer 1. Before the manuscript can be accepted, these comments have to be addressed. Please let me know if I can be of any assistance during the process.

Best regards,

Saúl

Reviewer's Responses to Questions

Comments to the Authors:

Please note here if the review is uploaded as an attachment.

Reviewer #1: Please see my attached comments (review.pdf)

Reviewer #2: PCOMPBIOL-D-22-00456

Interacting active surfaces: a model for three-dimensional cell aggregates

The interest in modeling biological surfaces is not recent, but most studies mainly focused on passive membranes. More recently, several papers extended the study of fluid surfaces to active surfaces, which is a natural and necessary step to making better models with the hope of quantitatively confronting theory with biological experiments.

This article provides significant advances for the simulation of three-dimensional biological systems that will undoubtedly positively impact the field. The authors put forward a numerical approach capable of handling multicellular aggregates with the dynamical evolution of surface fields. There is a good balance in the article between theory (where there is nothing particularly new, but this is not the article's focus), numerics, and results. The cell mechanics is dictated here by the actomyosin cortex at a long (viscous) timescale, and cell-cell adhesion is modeled using the phenomenological Morse potential. They present biologically relevant applications of the numerical scheme. The paper is well written and would appeal to what I consider typical readers of PLOS. After some minor revisions, I would be happy to recommend it to the editors of PLOS for publication.

Introduction:

In the introduction, the reader might benefit from a brief discussion on the physical/biological motivation on why only the cortex is necessary for describing the cell dynamics and why the membrane plays no role.

The authors say on pg. 2, "In this framework, topological transitions appear as a natural output of the remodeling of cell-cell interactions and are not treated explicitly." However, it is not clear how the topological transitions will happen naturally. This is particularly relevant because Sec 3.4 deals with cell divisions. Still, the authors chose to cut the cell in a random plane instead of modeling the division dynamics (as in the ref. HB da Rocha, J Bleyer, H Turlier - Journal of the Mechanics and Physics of Solids, 2022, although I believe that here the authors did not treat topological transitions).

Materials and methods

Pg. 4:

I'm curious to know why the authors chose the virtual work principle to formulate what is clearly a fluid problem. Wouldn't the Onsager variational principle or virtual power principle be more relevant here?

I believe that because they deal essentially with stokes flow, ultimately, there will be no problem.

Pg. 8:

The section on the forces arising from cell-cell interactions is presently a bit confusing. The authors start by stating a general function for the cell-cell interactions, then go on to motivate a particular form for the cell-cell interaction energy considering stretchable linkers connecting the cells with binding and unbinding dynamics. Then, the authors observe that such potential fails to capture repulsion and turns to a phenomenological potential, the Morse potential. I believe that this section could go direct to the point.

Pg. 11:

The authors devote a subsection to presenting an already established surface reparametrization method. Yet, the exposition is restricted to a single cell without discussing the reparametrization in the numerical experiments. Thus, I would suggest the authors either shorten the exposition to a minimum or complete it with (1) information about the extension to cell aggregates and (2) error assessment in the numerical examples to give the reader an idea of the accuracy of the method. For instance, are there any difficulties when parametrizing cell aggregates (e.g., possible self-intersections)? What is the reparametrization error in terms of volume conservation?

Pg. 20:

In the discussion section, the authors report that the exact integration of the interaction potential has a high computational cost. I think the reader would also benefit from knowing the relative weight of this simulation phase, i.e., the percentage of time devoted to integrating the interaction potential with respect to the total simulation time.

Finally, the authors highlight in the abstract and the introduction their hybrid MPI-OpenMP parallelized C++ implementation. Yet, the reader is given very few details in the subsequent exposition on the parallelization, especially in the numerical experiments. I would suggest reporting at least minimal quantities to give the reader an idea of the parallel performance of the code. For instance, to inform about global problem sizes, max. local problem sizes, max. number of cores employed, total simulation times, and CPU specification for the largest numerical examples.

Reviewer #3: This work presents a general computational model for the interaction of active fluidic surfaces. The manuscript is very well written, interesting and important. The presented examples are well chosen and clearly demonstrate the versatility of the proposed model. The work is suitable for publication provided the following comments are addressed:

1. Sec. 2.1: Usually the exact opposite notation is used: Greek indices for surface coordinates and Latin indices for 3D coordinates. The authors should motivate their choice if it is non-standard.

2. Sec. 2.1: g_ij, C_ij, etc. are not tensors (even if many authors erroneously call them so). They are just components, possibly of tensors. The full tensor includes the basis vectors, which makes a big difference, esp. for curvilinear coordinates.

3. Following Eq. (7): The authors should note here that the scope of constitutive laws for fluidic membranes as it stems from irreversible thermodynamics has also been discussed in Sahu et al. (2017), “Irreversible thermodynamics of curved lipid membranes”, Phys. Rev. E, 96:042409

4. Sec. 3.1: It is not clear to me, whether the surface shape changes in this example. There is an out-of-plane surface velocity but then the analytical solution seems to be based on a spherical shape.

5. It is not clear to me to what degree the surface flow has an influence on the presented results in Sec. 3.2. & 3.3. (and also 3.4). Did the authors vary the relevant parameters to examine? It would be interesting to see this.

6. At some point the authors mention that the active surface tension is considered a given constant, but in principle could depend on some concentration and vary locally. Is this the case in all four examples? The authors should clarify.

**********

Have the authors made all data and (if applicable) computational code underlying the findings in their manuscript fully available?

The PLOS Data policy requires authors to make all data and code underlying the findings described in their manuscript fully available without restriction, with rare exception (please refer to the Data Availability Statement in the manuscript PDF file). The data and code should be provided as part of the manuscript or its supporting information, or deposited to a public repository. For example, in addition to summary statistics, the data points behind means, medians and variance measures should be available. If there are restrictions on publicly sharing data or code —e.g. participant privacy or use of data from a third party—those must be specified.

Reviewer #1: Yes

Reviewer #2: Yes

Reviewer #3: None

**********

PLOS authors have the option to publish the peer review history of their article (what does this mean?). If published, this will include your full peer review and any attached files.

If you choose “no”, your identity will remain anonymous but your review may still be made public.

Do you want your identity to be public for this peer review? For information about this choice, including consent withdrawal, please see our Privacy Policy.

Reviewer #1: No

Reviewer #2: No

Reviewer #3: No

Figure Files:

While revising your submission, please upload your figure files to the Preflight Analysis and Conversion Engine (PACE) digital diagnostic tool, https://pacev2.apexcovantage.com. PACE helps ensure that figures meet PLOS requirements. To use PACE, you must first register as a user. Then, login and navigate to the UPLOAD tab, where you will find detailed instructions on how to use the tool. If you encounter any issues or have any questions when using PACE, please email us at figures@plos.org.

Data Requirements:

Please note that, as a condition of publication, PLOS' data policy requires that you make available all data used to draw the conclusions outlined in your manuscript. Data must be deposited in an appropriate repository, included within the body of the manuscript, or uploaded as supporting information. This includes all numerical values that were used to generate graphs, histograms etc.. For an example in PLOS Biology see here: http://www.plosbiology.org/article/info%3Adoi%2F10.1371%2Fjournal.pbio.1001908#s5.

Reproducibility:

To enhance the reproducibility of your results, we recommend that you deposit your laboratory protocols in protocols.io, where a protocol can be assigned its own identifier (DOI) such that it can be cited independently in the future. Additionally, PLOS ONE offers an option to publish peer-reviewed clinical study protocols. Read more information on sharing protocols at https://plos.org/protocols?utm_medium=editorial-email&utm_source=authorletters&utm_campaign=protocols

Attachment

Submitted filename: review.pdf

PLoS Comput Biol. doi: 10.1371/journal.pcbi.1010762.r003

Decision Letter 1

Douglas A Lauffenburger, Saúl Ares

7 Nov 2022

Dear Dr. Salbreux,

Thank you very much for submitting your manuscript "Interacting active surfaces: a model for three-dimensional cell aggregates" for consideration at PLOS Computational Biology. As with all papers reviewed by the journal, your manuscript was reviewed by members of the editorial board and by several independent reviewers. The reviewers appreciated the attention to an important topic. Based on the reviews, we are likely to accept this manuscript for publication, providing that you modify the manuscript according to the review recommendations.

We have now received all the Reviewer's reports. While two Reviewers recommend publication without more comments, one Reviewer still raises some relevant points. I think that clarifying these points will be positive for the manuscript, and therefore I recommend to address them carefully.

Best regards,

Saúl Ares

Please prepare and submit your revised manuscript within 30 days. If you anticipate any delay, please let us know the expected resubmission date by replying to this email.

When you are ready to resubmit, please upload the following:

[1] A letter containing a detailed list of your responses to all review comments, and a description of the changes you have made in the manuscript. Please note while forming your response, if your article is accepted, you may have the opportunity to make the peer review history publicly available. The record will include editor decision letters (with reviews) and your responses to reviewer comments. If eligible, we will contact you to opt in or out

[2] Two versions of the revised manuscript: one with either highlights or tracked changes denoting where the text has been changed; the other a clean version (uploaded as the manuscript file).

Important additional instructions are given below your reviewer comments.

Thank you again for your submission to our journal. We hope that our editorial process has been constructive so far, and we welcome your feedback at any time. Please don't hesitate to contact us if you have any questions or comments.

Sincerely,

Saúl Ares, Ph.D.

Guest Editor

PLOS Computational Biology

Douglas Lauffenburger

Section Editor

PLOS Computational Biology

***********************

A link appears below if there are any accompanying review attachments. If you believe any reviews to be missing, please contact ploscompbiol@plos.org immediately:

Dear Dr. Salbreux,

We have now received all the Reviewer's reports. While two Reviewers recommend publication without more comments, one Reviewer still raises some relevant points. I think that clarifying these points will be positive for the manuscript, and therefore I recommend to address them carefully.

Best regards,

Saúl Ares

Reviewer's Responses to Questions

Comments to the Authors:

Please note here if the review is uploaded as an attachment.

Reviewer #1: I thank the authors for their careful responses to my comments, as well as the comments of the other reviewers. I am satisfied with the response to my minor concerns, as well as two of my three major concerns. However, I remain worried about your treatment of the active tension, in which $\\gamma$ is either a prescribed constant or a prescribed field (which does not vary in time). I now understand that you seek to describe a cell in the limit where cytoskeletal elements are constantly and rapidly turning over, such that local inhomogeneities are quickly removed and can be neglected on the natural timescale of membrane deformations/flows. In my mind, I picture a reservoir of cytoskeletal elements in the cell cytoplasm to allow such a situation. However, this brings up additional questions:

1. It seems such a composite system (membrane + cortex) is no longer described by the Helfrich free energy, which is appropriate for a two-dimensional system with in-plane fluidity. Given your statement that cortical stresses dominate membrane ones, wouldn't an energy density for a material with in-plane elasticity (and not fluidity) and out-of-plane bending be more appropriate? Your edits to the introduction say that the composite system is in-plane fluid on the timescale of tens of seconds, but many cellular phenomena of interest happen on shorter timescales. Wouldn't your choice of free energy then imply you cannot resolve any of those?

2. Generally, a bending deformation costs energy because one side of the sheet is stretched while the other is compressed, both of which are energetically unfavorable. However, if the turnover of cytoskeletal elements is so rapid, wouldn't this bending energy no longer exist, since there is no way for stress to be built up? Rather, the actomyosin cortex would always remain in a stress-free configuration. It seems the cortex turnover would have to in fact be slow relative to shape changes in order for bending forces to arise.

3. Even under the assumption that a rapid turnover prevents any density changes of the cortex, and that the Helfrich energy remains appropriate, wouldn't the lipid membrane itself still undergo density variations as the composite system deforms? In this case, even if the density of the cortex is constant, there will still be surface tension gradients caused by the membrane. Moreover, since the gradient of the "cortex" surface tension is zero, it is these membrane surface tensions which will dominate in the in-plane equations. A mass balance would then be required in your formulation.

4. I believe your response regarding the Rayleigh--Plateau instability is incorrect. It is true that pearling arises in a cylindrical fluid column with constant surface tension. However, here the driving mechanism is the development of pressure gradients in the fluid column in response to an initial perturbation. These pressure gradients are due to the Young--Laplace equation (constant tension and curvature gradients lead to pressure gradients), and drive a viscous fluid flow (via the Stokes equation) which reinforces the initial disturbance. However, since your numerical method does not capture any pressure gradients in the surrounding medium, I believe it cannot describe such an instability. If I am correct, then the inability of your equations to describe such a well-known and commonly observed cellular phenomena would be very troubling, and would further confirm my belief that you need an explicit statement of local mass balance in your dynamics.

Reviewer #2: I have reviewed the manuscript's revised version and the author's response to the previous comments. The authors made an effort to convince the referees about the merits of their work and revised the manuscript according to the referees' questions and comments.

On a minor note, I agree with Reviewer #3 point 1: using Latin indices to represent surfaces is disturbing and might confuse readers used to the classic notation (it confused me at first sight). Although I believe uniformizing the notation is helpful for overall readability, it does not remove the merit of the work.

Given this, I recommend the publication of the revised version in PLOS Computational Biology.

Reviewer #3: The authors have accounted for all my comments, and as far as I can see, also the other reviewer's comments. In my mind the work is suitable for publication now.

**********

Have the authors made all data and (if applicable) computational code underlying the findings in their manuscript fully available?

The PLOS Data policy requires authors to make all data and code underlying the findings described in their manuscript fully available without restriction, with rare exception (please refer to the Data Availability Statement in the manuscript PDF file). The data and code should be provided as part of the manuscript or its supporting information, or deposited to a public repository. For example, in addition to summary statistics, the data points behind means, medians and variance measures should be available. If there are restrictions on publicly sharing data or code —e.g. participant privacy or use of data from a third party—those must be specified.

Reviewer #1: Yes

Reviewer #2: Yes

Reviewer #3: Yes

**********

PLOS authors have the option to publish the peer review history of their article (what does this mean?). If published, this will include your full peer review and any attached files.

If you choose “no”, your identity will remain anonymous but your review may still be made public.

Do you want your identity to be public for this peer review? For information about this choice, including consent withdrawal, please see our Privacy Policy.

Reviewer #1: No

Reviewer #2: No

Reviewer #3: No

Figure Files:

While revising your submission, please upload your figure files to the Preflight Analysis and Conversion Engine (PACE) digital diagnostic tool, https://pacev2.apexcovantage.com. PACE helps ensure that figures meet PLOS requirements. To use PACE, you must first register as a user. Then, login and navigate to the UPLOAD tab, where you will find detailed instructions on how to use the tool. If you encounter any issues or have any questions when using PACE, please email us at figures@plos.org.

Data Requirements:

Please note that, as a condition of publication, PLOS' data policy requires that you make available all data used to draw the conclusions outlined in your manuscript. Data must be deposited in an appropriate repository, included within the body of the manuscript, or uploaded as supporting information. This includes all numerical values that were used to generate graphs, histograms etc.. For an example in PLOS Biology see here: http://www.plosbiology.org/article/info%3Adoi%2F10.1371%2Fjournal.pbio.1001908#s5.

Reproducibility:

To enhance the reproducibility of your results, we recommend that you deposit your laboratory protocols in protocols.io, where a protocol can be assigned its own identifier (DOI) such that it can be cited independently in the future. Additionally, PLOS ONE offers an option to publish peer-reviewed clinical study protocols. Read more information on sharing protocols at https://plos.org/protocols?utm_medium=editorial-email&utm_source=authorletters&utm_campaign=protocols

References:

Review your reference list to ensure that it is complete and correct. If you have cited papers that have been retracted, please include the rationale for doing so in the manuscript text, or remove these references and replace them with relevant current references. Any changes to the reference list should be mentioned in the rebuttal letter that accompanies your revised manuscript.

If you need to cite a retracted article, indicate the article’s retracted status in the References list and also include a citation and full reference for the retraction notice.

PLoS Comput Biol. doi: 10.1371/journal.pcbi.1010762.r005

Decision Letter 2

Douglas A Lauffenburger, Saúl Ares

26 Nov 2022

Dear Dr. Salbreux,

We are pleased to inform you that your manuscript 'Interacting active surfaces: a model for three-dimensional cell aggregates' has been provisionally accepted for publication in PLOS Computational Biology.

Before your manuscript can be formally accepted you will need to complete some formatting changes, which you will receive in a follow up email. A member of our team will be in touch with a set of requests.

Please note that your manuscript will not be scheduled for publication until you have made the required changes, so a swift response is appreciated.

IMPORTANT: The editorial review process is now complete. PLOS will only permit corrections to spelling, formatting or significant scientific errors from this point onwards. Requests for major changes, or any which affect the scientific understanding of your work, will cause delays to the publication date of your manuscript.

Should you, your institution's press office or the journal office choose to press release your paper, you will automatically be opted out of early publication. We ask that you notify us now if you or your institution is planning to press release the article. All press must be co-ordinated with PLOS.

Thank you again for supporting Open Access publishing; we are looking forward to publishing your work in PLOS Computational Biology. 

Sincerely,

Saúl Ares, Ph.D.

Guest Editor

PLOS Computational Biology

Douglas Lauffenburger

Section Editor

PLOS Computational Biology

***********************************************************

Dear Dr. Salbreux,

I believe the discussion with the Reviewers has helped to make the manuscript clearer and all the assumptions more explicit. I find your last response and version satisfactory, and see no gain in any further discussion. Therefore, your manuscript is accepted in its current form.

PLoS Comput Biol. doi: 10.1371/journal.pcbi.1010762.r006

Acceptance letter

Douglas A Lauffenburger, Saúl Ares

9 Dec 2022

PCOMPBIOL-D-22-00456R2

Interacting active surfaces: a model for three-dimensional cell aggregates

Dear Dr Salbreux,

I am pleased to inform you that your manuscript has been formally accepted for publication in PLOS Computational Biology. Your manuscript is now with our production department and you will be notified of the publication date in due course.

The corresponding author will soon be receiving a typeset proof for review, to ensure errors have not been introduced during production. Please review the PDF proof of your manuscript carefully, as this is the last chance to correct any errors. Please note that major changes, or those which affect the scientific understanding of the work, will likely cause delays to the publication date of your manuscript.

Soon after your final files are uploaded, unless you have opted out, the early version of your manuscript will be published online. The date of the early version will be your article's publication date. The final article will be published to the same URL, and all versions of the paper will be accessible to readers.

Thank you again for supporting PLOS Computational Biology and open-access publishing. We are looking forward to publishing your work!

With kind regards,

Zsofia Freund

PLOS Computational Biology | Carlyle House, Carlyle Road, Cambridge CB4 3DN | United Kingdom ploscompbiol@plos.org | Phone +44 (0) 1223-442824 | ploscompbiol.org | @PLOSCompBiol

Associated Data

    This section collects any data citations, data availability statements, or supplementary materials included in this article.

    Supplementary Materials

    S1 Appendix. Details of derivations and computational framework used in the main text.

    (PDF)

    S1 Fig

    (A) Side view, cut by a plane perpendicular to the adhesion patch of an adhering doublet for D˜ larger than the critical value. The system develops a buckling instability that grows with time. The instability eventually leads to self-intersections (right-most image, where the blue cell has collapsed). (B) Coloured lines: pressure for simulations with different values of l˜ and κ˜. Black dotted line: theoretical approximation valid in the limit of κ˜0,l˜0,r˜min0. (C) Convergence of the method evaluated by computing the inner cell pressure P for different average mesh sizes h, and comparing the results with a simulation with h/ ≈ 2 ⋅ 10−2 (finer). For each h, we compute a box plot using different values of D˜ and fixed κ˜=10-2, l˜=0.02. (D) Side view, cut by a plane perpendicular to the adhesion patch of an adhering doublet with asymmetric tension for α = 0.7; the cell with lower tension (blue) engulfing the cell with higher tension (red) develops a self-intersection in our numerical simulations (right-most image).

    (PDF)

    S1 Video. Comparison of the mesh relaxation method for different values of the tolerance for normal motion (left column: 10−3, right column: 10−4) and different mesh sizes (top row: 4 × 10−2, bottom row: 2 × 10−2).

    The colormap represents the distance to the original surface, which is in all cases below 5 × 10−3.

    (M4V)

    S2 Video. Growth of a cell aggregate driven by cell growth and cell divisions in the case where the cell lifetime tD is ten times larger than the shape relaxation time-scale τ.

    (MP4)

    S3 Video. Growth of a cell aggregate driven by cell growth and cell divisions in the case where the cell lifetime tD is ten times smaller than the shape relaxation time-scale τ.

    (MP4)

    Attachment

    Submitted filename: review.pdf

    Attachment

    Submitted filename: Response_reviewers.pdf

    Attachment

    Submitted filename: Reply.pdf

    Data Availability Statement

    The source code used to produce the results and analyses presented in this manuscript is available at the Git repository: https://github.com/torressancheza/ias.


    Articles from PLOS Computational Biology are provided here courtesy of PLOS

    RESOURCES