Abstract
Biological cells rely on precise spatiotemporal coordination of biochemical reactions to control their functions. Such cell signaling networks have been a common focus for mathematical models, but they remain challenging to simulate, particularly in realistic cell geometries. Here we present Spatial Modeling Algorithms for Reactions and Transport (SMART), a software package that takes in high-level user specifications about cell signaling networks and then assembles and solves the associated mathematical systems. SMART uses state-of-the-art finite element analysis, via the FEniCS Project software, to efficiently and accurately resolve cell signaling events over discretized cellular and subcellular geometries. We demonstrate its application to several different biological systems, including yes-associated protein (YAP)/PDZ-binding motif (TAZ) mechanotransduction, calcium signaling in neurons and cardiomyocytes, and ATP generation in mitochondria. Throughout, we utilize experimentally derived realistic cellular geometries represented by well-conditioned tetrahedral meshes. These scenarios demonstrate the applicability, flexibility, accuracy and efficiency of SMART across a range of temporal and spatial scales.
Main
In the past decade, computational modeling has become an integral part of the discovery toolkit in biology along with advances in experimental technologies. One of the fundamental tenets of biology is that structure and function are closely related. In single-cell biology, this is reflected by the spatial compartmentalization of cellular signaling in different subcellular locations and organelles. Advances in microscopy in recent decades have provided data to support this notion from two approaches: electron microscopy for a detailed characterization of subcellular structure1,2,3 and super-resolution microscopy for the spatiotemporal localization of biochemical species that are important for cellular functions including signaling4. Detailed computational models using realistic cellular geometries and reaction-diffusion mechanisms can help us identify the possible biophysical mechanisms underlying such spatial compartmentalization5,6,7. However, representing these details including subcellular geometries such as organelles and the relevant reaction-transport formulations using the appropriate computational description remains an open challenge.
Historically, many mathematical models of cell signaling have neglected spatial effects, treating the cell as a well-mixed volume. In certain cases, this approximation can be justified, but given the slow diffusion of certain signaling molecules, the crowded intracellular environment and the complexity of cellular geometries, such approximations can diminish the predictive capability of the models. Furthermore, due to the variety of membrane-bound organelles present in cells, reaction networks are coupled across subvolumes and involve a complicated set of bulk-surface reactions at organelle membranes (Fig. 1a). As a result, moving from well-mixed models to multicompartment spatiotemporal models of cell signaling presents many technical barriers. Mathematically, this involves transitioning from systems of ordinary differential equations (ODEs) to systems of mixed-dimensional partial differential equations (PDEs). Such PDE systems are notoriously difficult to solve numerically due to nonlinearities, stiffness and instabilities8. Furthermore, solving these equations within realistic cellular geometries requires robust discretization of complex geometries2,3 (Fig. 1b,c) and is computationally expensive due to the high dimensionality of the systems.

a, Schematic of reaction-transport system in SMART. Given the topological relationships between different compartments in cells and information on reactions between species, fluxes across boundaries and diffusion rates of individual species, SMART assembles a finite element system of equations. A single model in SMART may include both volume species (circles in inset) and surface species (rectangles in inset) that can all diffuse and react with one another. b, Whole-cell geometry with segmented organelles from volume electron microscopy. c, Ca2+ release from the ER in a realistic geometry. For illustration, a linear molecular leak flux from the ER (jleak = νleak(cER − ci)) was assumed starting at t = 0, where jleak is the total flux, νleak is the leak permeability, and cER and ci are the Ca2+ concentrations in the ER and cytosol, respectively. This realistic ER geometry was derived from electron micrographs of dendritic spines27 and all rendering was performed in Paraview61. Whole cell schematic in a created with BioRender.com. b adapted from ref. 2, Springer Nature Ltd.
Recent efforts have been made to accurately represent cellular and subcellular geometries with well-conditioned triangular and tetrahedral meshes9,10,11,12. In particular, GAMer 2 (Geometry-preserving Adaptive Mesher version 2) allows users to convert microscopy images of cells into suitable meshes for finite element simulations11,12. These meshes can be annotated to mark the location of subcellular structures such as the nucleus, endoplasmic reticulum (ER) or mitochondria, along with their respective membrane boundaries13,14. Meshes from GAMer 2 can be readily loaded into the open-source finite element software package, FEniCS15, and used to simulate spatial models of cell signaling in realistic geometries. However, translating systems of PDEs defining cell signaling systems into variational forms defined over subsurfaces and subvolumes of the geometry, and solving these, is non-trivial.
To answer fundamental questions about spatiotemporal compartmentalization of cellular signaling, building on advances in meshing, we introduce Spatial Modeling Algorithms for Reactions and Transport (SMART), a Python-based software package to construct and solve systems of mixed-dimensional reaction-transport equations16,17. SMART complements other software packages for computational cell biology such as Virtual Cell (VCell)18,19 and Monte Carlo cell (MCell)20 by providing a unique toolkit to solve spatial signaling networks over complicated geometries using the finite element method. Similar to systems biology frameworks such as the Systems Biology Markup Language (SBML)21, SMART takes user input that specifies species, reactions, compartments and parameters involved in a given biological network. Here we describe this workflow and then demonstrate the use of SMART in several biological test cases, including yes-associated protein (YAP)/PDZ-binding motif (TAZ)-mediated mechanotransduction in cells on micropatterned substrates, calcium signaling in neuronal dendritic spines, calcium release within a cardiomyocyte and synthesis of ATP in a mitochondrion. Several of these examples use realistic subcellular geometries derived from electron micrographs and conditioned with GAMer 2. We further demonstrate the accuracy of SMART via a series of addition numerical verification tests and summarize its performance and scalability.
Results
Spatial modeling algorithms for reactions and transport
Cell signaling networks rely on non-trivial chains of molecular reactions and transport mechanisms acting within and across compartments: extracellular, intracellular and subcellular spaces, and membranes (Fig. 1a). These cellular domains define three-dimensional (3D) bulk volumes whereas the membranes can be viewed as two-dimensional (2D) manifold surfaces. The geometry of these compartments can be accurately represented through synthetic or imaging-guided computational meshes in the form of simplicial complexes, with individual volumes and surfaces identified and labeled by tags11 (Fig. 1b,c and Methods). Spatial modeling of cellular pathways and processes describe the distribution and evolution of different species present in or on these compartments; for example, ion concentrations such as Na+ in the cytosol or interstitial fluid, Ca2+ in subcellular compartments, or the density of receptors or other channels distributed along the plasma membrane.
Mathematically, we describe diffusion of such species and reactions between species, within or across compartments, via coupled systems of time-dependent, nonlinear and mixed-dimensional PDEs defined over the computational geometries (Fig. 2, Methods and Supplementary Note 1). Our modeling assumptions enable species to diffuse within volumes and on surfaces, and to be transported across surfaces to cross between volumes. Reactions between a single or multiple species occur within compartments (volume or surface reactions) or in adjacent compartments (volume–surface or volume–surface–volume reactions; Fig. 2a). The use of a mixed finite element discretization in space allows for high numerical accuracy and geometric flexibility8. Crucially, this approach allows for spatial variation of each species within compartments and transport across compartments, while conserving mass and momentum. The computational model is allowed to evolve over time, yielding detailed predictions for changes in each species within the specified geometries (Fig. 2e). High-performance sparse numerical linear algebra22 in combination with scalable finite element algorithms15 allows for computational models with millions of degrees of freedom to be solved efficiently. The numerical algorithms and software implementation are described in full in Supplementary Notes 2 and 3.

a, Illustration of the basic components used to define a model in SMART—species, reactions, parameters and compartments. The graphic contains three volume compartments (Ωm) and three surface compartments (Γq), with illustrations of the reaction types supported by SMART, including volume, surface, volume–surface and volume–surface–volume. The species depicted include both volume species (u) and surface species (v). b, Model geometry specified by mesh generated in Gmsh or conditioned in GAMer 2. c, Assembly of equations from reaction specifications in SMART. Each volume species and each surface species has an associated PDE with boundary conditions, as shown on the right (see also Supplementary Note 1). In a given volumetric compartment Ωm, Dim and fim are the diffusion coefficient and volume reaction rate of species i, and nm and Riq are the boundary normal vector and the boundary reaction rate on surface Γq. In a given surface compartment Γq, Djq and gjq are the diffusion coefficient and surface reaction rate of species j. ∇ and ∇∙ are the gradient and divergence operators, whereas ∇S and ∇S∙ are the surface gradient and surface divergence operators. d, SMART model discretization using finite elements. The nonlinear system is discretized using linear finite elements in FEniCS and then the block matrix problem is assembled in PETSc. The matrix is nested in terms of compartments involved in each interaction, as summarized on the right. e, Model solution and postprocessing in SMART. The system is solved iteratively at each time step until reaching tfinal. Results are post-processed to examine changes in concentration over time and space. Visualization via Paraview61 and plots are shown here for purely illustrative purposes. Cell schematic in a created with BioRender.com. Gmsh logo (b) and FEniCS logo (d) reproduced with permission under a Creative Commons license CC BY-SA 4.0. PETSc logo (e) reproduced under a Public Domain Dedication and License v1.0.
YAP/TAZ mechanotransduction on micropatterned substrates
To demonstrate the use of SMART at the whole-cell length scale, we consider the model of YAP/TAZ mechanotransduction originally developed in ref. 23 and extended to a spatial model in ref. 24. This model considers the intracellular signaling cascade induced by a cell adhering to a substrate with a given stiffness, from phosphorylation of focal adhesion kinase (FAK) to downstream activation of the actomyosin cytoskeleton and nuclear translocation of the transcriptional regulatory proteins YAP and TAZ (Fig. 3a). In general, on stiffer substrates, increased FAK phosphorylation results in increased actin polymerization and myosin contractility, leading to dephosphorylation of cytosolic YAP/TAZ and subsequent translocation of YAP/TAZ into the nucleus.

a, Schematic of YAP/TAZ mechanotransduction signaling pathway. Phosphorylation of FAK within the region of cell-substrate adhesion leads to cytoskeletal activation, triggering the dephosphorylation of YAP/TAZ and the opening of nuclear pore complexes (inset), allowing for the transport of YAP/TAZ into the nucleus. pFAK, phosphorylated FAK; RhoA, Ras homolog gene family member A; ROCK, Rho-associated kinase; LIMK, LIM kinase; mDia, mDia-family formins. b, Measurements of cytoskeletal activation in cells on micropatterned substrates. c, Summary of geometries for cells spread on circular, rectangular and star-shaped micropatterns. d, Simulations of YAP/TAZ mechanotransduction in cells on circular, rectangular and star-shaped micropatterns. For each case, the side view is pictured, including both F-actin in the cytosol and YAP/TAZ in the nucleus, as well as the bottom-up contact-region view showing local activation of actin polymerization in regions of higher curvature along the cell contour. Bottom-up views also include contours showing lines of constant concentration. e,f, F-actin (e) and YAP/TAZ nuclear-to-cytosolic ratio (N/C) (f) dynamics plotted over time for all three cases. All 3D rendering shown here was performed in Paraview61. a created with BioRender.com. b adapted with permission from ref. 25 under a Creative Commons license CC BY.
Source data
Here we test the predicted effects of cell adhesion to micropatterned surfaces on the localization of YAP/TAZ to the nucleus. We consider three different contact-region geometries previously tested experimentally25—circular, rectangular and star-shaped micropatterns (Fig. 3b,c). In all cases, the cell volume and size of the contact region are the same, but the total plasma membrane surface area is increased for geometries with greater curvature at the contact regions (mesh generation detailed in Supplementary Note 4). We specifically consider signaling dynamics after a cell has initially spread over the surface, when the cell geometry is relatively stationary.
We consider the predictions of this model across all three geometries on a very stiff substrate such as glass. We find that regions of the cell where the plasma membrane surface area to cytosolic volume ratio is the highest have high concentrations of signaling molecules of interest. In particular, we observe elevated levels of F-actin in these regions, in agreement with the results from ref. 25 (Fig. 3b,d and Supplementary Videos 1–3). Micropatterns with highly curved regions along the perimeter (star or rectangular patterns) show greater increases in overall cytoskeletal activation (Fig. 3e) and, consequently, higher nuclear abundance of YAP/TAZ (Fig. 3f). Importantly, regardless of the shape of the contact area, all increases in YAP/TAZ are much lower than those predicted by a well-mixed model of YAP/TAZ mechanotransduction (compare with Fig. 6d) due to persistent gradients in cytoskeletal activation over the cellular geometry. That is, the F-actin concentration at the nuclear membrane is much lower in this spatial model compared with the well-mixed case, in which the effects of signal attenuation in regions of the cytosol farther away from the plasma membrane are neglected. This observation highlights the importance of accounting for spatial effects in cell signaling networks.
Calcium dynamics in realistic subcellular geometries
We next consider spatial models defined over realistic subcellular geometries acquired from 3D electron microscopy. We utilize previously published models of calcium ion (Ca2+) dynamics within dendritic spines in neurons26 and cardiomyocyte Ca2+ release units (CRUs)5. Each case includes Ca2+ influx through the plasma membrane and Ca2+ exchange across the sarcoplasmic reticulum (SR) or ER membrane, as well as Ca2+ binding and unbinding to buffering proteins within the cytosol and SR/ER (Fig. 4a). The Ca2+ dynamics in each system are influenced by the geometry and relative spatial arrangement of organelles.

a, General schematic of a Ca2+ signaling cascade in a subcellular region. In response to biochemical or electrical stimulus, Ca2+ influx occurs through the plasma membrane and Ca2+ is released from the ER/SR store. Ca2+ elevations are counteracted by Ca2+ efflux into the extracellular space and repackaging into the ER/SR through SERCA. Finally, the changes in free Ca2+ are dampened due to Ca2+ binding to proteins in the cytosol (buffering). b, Realistic geometries of a dendritic spine and a cardiomyocyte CRU derived from electron microscopy. The dendritic spine branches off from the main dendritic shaft and contains a lamellar ER structure known as the spine apparatus (brown), as well as a denser region of signaling proteins in a subregion of the spine head, the post-synaptic density (red). The CRU consists of a section of SR (brown) closely apposed to T-tubules (dark gray) in a region known as the junctional cleft. Mitochondria (light gray) serve as passive diffusion barriers in this case. c, Simulation of Ca2+ dynamics in a dendritic spine. Ca2+ elevations are concentrated to the dendritic head; following the initial influx, Ca2+ is pumped into the spine apparatus via SERCA. d, Plots of cytosolic and spine apparatus Ca2+ dynamics in the dendritic spine head versus the dendritic shaft. e, Simulation of Ca2+ dynamics in a CRU. Ca2+ release from the SR results in a Ca2+ spike near the center of the geometry, followed by refilling of the SR with Ca2+. f, Plots comparing the dynamics of cytosolic and SR Ca2+ with versus without SERCA. All 3D rendering shown here was performed in Paraview61. a created with BioRender.com.
Source data
Using the model previously implemented for idealized dendritic spine geometries in ref. 26, we simulate Ca2+ changes within a realistic dendritic spine containing a specialized form of ER known as the spine apparatus27. Ca2+ influx occurs through voltage-sensitive Ca2+ channels located in the head and a section of the neck and through N-methyl-d-aspartate receptors localized to a dense region of proteins known as the post-synaptic density (Fig. 4b). Each of these fluxes is written as an analytical expression over time, and dependent on a specified change in the membrane potential. Ca2+ is removed from the cytosol via efflux across the plasma membrane through the sodium−Ca2+ exchanger and plasma membrane Ca2+ ATPase, and influx into the spine apparatus through the sarcoplasmic/endoplasmic Ca2+ ATPase (SERCA). Over the short timescale considered in this model, we assume that Ca2+ entry into the spine apparatus dominates over release. Simulations reveal that Ca2+ elevation is higher within the spine head than in the dendritic shaft, also leading to a more substantial increase in Ca2+ concentration in the spine apparatus located in this region (Fig. 4c,d and Supplementary Video 4). The peak Ca2+ approaches 5 μM, lower than the 8 μM peak observed in the original model26.
Given the importance of Ca2+ in signaling pathways, to ensure robustness across different model formulations and geometries, we also use SMART to model Ca2+ release from the SR in a CRU. The CRU geometry28 includes a continuous section of SR, one T-tubule volume and two mitochondria. The sodium–Ca2+ exchanger, plasma membrane Ca2+ ATPase and leak fluxes through the T-tubule membrane, the ryanodine receptor (RyR) and SERCA fluxes through the SR membrane, as well as Ca2+ buffering due to calmodulin, troponin and ATP in the cytosol and calsequestrin in the SR, all follow established relationships5. However, here we utilize a full spatial discretization of the SR interior, which was previously treated as a series of well-mixed subregions5. For comparison, we consider two conditions—one with SERCA present throughout the SR membrane and another with no SERCA activity. In agreement with the original model, Ca2+ reaches a concentration of several micromolar near the T-tubule/SR junction and about 1 μM further away from the sites of RyR release (Fig. 4e,f and Supplementary Video 5). This Ca2+ spike is short-lived, as the model assumes that RyRs close upon sufficient reduction of SR Ca2+. Including active SERCA in the SR membrane results in a slightly prolonged Ca2+ elevation and robust refilling of the SR Ca2+ store over time (Fig. 4f and Supplementary Video 6), again in line with previous findings5. In both Ca2+ signaling examples presented here, the spatial behavior captured by SMART is critical to the overall dynamics, with the proximity between Ca2+ sources and sinks determining the overall extent of Ca2+ increase.
ATP synthesis in realistic mitochondrial geometries
We finally consider a biochemical network within a single organelle, modeling the generation and transport of ATP within a realistic mitochondrial geometry previously reconstructed from serial electron tomograms and conditioned in GAMer 27,29. Here, we implement a thermodynamically consistent continuum-based model30 and compare our current results with those from well-mixed ODE simulations and particle-based simulations7,30.
The model considers the generation of ATP in the mitochondrial matrix by ATP synthase, followed by the transport of ATP into the intermembrane space (IMS) by adenine nucleotide transporters (ANTs) and export into the cytosol through voltage-dependent anion channels (VDACs) in the outer membrane (OM) (Fig. 5a,b). Previous experimental data and modeling results suggest that the spatial organization of ATP synthase and ANTs is a key determinant of the magnitude of ATP changes in the cytosol7. Accordingly, we tested two alternative spatial arrangements of ATP synthase and ANTs while keeping the total number of molecules unchanged. In the first case, we distributed these molecules uniformly throughout the inner membrane, whereas in the second, more physiological case, we colocalized ANTs and ATP synthase in invaginations of the inner membrane known as cristae. In both cases, we maintained the same total amount of ANTs and ATP synthase molecules.

a, Schematic of the ATP synthesis process in mitochondrion. ADP in the mitochondrial matrix is converted into ATP by ATP synthase in the cristae membrane, then transported into the IMS through ANTs and exported into the cytosol through voltage-dependent anion channels. b, Realistic mitchondrial geometry. The inner membrane divides two volume compartments—matrix (yellow) and IMS (blue). The inner membrane itself is divided into a portion on the periphery (yellow) and invaginations known as cristae (brown). c, Dynamics of IMS ATP and matrix ATP in a mitochondrion with uniform distributions of ATP synthase and ANTs in the inner membrane. d,e, IMS ATP concentration (d) and cytosolic ATP concentration (e) over time for uniform versus cristae-localized distributions of IMS proteins. ODE model predictions are plotted as well for ease of comparison (dashed lines). All 3D rendering shown here was performed in Paraview61. a created with BioRender.com.
Source data
A uniform distribution of ANTs results in dynamics of IMS and cytosolic ATP similar to those predicted by the ODE model and particle-based simulations (Fig. 5d,e and Supplementary Video 7). ATP in the IMS initially decreases rapidly as it binds to ANTs, and then gradually increases as ATP synthase produces more ATP. In comparison, concentrating ANTs and ATP synthase in the cristae results in a less pronounced initial reduction of ATP in the cytosol. This phenomenon was previously termed ‘energy buffering’7 and was attributed to the spatial separation between ANTs in the cristae and voltage-dependent anion channels in the outer membrane. Rapid changes to ATP concentration in the inner cristae space do not immediately affect ATP levels in the cytosol as time is required for diffusion between the outer membrane and cristae. This delay and dampening effect could make the cell more resilient to a noisy environment featuring rapid changes in the availability of ATP and ADP. This spatial phenomenon is captured via SMART simulations but is not accessible via well-mixed ODE models.
Verification and validation of computational algorithms
To verify our numerical and computational approach, we examine the simulation results for an example with an analytical solution at steady state (detailed in Supplementary Note 5 and Supplementary Tables 2–5). In this example, originally examined in ref. 31, a protein is phosphorylated at the cell membrane and dephosphorylated throughout the cytosol (Fig. 6a). We consider the case of a thin slab whose spatial solution is well described by the one-dimensional (1D) solution along its thickness. Figure 6b,c shows the temporal and spatial convergence, respectively, for three different diffusion coefficients, using the finest mesh (Fig. 6b) and finest time step (Fig. 6c). We observe that the numerical error is consistently lower for higher diffusion coefficients. Moreover, the mesh resolution error dominates up to some critical value of the time step for each D, as indicated by the plateau in each curve (Fig. 6b). This critical time step is smaller for high values of D, reflecting the need for smaller time steps to achieve optimal convergence in cases of rapid diffusion. At the smallest time step, mesh refinement error dominates in all cases, as demonstrated by the theoretically expected and optimal second-order convergence in the ({{mathcal{L}}}_{2}) norm of the error with respect to element size h (Fig. 6c).

a, Model of protein phosphorylation at the plasma membrane. b,c, Convergence of system describing phosphorylation of proteins at the plasma membrane (as described in ref. 31) upon time step refinement (b) and mesh refinement (c). The ({{mathcal{L}}}_{2}) error between the computed (u) and analytical (ue) solutions for all combinations of temporal and spatial refinement are shown in Supplementary Tables 6–8 for diffusion coefficients (D) 10 μm2 s−1, 100 μm2 s−1 and 1,000 μm2 s−1, respectively. d, Comparison of ODE solution to full SMART simulation for mechanotransduction example with fast diffusion at different mesh refinements. e, Spatial differences in solution for dendritic spine Ca2+ for course versus refined mesh. Maximum and average Ca2+ concentrations in different regions are reported for the coarse versus fine mesh. f, Comparison of ODE solution to full SMART simulation of mitochondrial ATP production for fast-diffusing nucleotide species. All 3D rendering shown here was performed in Paraview61.
Source data
Next, we focus on the accuracy and convergence of the numerical results for our three main biological scenarios. In the case of YAP/TAZ mechanotransduction, we can compare our numerical solutions with solutions of the well-mixed ODE approximation. Considering the case of a cell with a circular contact region on a glass substrate, we set diffusion coefficients for all volume species to 1,000 μm2 s−1 and treat all surface species as uniform and non-diffusing. Upon mesh refinement (Supplementary Table 9), the average F-actin concentration and nuclear YAP/TAZ concentration converge to a solution close to the trajectories predicted by the ODEs (Fig. 6d).
We next consider the effect of mesh refinement (Supplementary Table 10) and time-step refinement on dendritic spine simulations. In this case, the average Ca2+ concentrations are similar across mesh refinements, but solutions show small local spatial differences (Fig. 6e). In general, lower peak values are observed in the more refined mesh. Similarly, testing time steps from 0.25 ms to 2 ms reveals convergence to a single solution consistent with that in Fig. 4 (Supplementary Fig. 1). The time required for dendritic spine simulations at different mesh resolutions is further assessed in Supplementary Note 5.3 and Supplementary Fig. 2; in summary, we find that the total simulation time is consistently dominated by finite element assembly, while the time required for SMART model initialization is relatively small.
Finally, we assess the accuracy of our solutions at the single-organelle level by comparing our mitochondrial ATP production simulations with a well-mixed approximation. When setting the diffusion coefficients for all volumetric nucleotide species to 150 μm2 s−1, we obtain a close match to the ODE solution (Fig. 6f). In particular, the predicted value of cytosolic ATP deviates by a maximum of 0.2% from the well-mixed solution (Fig. 6f).
Discussion
Cell function is tightly linked to cell shape, as evidenced by the diverse shapes shown by different cell types, from neurons with branch-like extensions to cardiomyocytes that assemble in block-like morphologies. The importance of geometry in function extends to the single-organelle level; for instance, the inner membrane of mitochondria forms tortuous invaginations (cristae) that facilitate efficient production of ATP. The importance of cell and organelle geometry are generally well appreciated, but detailed geometries have proven difficult to include in models of cell signaling. The models showcased within this work show the use of our simulation technology and software, SMART, to simulate such signaling networks with spatial resolution, with a particular focus on realistic cell and organelle geometries.
SMART offers many possibilities for exploring the impact of cell shape in spatiotemporal signaling models in cell biology. This opportunity is driven by a wealth of imaging data from modalities such as volume electron microscopy and super-resolution fluorescence microscopy2,3,4. While the experimentally derived cell geometries here were all extracted from electron micrographs, other types, for example, fluorescence data, could be utilized for future applications of SMART. Fluorescence data could offer the additional opportunity to inform not just cell and organelle geometry but also the spatial localization and dynamics of different molecules such as membrane receptors. There are a variety of high-quality public datasets available from super-resolution microscopy and volume electron microscopy alike due to projects such as the Allen Institute’s Cell Explorer32 and Janelia’s OpenOrganelle2. Biophysical modeling leveraging such imaging datasets takes full advantage of the recent efforts to improve mesh conditioning for biological samples such as GAMer 211, VolRover33 or fTetWild34.
Indeed, the examples in this paper demonstrate the fundamental importance of geometry in models of cell signaling. For instance, in our model of YAP/TAZ mechanotransduction, while results agree qualitatively between a well-mixed model and a full spatial description, quantitative predictions of the model differ considerably between these two modeling regimes. Furthermore, certain aspects of the signaling network cannot be captured by a well-mixed model, such as increased levels of actin polymerization near the plasma membrane compared with elsewhere in the cell. Similarly, despite the fast diffusion of small molecular species such as Ca2+ and ATP, we find that spatial factors such as the adjacency between sources and sinks (dendritic spine and CRU examples) or the distribution of surface species (ATP example) are key determinants of system behavior. Indeed, in the case of ATP generation, changing the distribution of ATP synthase and ANTs in the inner membrane has a non-negligible effect on ATP dynamics in the cytosol. Considering that model parameters are commonly estimated using well-mixed models, parameterizing spatial models remains an important challenge. SMART is well positioned to address these issues via auxiliary tools such as dolfin-adjoint for sensitivity analysis and parameter estimation in FEniCS-based models35.
In addition to SMART, there exist several complementary software options available to computational biologists and biophysicists for examining the spatiotemporal behavior of cell signaling networks. Among the most popular are VCell18,19 and MCell20, both open-source projects focused on continuum and particle-based models of biochemical networks in cells, respectively. Within this broader context, SMART offers unique capabilities and features for those users wishing to test complex cell geometries in a continuum framework. For instance, VCell provides a robust option for solving mixed-dimensional reaction-diffusion equations using the finite volume method, but currently only pixelized or voxelized grid meshes are supported36. MCell, in contrast, does support surfaces defined by unstructured meshes; however, MCell uses particle-based simulations to describe stochastic reaction-diffusion networks. Such simulations are much more accurate when considering a small number of molecules but cannot yet be scaled to whole-cell simulations where many billions of molecules may be present. Alternative stochastic simulation packages such as the Stochastic Engine for Pathway Simulation (STEPS)37 or Lattice Microbes38 use other algorithms to model stochastic reaction-diffusion networks within cells. Many other options allow users to readily assemble signaling networks and/or perform parameter estimation and sensitivity analysis in the well-mixed case39,40. These complementary approaches work well alongside SMART to help develop robust models of cell signaling and select parameters for spatial and well-mixed models alike.
One of our goals is to make SMART widely accessible and useful for a variety of researchers with different areas of expertise. Accordingly, detailed installation instructions, documented test cases and application programming interface documentation are all readily available through our GitHub repository17. Furthermore, our software package has been tested and reviewed by other scientists as part of the publishing process in the Journal of Open Source Software16. We anticipate that future releases of SMART will incorporate technical improvements, both in SMART directly and via updates to the underlying FEniCS(x) software platform41. For instance, while the current version of SMART does not support parallelization using the message passing interface, use of FEniCSx will allow users to more efficiently solve larger problems via parallelization.
SMART currently only supports describing a set of compartments of co-dimension 1, that is, only 3D/2D or 2D/1D, whereas in principle, 1D or even zero-dimensional (0D) features could contribute in the full 3D case. We note that 0D/well-mixed features can currently be included by explicitly updating parameters at each time step, as in our ATP generation example (equations (1) and (2)). In many cases, the well-mixed (0D) approximation may be applied to several fast-diffusing species without loss of accuracy and while saving a large amount of computational cost.
SMART does not currently consider the effects of stochasticity and/or discrete particle dynamics that have previously been modeled in realistic geometries using MCell6,7,14. While such simulations do capture the realistic effects of thermal noise and finite molecule number, they are often not scalable to larger geometries. When considering large numbers of particles over an extended geometry, it is appropriate to use a mean-field approximation, modeling the deterministic evolution of concentrations over time rather than discrete particles42. Even over smaller length scales, particle-based and continuum simulations can produce similar findings; for instance, we found that our simulations of ATP synthesis show the same phenomenon of energy buffering that was originally observed in MCell simulations7. In future versions of SMART, we plan to incorporate the effects of stochasticity by adding white noise contributing to reaction and/or transport rates, using Monte Carlo sampling or other methods for stochastic finite element analysis43,44.
SMART currently only supports diffusion as a transport mechanism, but our framework can be expanded in the future to support other mechanisms of transport, such as advection and/or electrodiffusion. For prescribed advection within a fixed geometry, our current framework can be readily modified provided that the system is diffusion dominated or only mildly advection dominated (that is, the Péclet number is small or moderate)45. The effects of electrodiffusion are expected to be important in certain systems; FEniCS code has previously been developed for solving these equations and can be integrated into future versions of SMART46.
Changes in cell geometry often occur on a slower timescale compared with the rates of reaction and diffusion, so fixed geometry simulations such as those in this paper are often a valid approximation of system dynamics. However, mechanical responses, such as cell shape changes governed by elasticity of the cell membrane and interactions between the cytoskeleton and the membrane47,48,49,50, are often tightly coupled to reaction and transport. For instance, during cell migration, cell signaling leading to actin polymerization governs cell shape changes, which are commonly modeled using equations from fluid mechanics51,52. Finite element method-based approaches, such as that of SMART, offer one promising approach to efficiently solve coupled chemo-mechanical problems, due to their general applicability to solve a range of PDEs. Problems of this class generally involve moving boundaries, for which many approaches have been developed within finite element analysis53,54. A natural starting point for solving moving boundary problems within the SMART framework is to split the solution process into two steps at each time step of the simulation. First, SMART can be used to solve for reactions and transport within the current geometry. Then, the equations governing concentration-dependent mechanics of the surfaces and volumes within the domain can be solved, allowing us to update the geometry accordingly. This strategy has previously shown success in simulations of cell biophysics, including cell migration52, phagocytosis55 and dendritic spine shape changes56. SMART offers opportunities to model other such coupled multiphysics systems in future applications.
Methods
The mathematical models, computational algorithms and simulation technology underlying SMART are summarized here. An extended description is provided Supplementary Notes 1–3.
Domains, geometries and interfaces
We consider model geometries embedded in 2D or 3D represented by tessellated curves, surfaces and volumes. Each geometry is described by a collection of 3D volumes (or 2D surfaces in the 2D case) with boundaries and interfaces between volumes represented by 2D surfaces (or 1D curves in the 2D case). We refer to the highest-dimensional compartments as the bulk domains (Ω) and the lower-dimensional boundaries or interfaces as the surfaces (Γ). Moreover, each of these domains is represented by a simplicial tessellation formed by the mesh cells (intervals, triangles or tetrahedra), mesh facets (points, intervals or triangles) and mesh vertices (points). Importantly, all (sub)regions, boundaries and interfaces are defined relative to a single overarching parent mesh8. Subdomains Ωm ⊆ Ω are defined as a set of mesh cells with a common label or tag (m), and similarly exterior boundaries and interior interfaces Γq are defined as a set of mesh facets again with a common tag (q). In the examples presented here, we generated parent meshes and labeled their subdomains using either GAMer 211 to construct meshes from electron microscopy data or Gmsh57 to generate idealized cell geometries.
Coupled multi-domain reaction-transport equations
SMART represents the spatially and temporally varying concentrations of multiple species coexisting within domains via a general abstract modeling framework based on first principles. Each concentration is defined over a subdomain Ωm and/or surface Γq. The evolution and distribution of these concentrations are described by a coupled system of time-dependent and nonlinear PDEs representing conservation of mass, the diffusion of each species, reactions between species within the bulk or surface domains, and fluxes between the bulk and surface domains. See Supplementary Note 1 for a full description of the general framework and an example of system assembly for a simple surface–volume reaction (Supplementary Fig. 3). Reactions are assumed to be local in the sense that different species may interact within each subdomain Ωm, and on or across the surfaces Γq via the surface itself and its neighboring subdomains. Specific computational models specify the effective diffusivity of each species and symbolic expressions for model reactions and fluxes, the initial concentration of each species, and any bulk or surface source or sinks. Input parameters may be constant or spatially or temporally varying.
Numerical approximation and solution strategies
Each system of mixed-dimensional reaction-transport equations is discretized in time using a first-order accurate implicit Euler scheme with a uniform, variable or adaptive time-step size, yielding a coupled system of nonlinear PDEs at each time step. For the spatial discretization, we employ a monolithic finite element method via the FEniCS finite element software suite15. As unknown discrete fields, we consider the concentration of each species ({u}_{i}^{m}) defined in each bulk subdomain Ωm and the concentration of each species ({v}_{j}^{q}) defined over each surface Γq. All discrete fields are represented by continuous piecewise linear finite elements defined relative to the mesh used to represent the geometry. As the equations are coupled across fields and domains, the resulting nonlinear systems of discrete equations take a block structure8 (Fig. 2d).
All nonlinear systems of equations are by default solved by Newton–Raphson iterations with an exact, automatically and symbolically derived Jacobian. The time step for each system is either set as uniform throughout the course of the simulation or can be set adaptively based on the number of Newton–Raphson iterations required for convergence at the previous time step, as summarized in Supplementary Table 1. In case of nonlinear solver divergence or negative solutions, repeated restarts with associated reductions in time step are invoked as an optional mediation strategy. The linear systems are solved iteratively using Krylov solvers in PETSc22. For default solver tolerances and settings, we refer to the open-source SMART code17.
SMART model specifications
As outlined in the first results section, the user must specify species, reactions, parameters and compartments, and link these to a parent mesh before initializing a simulation. Several minimal use cases are given in the SMART documentation17 and the code for all examples in this paper is freely available58. In short, each species, reaction, parameter or compartment is defined as a Python object, each with associated properties detailed in Supplementary Note 3 and Fig. 2. All instances of a given object type are then stored in an ordered Python dictionary, resulting in a single ‘container’ for each type. The parent mesh is either generated using Gmsh or read directly from an hdf5 or xml file. The containers and mesh are then used to initialize the SMART model.
Model set-up for biological test cases
Here we briefly outline some of the relevant details for each test case; for full model specifications, refer to Supplementary Tables 11–26 and our code58.
Example 1
This example is described in a previous publication that conducted similar simulations in VCell24. There are 24 species in the original model, 11 of which are eliminated after accounting for mass conservation. We note that this simplification is only possible when different forms of a given molecule reside in the same compartment and share the same diffusion coefficient. This simplification, for instance, cannot be applied to actin species (F-actin and G-actin), as they have drastically different diffusion coefficients. All parameters were used unaltered from ref. 24, with the exception of the altered diffusion coefficients for well-mixed simulations.
We generate meshes for these cell geometries as described in Supplementary Note 4. We minimized computational expense by exploiting the symmetries of each geometry; in the case of a circular contact region, the geometry is axially symmetric, allowing us to simulate the model over a 2D mesh while ensuring the correct r dependence in all integrals, where r is the radial coordinate in cylindrical polar coordinates (Supplementary Note 3.3). The rectangular contact region has two symmetry axes, allowing us to simulate only one-quarter of the full geometry, treating the faces on the symmetry axes as no-flux boundaries. Similarly, the star contact region has five symmetry axes, allowing us to simulate one-tenth of the full mesh. Simulations were run to t = 10,000 s, by which time the system has plateaued to an apparent steady state.
Example 2
The model of Ca2+ dynamics within a dendritic spine was derived from ref. 26. This model involves only four dynamical species—Ca2+, fixed Ca2+ buffers bound to the plasma membrane, mobile Ca2+ buffers in the cytosol and Ca2+ in the spine apparatus, which was previously assumed to be constant. Ca2+ bound to buffers was not treated as a separate species, but was implicitly included assuming mass conservation and the same diffusion coefficient for buffering protein and buffering protein bound to Ca2+. All other quantities that change over time were treated as time-dependent parameters, explicitly defined by functions of time. As in the original model, N-methyl-d-aspartate receptors were restricted to the post-synaptic density. Voltage-sensitive Ca2+ channels were restricted to the spine head and a portion of the neck to match the region of stimulus in ref. 26. All other membrane fluxes were uniform throughout the spine head, neck and dendritic shaft.
Our analysis of the CRU used the model presented by ref. 5 with minor modifications. In their simulations, the SR was treated as a composite of several well-mixed compartments and the wider space surrounding the CRU was simulated as connected well-mixed compartments. Instead, we included the entire SR volume explictly in our spatial simulations, and boundaries of the cytosolic mesh were treated as no-flux surfaces. As above, complexes between Ca2+ and buffering species (ATP, calmodulin, troponin and calsequestrin) were implicitly considered under the assumptions of buffer mass conservation and unchanged diffusion coefficients. The main mechanism for Ca2+ elevations in this model is release from the SR through RyRs, which is assumed to terminate when the Ca2+ concentration falls below a certain threshold. Rather than explicitly encoding this discontinuity in the equations, we enforce this condition manually—we assign zero conductance to the RyRs after the average Ca2+ concentration in the entire SR reaches the threshold. SERCA channels were either included uniformly through the SR membrane or were excluded entirely.
Example 3
The model of ATP generation was directly adapted from the model in ref. 30. The model considers six states of ATP synthase and nine states of ANTs, as well as ATP concentration in the matrix and IMS and ADP concentration in the matrix. Assuming mass conservation, only five states and eight states need to be modeled explicitly for ATP synthase and ANTs. ADP concentration in the IMS is assumed to be constant and ATP concentration in the cytosol was solved for using the following coupling scheme. Before solving the PDEs at each time step (t = tn), the ATP concentration Tcyto at the next time point tn + τn was estimated as:
where TIMS is the ATP concentration in the IMS, volcyto is the volume of cytosol immediately surrounding the mitochondrion, NA is Avogadro’s number, τn is the time step at iteration n, kvdac is the ATP transport rate through VDACs, [VDAC] is the surface density of VDACs in the OM and ΓOM is the mesh surface comprising the OM. This updated value of Tcyto was then used in solving the PDE system, after which the estimated value was updated for consistency with the implicit Euler time discretization:
Reporting summary
Further information on research design is available in the Nature Portfolio Reporting Summary linked to this article.
Data availability
Results data (average concentrations, timing data and so on) are available on Zenodo at https://doi.org/10.5281/zenodo.11252055 (ref. 59). Meshes required to run spatial simulations shown in this paper can also be downloaded on Zenodo at https://doi.org/10.5281/zenodo.10480304 (ref. 60). Source data are provided with this paper.
Code availability
All code is freely available, both for SMART17 and for the biological test cases implemented in this paper, on Zenodo at https://doi.org/10.5281/zenodo.11268945 (ref. 58).
References
-
Villinger, C. et al. FIB/SEM tomography with TEM-like resolution for 3D imaging of high-pressure frozen cells. Histochem. Cell Biol. 138, 549–556 (2012).
Google Scholar
-
Heinrich, L. et al. Whole-cell organelle segmentation in volume electron microscopy. Nature 599, 141–146 (2021).
Google Scholar
-
McCafferty, C. L. et al. Integrating cellular electron microscopy with multimodal data to explore biology across space and time. Cell 187, 563–584 (2024).
Google Scholar
-
Schermelleh, L. et al. Super-resolution microscopy demystified. Nat. Cell Biol. 21, 72–84 (2019).
Google Scholar
-
Hake, J. et al. Modelling cardiac calcium sparks in a three-dimensional reconstruction of a calcium release unit: calcium sparks in reconstructed release unit. J. Physiol. 590, 4403–4422 (2012).
Google Scholar
-
Bell, M. K., Holst, M. V., Lee, C. T. & Rangamani, P. Dendritic spine morphology regulates calcium-dependent synaptic weight change. J. Gen. Physiol. 154, e202112980 (2022).
Google Scholar
-
Garcia, G. C. et al. Mitochondrial morphology provides a mechanism for energy buffering at synapses. Sci. Rep. 9, 18306 (2019).
Google Scholar
-
Daversin-Catty, C., Richardson, C. N., Ellingsrud, A. J. & Rognes, M. E. Abstractions and automated algorithms for mixed domain finite element methods. ACM Trans. Math. Softw. 47, 31:1–31:36 (2021).
Google Scholar
-
Wang, X. & Danuser, G. Remeshing flexible membranes under the control of free energy. PLoS Comput. Biol. 18, e1010766 (2022).
Google Scholar
-
Means, S. et al. Reaction diffusion modeling of calcium dynamics with realistic ER geometry. Biophys. J. 91, 537–557 (2006).
Google Scholar
-
Lee, C. T. et al. 3D mesh processing using GAMer 2 to enable reaction-diffusion simulations in realistic cellular geometries. PLoS Comput. Biol. 16, e1007756 (2020).
Google Scholar
-
Lee, C. T. et al. An open-source mesh generation platform for biophysical modeling using realistic cellular geometries. Biophys. J. 118, 1003–1008 (2020).
Google Scholar
-
Venkatraman, K. et al. Cristae formation is a mechanical buckling event controlled by the inner mitochondrial membrane lipidome. EMBO J. 42, e114054 (2023).
Google Scholar
-
Mesa, M. H., Garcia, G. C., Hoerndli, F. J., McCabe, K. J. & Rangamani, P. Spine apparatus modulates Ca2+ in spines through spatial localization of sources and sinks. Preprint at bioRxiv https://doi.org/10.1101/2023.09.22.558941 (2023).
-
Alnæs, M. et al. The FEniCS Project Version 1.5. Arch. Numer. Softw. 3, 9–23 (2015).
-
Laughlin, J. G. et al. SMART: Spatial Modeling Algorithms for Reactions and Transport. J. Open Source Softw. 8, 5580 (2023).
Google Scholar
-
Laughlin, J. G. et al. SMART: Spatial Modeling Algorithms for Reactions and Transport. Zenodo https://doi.org/10.5281/zenodo.10019519 (2023).
-
Schaff, J., Fink, C., Slepchenko, B., Carson, J. & Loew, L. A general computational framework for modeling cellular structure and function. Biophys. J. 73, 1135–1146 (1997).
Google Scholar
-
Cowan, A. E., Moraru, I. I., Schaff, J. C., Slepchenko, B. M. & Loew, L. M. in Methods in Cell Biology Vol. 110 (eds Asthagiri, A. R. & Arkin, A. P.) 195–221 (Elsevier, 2012); https://doi.org/10.1016/B978-0-12-388403-9.00008-4
-
Kerr, R. A. et al. Fast Monte Carlo simulation methods for biological reaction-diffusion systems in solution and on surfaces. SIAM J. Sci. Comput. 30, 3126–3149 (2008).
Google Scholar
-
Hucka, M. et al. The Systems Biology Markup Language (SBML): a medium forrepresentation and exchange of biochemical network models. Bioinformatics 19, 524–531 (2003).
Google Scholar
-
Balay, S., Gropp, W., McInnes, L. C. & Smith, B. F. PETSc, the portable, extensible toolkit for scientific computation. Argonne National Laboratory https://www.anl.gov/mcs/petsc-portable-extensible-toolkit-for-scientific-computation (1998).
-
Sun, M., Spill, F. & Zaman, M. H. A computational model of YAP/TAZ mechanosensing. Biophys. J. 110, 2540–2550 (2016).
Google Scholar
-
Scott, K. E., Fraley, S. I. & Rangamani, P. A spatial model of YAP/TAZ signaling reveals how stiffness, dimensionality, and shape contribute to emergent outcomes. Proc. Natl Acad. Sci. USA 118, e2021571118 (2021).
Google Scholar
-
Maduram, J. H., Goluch, E., Hu, H., Liu, C. & Mrksich, M. Subcellular curvature at the perimeter of micropatterned cells influences lamellipodial distribution and cell polarity. Cell Motil. Cytoskeleton 65, 841–852 (2008).
Google Scholar
-
Bell, M., Bartol, T., Sejnowski, T. & Rangamani, P. Dendritic spine geometry and spine apparatus organization govern the spatiotemporal dynamics of calcium. J. Gen. Physiol. 151, 1017–1034 (2019).
Google Scholar
-
Wu, Y. et al. Contacts between the endoplasmic reticulum and other membranes in neurons. Proc. Natl Acad. Sci. USA 114, E4859–E4867 (2017).
Google Scholar
-
Hoshijima, M. et al. CCDB:3603, MUS MUSCULUS, T-tubules, sarcoplasmic reticulum, myocyte. Cell Image Library https://doi.org/10.7295/W9CCDB3603 (2004).
-
Mendelsohn, R. et al. Morphological principles of neuronal mitochondria. J. Comp. Neurol. 530, 886–902 (2022).
Google Scholar
-
Garcia, G. C., Gupta, K., Bartol, T. M., Sejnowski, T. J. & Rangamani, P. Mitochondrial morphology governs ATP production rate. J. Gen. Physiol. 155, e202213263 (2023).
Google Scholar
-
Meyers, J., Craig, J. & Odde, D. J. Potential for control of signaling pathways via cell size and shape. Curr. Biol. 16, 1685–1693 (2006).
Google Scholar
-
Johnson, G. T. et al. Building the next generation of virtual cells to understand cellular biology. Biophys. J. 122, 3560–3569 (2023).
Google Scholar
-
Edwards, J. et al. VolRoverN: enhancing surface and volumetric reconstruction for realistic dynamical simulation of cellular and subcellular function. Neuroinformatics 12, 277–289 (2014).
Google Scholar
-
Hu, Y., Schneider, T., Wang, B., Zorin, D. & Panozzo, D. Fast tetrahedral meshing in the wild. ACM Trans. Graph. 39, 117:117:1–117:117:18 (2020).
Google Scholar
-
Mitusch, S. K., Funke, S. W. & Dokken, J. S. dolfin-adjoint 2018.1: automated adjoints for FEniCS and Firedrake. J. Open Source Softw. 4, 1292 (2019).
Google Scholar
-
Novak, I. L. et al. Diffusion on a curved surface coupled to diffusion in the volume: application to cell biology. J. Comput. Phys. 226, 1271–1290 (2007).
Google Scholar
-
Hepburn, I., Chen, W., Wils, S. & De Schutter, E. STEPS: efficient simulation of stochastic reaction–diffusion models in realistic morphologies. BMC Syst. Biol. 6, 36 (2012).
Google Scholar
-
Roberts, E., Stone, J. E. & Luthey-Schulten, Z. Lattice microbes: high-performance stochastic simulation method for the reaction-diffusion master equation. J. Comput. Chem. 34, 245–255 (2013).
Google Scholar
-
Hoops, S. et al. COPASI—a Complex Pathway Simulator. Bioinformatics 22, 3067–3074 (2006).
Google Scholar
-
Clark, A. P., Chowkwale, M., Paap, A., Dang, S. & Saucerman, J. J. Logic-based modeling of biological networks with Netflux. Preprint at bioRxiv https://doi.org/10.1101/2024.01.11.575227 (2024).
-
Baratta, I. A. et al. DOLFINx: the next generation FEniCS problem solving environment. Zenodo https://doi.org/10.5281/zenodo.10447666 (2023).
-
Voorsluijs, V., Dawson, S. P., De Decker, Y. & Dupont, G. Deterministic limit of intracellular calcium spikes. Phys. Rev. Lett. 122, 088101 (2019).
Google Scholar
-
Croci, M., Giles, M. B., Rognes, M. E. & Farrell, P. E. Efficient white noise sampling and coupling for multilevel Monte Carlo with nonnested meshes. SIAM/ASA J. Uncertain. Quantif. 6, 1630–1655 (2018).
Google Scholar
-
Stefanou, G. The stochastic finite element method: past, present and future. Comput. Methods Appl. Mech. Eng. 198, 1031–1051 (2009).
Google Scholar
-
Vinje, V., Bakker, E. N. T. P. & Rognes, M. E. Brain solute transport is more rapid in periarterial than perivenous spaces. Sci. Rep. 11, 16085 (2021).
Google Scholar
-
Benedusi, P., Ellingsrud, A. J., Herlyng, H. & Rognes, M. E. Scalable approximation and solvers for ionic electrodiffusion in cellular geometries. SIAM J. Sci. Comput. 46, B725–B751 (2024).
Google Scholar
-
Mahapatra, A., Malingen, S. A. & Rangamani, P. Interplay between cortical adhesion and membrane bending regulates microparticle formation. Preprint at bioRxiv https://doi.org/10.1101/2024.02.07.579325 (2024).
-
Serwas, D. et al. Mechanistic insights into actin force generation during vesicle formation from cryo-electron tomography. Dev. Cell 57, 1132–1145.e5 (2022).
Google Scholar
-
Akamatsu, M. et al. Principles of self-organization and load adaptation by the actin cytoskeleton during clathrin-mediated endocytosis. eLife 9, e49840 (2020).
Google Scholar
-
Zhu, C., Lee, C. T. & Rangamani, P. Mem3DG: modeling membrane mechanochemical dynamics in 3D using discrete differential geometry. Biophys. Rep. 2, 100062 (2022).
-
Chen, Y., Saintillan, D. & Rangamani, P. Interplay between mechanosensitive adhesions and membrane tension regulates cell motility. PRX Life 1, 023007 (2023).
Google Scholar
-
Herant, M. & Dembo, M. Cytopede: a three-dimensional tool for modeling cell motility on a flat surface. J. Comput. Biol. 17, 1639–77 (2010).
Google Scholar
-
Sahu, A., Omar, Y. A. D., Sauer, R. A. & Mandadapu, K. K. Arbitrary Lagrangian–Eulerian finite element method for curved and deforming surfaces: I. General theory and application to fluid interfaces. J. Comput. Phys. 407, 109253 (2020).
Google Scholar
-
Zimmermann, C. et al. An isogeometric finite element formulation for phase transitions on deforming surfaces. Comput. Methods Appl. Mech. Eng. 351, 441–477 (2019).
Google Scholar
-
Herant, M., Heinrich, V. & Dembo, M. Mechanics of neutrophil phagocytosis: experiments and quantitative models. J. Cell Sci. 119, 1903–1913 (2006).
Google Scholar
-
Bonilla-Quintana, M. & Rangamani, P. Biophysical modeling of actin-mediated structural plasticity reveals mechanical adaptation in dendritic spines. eNeuro https://doi.org/10.1523/ENEURO.0497-23.2024 (2024).
-
Geuzaine, C. & Remacle, J.-F. Gmsh: a 3-D finite element mesh generator with built-in pre- and post-processing facilities: the GMSH paper. Int. J. Numer. Methods Eng. 79, 1309–1331 (2009).
Google Scholar
-
Francis, E. A., Finsberg, H. N. & Dokken, J. S. Biological test cases implemented in SMART. Zenodo https://doi.org/10.5281/zenodo.11268945 (2024).
-
Francis, E., Dokken, J. S. & Finsberg, H. N. T. SMART analysis data. Zenodo https://doi.org/10.5281/zenodo.11252055 (2024).
-
Francis, E. SMART demo meshes. Zenodo https://doi.org/10.5281/zenodo.10480304 (2024).
-
Ahrens, J., Geveci, B. & Law, C. in Visualization Handbook (eds Hansen, C. D. & Johnson, C. R.) 717–731 (Elsevier, 2005); https://doi.org/10.1016/B978-012387582-2/50038-1
Acknowledgements
We acknowledge the members of the Rangamani Lab for their valuable insights throughout the development of SMART. We also thank C. Daversin-Catty for her guidance on using mixed-dimensional features in FEniCS. E.A.F. was supported by the National Science Foundation under grant number EEC-2127509 to the American Society for Engineering Education and funding from the Wu Tsai Human Performance Alliance at UCSD to P.R. P.R. was supported by the Air Force Office of Scientific Research (AFOSR, https://www.wpafb.af.mil/afrl/afosr/) Multidisciplinary University Research Initiative (MURI) FA9550-18-1-0051. J.G.L. was supported by a fellowship from the UCSD Center for Transscale Structural Biology and Biophysics/Virtual Molecular Cell Consortium and C.T.L. was supported by a Hartwell Foundation Postdoctoral Fellowship and a Kavli Institute for Brain and Mind Postdoctoral Fellowship. M.E.R was supported by the European Research Council (ERC) under the European Union’s Horizon 2020 research and innovation program under grant agreement 714892 (Waterscales), by the Research Council of Norway under grant 324239 (EMIx), by the Foundation Kristian Gerhard Jebsen via the K. G. Jebsen Center for Brain Fluid Research, and by the Fulbright Foundation. Simulation results presented in this paper benefited from the Experimental Infrastructure for Exploration of Exascale Computing (eX3), which is financially supported by the Research Council of Norway under contract 270053; in addition to the Triton Shared Compute Cluster at the San Diego Supercomputer Center (https://doi.org/10.57873/T34W2R).
Author information
Authors and Affiliations
Contributions
J.G.L. wrote the original code and conducted preliminary simulations. E.A.F. conducted the simulations shown in this work, wrote the tests, analyzed data, wrote the first draft of the paper and prepared figures. J.S.D. and H.N.T.F. contributed to software development and conducted numerical and performance testing. C.T.L. assisted in the original development of SMART and worked on mesh processing. M.E.R. and P.R. designed and supervised the project and wrote sections of the paper. All authors reviewed the paper.
Corresponding authors
Ethics declarations
Competing interests
The authors declare no competing interests.
Peer review
Peer review information
Nature Computational Science thanks Herve Turlier and the other, anonymous, reviewer(s) for their contribution to the peer review of this work. Peer reviewer reports are available. Primary Handling Editor: Ananya Rastogi, in collaboration with the Nature Computational Science team.
Additional information
Publisher’s note Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
Supplementary information
Supplementary Information
Supplementary Notes 1–5, Tables 1–26, Figs. 1–3, captions for Videos 1–7 and References.
Reporting Summary
Peer Review File
Supplementary Data 1
Source data for Supplementary Figs. 1 and 2.
Supplementary Video 1
F-actin and YAP/TAZ dynamics in a cell on a circular micropattern.
Supplementary Video 2
F-actin and YAP/TAZ dynamics in a cell on a rectangular micropattern.
Supplementary Video 3
F-actin and YAP/TAZ dynamics in a cell on a star-shaped micropattern.
Supplementary Video 4
Calcium dynamics in a dendritic spine.
Supplementary Video 5
Calcium dynamics in a cardiomyocyte CRU with SERCA.
Supplementary Video 6
Calcium dynamics in a cardiomyocyte CRU without SERCA.
Supplementary Video 7
ATP dynamics in a mitochondrion.
Source data
Source Data Fig. 3
Source data for Fig. 3.
Source Data Fig. 4
Source data for Fig. 4, organized by panel.
Source Data Fig. 5
Source data for Fig. 5.
Source Data Fig. 6
Source data for Fig. 6, organized by panel.
Rights and permissions
Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/.
Reprints and permissions
About this article
Cite this article
Francis, E.A., Laughlin, J.G., Dokken, J.S. et al. Spatial modeling algorithms for reactions and transport in biological cells.
Nat Comput Sci (2024). https://doi.org/10.1038/s43588-024-00745-x
-
Received: 24 May 2024
-
Accepted: 19 November 2024
-
Published: 19 December 2024
-
DOI: https://doi.org/10.1038/s43588-024-00745-x