Abstract
Models of cardiac mechanics are increasingly used to investigate cardiac physiology. These models are characterized by a high level of complexity, including the particular anisotropic material properties of biological tissue and the actively contracting material. A large number of independent simulation codes have been developed, but a consistent way of verifying the accuracy and replicability of simulations is lacking. To aid in the verification of current and future cardiac mechanics solvers, this study provides three benchmark problems for cardiac mechanics. These benchmark problems test the ability to accurately simulate pressure-type forces that depend on the deformed objects geometry, anisotropic and spatially varying material properties similar to those seen in the left ventricle and active contractile forces. The benchmark was solved by 11 different groups to generate consensus solutions, with typical differences in higher-resolution solutions at approximately 0.5%, and consistent results between linear, quadratic and cubic finite elements as well as different approaches to simulating incompressible materials. Online tools and solutions are made available to allow these tests to be effectively used in verification of future cardiac mechanics software.
Keywords: cardiac mechanics, verification, benchmark, VVUQ
1. Introduction
Computational models of the heart are increasingly used to improve our understanding of cardiac physiology, including the effect of specific genetic changes and animal models of disease [1–3]. In addition, patient-specific models are being developed to predict and quantify the response of clinical interventions, identify potential treatments and evaluate novel devices [4,5]. For this purpose, a large number of independent simulation codes have been developed, ranging from open-source software and commercial products to a range of closed-source codes specific to individual research groups [6–8]. The shift of cardiac models from a research tool to a potential clinical product for informing patient care will bring cardiac models into the remit of clinical regulators. With this transition comes the requirement for improved coding standards. The move towards higher standards of accuracy and reproducibility is mirrored in many other fields of scientific computation [9]. A recent report by the National Research Council on the verification, validation and uncertainty quantification of scientific software addressed some of these issues with the aim of improving processes in computational science [10]. They define three specific categories of interest:
— erification. Determining how accurate a computer program solves the equations of a mathematical model.
— alidation. Determining how well a mathematical model represents the real world phenomena it is intended to predict.
— ncertainty quantification. The process of quantifying uncertainties associated with calculating the result of a model.
In cardiac modelling, uncertainty quantification has long been part of the accepted set of techniques, both in parameter sensitivity studies and studying the effects of biological variability. Approaches to uncertainty quantification include sensitivity analysis, visualization of parameter sweeps and the use of regression techniques [11–14]. More formal approaches have also been applied, including quantification of variability in high-throughput experiments and propagation of this variability in models, and high-order stochastic collocation methods to analyse variability in high-throughput ion channel data [15,16].
The variability and uncertainty of biological systems create significant challenges for validating computational models [9,17]. Historical data from the experimental literature cover a wide range of conditions with respect to temperature, species, genetic strain and other methodological detail [18]. As comprehensive and consistent experimental datasets are rarely available, the data most useful for validating predictions are nearly always used for constraining parameters and developing the model.
Verification is the process of determining a code's accuracy in solving the mathematical model it implements. This is an area that has also been widely recognized in high-stakes fields such as aeronautics, nuclear physics and weather prediction [17,19,20]. Until recently, verification has had a limited role in cardiac modelling. More recently, concerted verification efforts have been made in the area of cardiac electrophysiology solvers. These include an N-version benchmark now being used routinely [21], analytic solutions becoming available [22] and more benchmark tests currently being organized to expand these tests to cover more complex electrophysiological phenomena.
Similar domain-specific verification tests have been lacking for simulating cardiac mechanics. The heart has unique mechanical properties, including a contractile force generated by the tissue itself, and complex nonlinear and anisotropic material features. There are a range of analytic solutions which are commonly used in testing the correctness and convergence of solid mechanics software, most notably Rivlin's problems on torsion, inflation and extension of an incompressible isotropic cylinder [23]. Although these analytic solutions for solid mechanics problems help in verifying the correctness of mechanics codes, these typically do not test several crucial aspects specific to the simulation of cardiac mechanics. First, these problems with analytic solutions tend to be limited to isotropic material properties, whereas cardiac material is typically modelled as transversely isotropic or orthotropic. Second, complex pressure boundary conditions, in which both the area and orientation of the surface changes, are poorly tested. Third, active contraction of tissue is not tested, while it is the driving force in a simulation of cardiac function. As a result, simulation codes in the field are often under-verified, and a standard problem set is lacking. Similar limitations to using simple test problems with available analytic solutions were encountered in the field of computational fluid dynamics, which has a long history of verification and validation [19]. Lessons from this field include extending verification efforts to include benchmarks of carefully defined complex problems, and direct comparisons with experiments tailor-made for simulation validation. A complementary strategy for investigating reproducibility in the field of cardiac mechanics was the recent STACOM challenge [24], which asked participants to predict left-ventricular deformation between two given magnetic resonance imaging (MRI) datasets. As this challenge left many aspects open to user choice, including mesh generation, boundary constraints and material models, and did not aim for a single consensus solution, it is less suitable as a verification problem.
This report presents a set of three problems for the validation of cardiac mechanics software, along with an N-version benchmark of 11 different implementations. We have defined a series of benchmark problems that can be solved by typical cardiac mechanical simulators, with features that are important for solving cardiac mechanics problems.
2. Methods
We propose to verify cardiac mechanics codes using an N-version benchmark. For this approach to be effective, we need to ensure a large enough number of participants to achieve a community consensus for the solution, while ensuring that the test problems cover the salient properties of the codes. The cardiac mechanics benchmark problems should be simple enough to be clearly and unambiguously communicated, whereas complex enough to test important aspects of software codes not routinely tested using other methods. To ensure that any differences in solutions are due to differences in the implementation and not owing to ambiguities in the model definition or the use of different image processing tools, we use analytic descriptions for the geometry in all problems. However, we have not required the use of a specific numerical method, finite-element basis type or approach to modelling incompressibility, to maximize the number of potential participants. We have created a set of three different problems, each testing different aspects important to solving cardiac mechanics. The first problem uses a simple beam geometry with a typical cardiac constitutive law, testing the correct implementation of the governing equations, material properties and pressure boundary conditions changing with the deformed surface orientation and area. The second problem is independent of fibre direction and uses isotropic material properties, but tests a more complex left ventricular geometry. Finally, the third problem uses an identical geometry to the second problem, but adds a varying fibre distribution and active tension.
The free choice of numerical method and basis types poses challenges for comparing results and solution formats. As a compromise, the VTK file format is used for data output and processing, as this format is already in common use, several participants had built-in support for it in their software, and there is an extensive application program interface (API) for reading and processing results [25].
(a). Solid mechanics theory and notation
We start with a brief overview to the theory of solid mechanics to introduce notation and concepts referred to in the problem description. We denote the undeformed location in Cartesian coordinates of a point as X and the deformed position as x=x(X). The deformation gradient is defined as F=∂x/∂X, and is the Green–Lagrange strain tensor. The governing equations for the deformation of an incompressible solid in steady-state equilibrium can be stated as
2.1 |
and
2.2 |
where and σ is the Cauchy stress tensor which is derived from a strain energy function W(E) by
2.3 |
where T is the second Piola–Kirchhoff stress tensor. Apart from these basic governing equations, theory is dependent on the numerical approach. Further derivation usually proceeds by the principle of virtual work to derive a finite-element weak form. Reviews of modelling mechanics and finite-element approaches can be found in the literature, e.g. Holzapfel [26] or Bonet & Wood [27]. Regardless of the discretization used, the equations are both inherently nonlinear, and additional nonlinearity is introduced when using a nonlinear strain energy function W(E), which is the norm in cardiac mechanics simulations. To maximize the number of participants and encourage a wide range of solutions, we have made no particular requirement or recommendation for specific numerical approaches in defining the benchmark problems.
(b). Constitutive law
Cardiac tissue consists of a mesh of collagen with cardiac muscle cells, or ‘cardiomyocytes’. Cardiomyocytes are approximately 100×10×10 μm in size, with a distinct long axis, often referred to as the ‘fibre direction’. Taking into account, the fibre direction leads to models with a transversely isotropic constitutive law [28–30]. In addition, laminar sheets have been identified, with more collagen links between cells in a sheet, compared with between sheets. Taking these sheets into account gives rise to an orthotropic material law [31–34]. However, histological examination shows that while sheets are clearly present in the mid-myocardium, their presence is not uniform throughout the myocardial wall [35]. In addition, defining a problem with orthotropic material properties requires a more complex problem description, and not all participants have software that supports simulating this kind of material.
For the benchmark problems, we use the transversely isotropic constitutive law by Guccione et al. [28]. It was anticipated that this constitutive law would be the most widely implemented by potential participants because it is relatively simple and has been widely used in cardiac modelling. Its strain energy function is given by
2.4 |
and
2.5 |
where Eij are components of the Green–Lagrange strain tensor E in a local orthonormal coordinate system with fibres in the e1-direction, and where C,bf,bt,bfs are the material parameters which will be defined for each of the three problem separately. In all problems, the material is fully incompressible, i.e. J=1 as stated in equation (2.2). Please note that in all problems the direction of the pressure boundary condition changes with the deformed surface orientation, and its magnitude scales with the deformed area. There were no restrictions on the methods used to satisfy incompressibility, and participants used both Lagrange multiplier methods as well as quasi-incompressibility approaches with penalty functions to satisfy this constraint.
(c). Problem descriptions
The following sections give a complete and reproducible description of each of the three benchmark problems as distributed to the participants. In addition to an incompressible large deformation elasticity formulation and a description of the constitutive law, five additional components were required for a reproducible problem definition: a reproducible problem definition requires five additional parts: a problem geometry, the material parameters (C,bf,bt,bfs), a full description of the fibre direction throughout the geometry, the Dirichlet boundary conditions and the applied pressure boundary conditions. The three problems each test different aspects important to cardiac mechanics solvers. The first problem is the simulation of a deforming rectangular beam. This problem tests pressure-type forces whose directions change with the deformed surface orientation, and the correct implementation of fibre directions changing with the deformation, the transversely isotropic constitutive law, and Dirichlet boundary conditions. This problem uses a simple mesh geometry, which makes it easier to quickly test new codes and provide an initial verification test. The second problem is the inflation of an ellipsoid with isotropic material properties. The problem tests the reproduction of a mesh geometry from a description, and a deformation pattern similar to cardiac inflation. The third problem is the inflation and active contraction of an ellipsoid with transversely isotropic material properties. The problem tests reproducibility of complex fibre patterns, and the implementation of active contraction, both important aspects of a cardiac mechanics solver. Using two problems on the same initial geometry allows benchmark participants to generate a mesh geometry and verify inflation first, before the source of potential errors is conflated with the implementation of active contraction and fibre directions. This is intended to make it easier to track down potential errors in an implementation.
(i). Problem 1: deformation of a beam
Figure 1 shows the problem geometry and a representative solution.
Geometry: the undeformed geometry is the region x∈[0,10], y∈[0,1], z∈[0,1] mm.
Constitutive parameters: transversely isotropic, C=2 kPa,bf=8,bt=2,bfs=4.
Fibre direction: constant along the long axis, i.e. (1, 0, 0).
Dirichlet boundary conditions: the left face (x=0) is fixed in all directions.
Pressure boundary conditions: a pressure of 0.004 kPa is applied to the entire bottom face (z=0).
(ii). Problem 2: inflation of a ventricle
Figure 2 shows the problem geometry and an example solution.
Geometry: the undeformed geometry is defined using the parametrization for a truncated ellipsoid:
2.6 |
The undeformed geometry is defined by the volume between:
— the endocardial surface ,
— the epicardial surface
— the base plane z=5 mm which is implicitly defined by the ranges for u.
Constitutive parameters: isotropic, C=10 kPa, bf=bt=bfs=1.
Dirichlet boundary conditions: the base plane (z=5 mm) is fixed in all directions.
Pressure boundary conditions: a pressure of 10 kPa is applied to the endocardial surface.
(iii). Problem 3: inflation and active contraction of a ventricle
Geometry, Dirichlet boundary conditions: identical to problem 2.
Fibre definition: fibre angles α used in this benchmark problem range from −90° at the epicardial surface to +90° at the endocardial surface. These angles were chosen to allow for easy visual inspection of generated fibre directions, despite being steeper than those measured in DTMRI experiments [36]. They are defined using the direction of the derivatives of the parametrization of the ellipsoid in equation (2.6)
2.7 |
2.8 |
2.9 |
2.10 |
2.11 |
2.12 |
where rs, rl and α are derived from the transmural distance t∈[0,1] which varies linearly from 0 on the endocardium and 1 on the epicardium. The apex (u=−π) has a fibre singularity which is common in cardiac mechanics problems. No specific approaches are prescribed for handling this singularity, and all approaches were considered acceptable.
Constitutive parameters: transversely isotropic, C=2 kPa, bf=8, bt=2, bfs=4.
Active contraction: the active stress is given by a constant, homogeneous, second Piola–Kirchhoff stress in the fibre direction of 60 kPa, i.e.
2.13 |
where Ta=60 kPa, f is the unit column vector in the fibre direction described above, and the passive stress Tp=∂W/∂E as in equation 2.3.
Pressure boundary conditions: a constant pressure of 15 kPa is applied to the endocardium. As this is a quasi-static problem, participants are free to add active stress first, add pressure first or increment both simultaneously in finding a solution. Figure 2 shows the problem geometry and an example solution.
(d). Participants
Table 1 lists the participants and the computational methods they used. Although there was no requirement to use a specific computational method, all participants used finite-element methods, as they are most common in the field of cardiac mechanics.
Table 1.
code name | affiliation | type | references | method |
---|---|---|---|---|
Cardioid | IBM2 | in-house | [8] | Q2Q1/P2P1, Lagrange multiplier, I/D |
CardioMechanics | KIT5 | in-house | [2] | P2, quasi-incompressible |
CARP | Graz1,4 | in-house | [37] | P1P0, quasi-incompressible, I/D |
Elecmech | KCL1 | in-house | [38,39] | Q3Q1, Lagrange multiplier |
GlasgowHeart-IBFE | Glasgow10,12 | in-house | [40] | Q1, IB/FEa |
Hopkins-MESCAL | Hopkins6 | in-house | Q1P0, Lagrange multiplier | |
LifeV | Duke15 | open sourceb | [41,42] | P2, quasi-incompressible |
MOOSE-EWE | USI9 | mixedc | [43] | Q2Q1/P2P1, Lagrange multiplier, I/D |
OpenCMISS | Auckland3,7,13 | open sourced | [6] | Q3Q1 (hermite), Lagrange multiplier, I/D |
Simula-FEniCS | Simula14 | open sourcee | [44,45] | P2P1f, Lagrange multiplier, I/D |
PUC-FEAPg | PUC8,11 | open source | [46] | Q1P0, Lagrange multiplier, I/D |
aIB/FE indicates the immersed boundary method using a finite-element mechanics model, and used the open-source IBAMR software available at https://github.com/IBAMR/IBAMR.
bLifeV was developed by EPFL and available at http://github.com/lifev.
cMOOSE is open source and available at http://www.mooseframework.org/, EWE is an in-house application using MOOSE.
dOpenCMISS available at http://www.opencmiss.org.
eFEniCS was developed by Simula and is available at http://fenicsproject.org, with problem-specific source code available at https://bitbucket.org/peppu/mechbench.
fFEniCS using two-dimensional elements in problems 2 and 3.
gPUC-FEAP: no solution submitted for problems 2 and 3, FEAP available at http://www.ce.berkeley.edu/projects/feap/.
3. Results
Here, we analyse and compare the submitted solutions with the benchmark problems. In terms of three-dimensional deformation as visualized, the submitted solutions are typically indistinguishable, so such visualizations are not included for all solutions. There are no analytic solutions to the problems, which limits the use of typical convergence analysis. In addition, the range of different finite-element basis types used result in further challenges in processing data and comparing solutions.
To analyse and compare results, we use the API provided by VTK [25].1 Participants were requested to provide meshes for the deformed and undeformed configurations in the VTK file format. Where a basis type was not supported by VTK, specifically on cases using cubic-order elements, solutions were interpolated to a compatible VTK element type. Our strategy for comparing solutions is based on a method for determining the deformed location of specific points in the submitted solutions for all participants. Using the VTK API, we locate the element containing a specific point in the undeformed mesh provided by a participant, along with the local parametric coordinates within that element. We use these local coordinates to locate the corresponding deformed point in the same element of the deformed geometry provided. This process allows us to track displacements in a wide variety of element types.
To calculate strain Si, we track changes in the distance between pairs of n points with coordinates and in the undeformed finite-element geometries and coordinates and of the deformed geometry, where . We use a finite difference scheme to determine the strain
3.1 |
For the beam problem, we use neighbouring points along the line (x,0.5,0.5) to calculate axial strain in the x-direction: and , where i=0,1,…,8. For transverse strain, we use , where i=0,1,…,9 and and for strain calculations in the y- and z-directions, respectively.
For the ellipsoidal problems, longitudinal, circumferential and radial strain are each calculated at the endocardium, epicardium and midwall. We use the parametrization in equations (2.6)–(2.12) and take the points along apex-to-base lines: vi=0, ui=u1+(u2−u1)/nu×(i+1)×0.95, where u1=−π, , nu=10 and i=0,1,…,nu−1. These lines are taken along the endocardium (t=0.1), epicardium (t=0.9) and midwall (t=0.5). For longitudinal strain, we use pairs of neighbouring points along each line. For transmural strains, we use pairs of neighbouring endocardium-midwall, midwall-epicardium and endocardium–epicardium points to calculate radial strain at endocardium, epicardium and midwall. To calculate circumferential strain, the second point is derived by rotating the points at each myocardial layer by using vi=π/10 instead of vi=0. The points used for strain calculation are also shown in figures 1 and 2.
Overall, we perform three types of comparisons for each problem. First, we look at key points in the solution, which provides a crude but efficient measure of solution accuracy, and allows us to plot the accuracy of all solutions as a function of the number of degrees of freedom used to solve the problem. Second, we display the deformation of key lines through the mesh, which provides a more global measure of accuracy while still being easy to interpret and compare in a two-dimensional plot. Third, we calculate the strain measures described in this section to enable a more complex quantitative comparison of the deformation in each direction.
(a). Problem 1
Figure 3 shows the maximal deflection of the beam across different solutions plotted against the number of degrees of freedom used, with the deformed position of a specific line at maximal deflection shown in figure 4. Figure 5 shows a comparison of strain measures in the submitted solutions. For both the strain measures and the deformed solution, only the solutions with most refined discretizations were used.
(b). Problem 2
Figure 6 shows the location of the endocardial and epicardial apex plotted against the number of degrees of freedom used. Figure 7 shows the deformed position of a line in the midwall from apex to base for all the submitted solutions, with details of the apex and inflection point. Figure 8 shows a comparison of strain measures for the submitted solutions.
(c). Problem 3
Figure 9 shows the location of the endocardial and epicardial apex plotted against the number of degrees of freedom used. Figure 10 shows the deformed position of a line in the midwall from apex to base for all the submitted solutions, and figure 11 shows the position of this same line as viewed from the top, comparing results for the twisting motion of the ventricle under active contraction. Details are provided of several key regions to highlight small differences between solutions. Figure 12 shows a comparison of strain measures for the submitted solutions.
4. Discussion
This study presented a set of benchmark problems and an in-depth evaluation of 11 different cardiac mechanics codes, each submitting between one and four solutions for the three benchmark problems. The results, processing tools and MATLAB scripts for mesh generation, are made available online to assist in the verification of additional software in the field.2
In addition to verifying a basic solid mechanics solver, the benchmark problems test several aspects of software specific to cardiac mechanics. First, all three problems test pressure boundary conditions that depend on the deformed surface orientation and area. This has typically been the only type of external force applied to the heart in physiological cardiac simulations, although some more recent work implements contact mechanics with the pericardium [2], or spring boundary conditions to simulate contact with soft material near the apex. Second, the problems test a commonly used transversely isotropic constitutive law, as well as a complex fibre distribution. Fibre directions are most commonly stated in terms of ‘fibre angles’, and routinely visualized in the literature. However, they are rarely described accurately enough to ensure reproducibility, as the conversion from fibre angles to fibre vectors can rely on details of mesh geometry and implementation of local coordinate systems and orthogonalization. Specifically, fibre orientations are often defined with respect to local finite-element mesh coordinates, but mesh personalization tools vary, and there is no guarantee that these local coordinates unambiguously align with the apical-basal or circumferential directions. As a result, reproducible fibre directions are rarely given in studies on cardiac mechanics. In this study, the use of an exact mathematical description of fibre directions provided an unambiguous anatomical description and demonstrates that this description is sufficient for different groups to reproduce a solution. Third, we have tested the inclusion of contractile forces. Although these contractile forces are arguably the most important factor driving cardiac deformation, there have been no tests of its correct implementation proposed so far. The third benchmark problem tests this aspect and reproduces the typical twisting motion with apical–basal shortening of the ventricle in systole. Overall, the current problems aim to strike a balance between problem complexity and testing aspects that are important in cardiac mechanics, but currently not routinely tested. At the same time, they were designed to be simple enough to run relatively quickly, increasing their utility in rapid verification of software.
In this report, we have used a variety of methods to compare the submitted solutions. Showing deformation results for a few key points plotted against the number of degrees of freedom is a concise way of comparing a large number of solutions. They also provide a quick verification test for new software codes, as comparison of a single point for each problem can quickly reveal incorrect solutions. A drawback of this technique is that the selected points of comparison may not be representative of the overall accuracy of a solution. Especially in problem 3, errors localized at the apex show up disproportionately, and are not always representative of the accuracy elsewhere. Therefore, we have highlighted both regions close to the apex as well as closer to the base. Plotting the deformation of lines through the simulation domain as in figures 4, 7 and 10 shows more information, but can quickly result in solutions overlapping in visualizations. Finally, we have plotted strain in different directions, and at different locations, for the submitted solutions. For problem 1, despite the large deformation of the beam, relatively small strains on the order of 1% were observed (figure 5). The largest strains and largest discrepancies between solutions are located near the Dirichlet boundary conditions at x=0. Thus, this strain test is useful to reveal obvious errors in implementation or to reveal shortcomings in discretization such as volumetric locking by linear finite elements. A potential explanation for differences in strain between submitted solutions is the low number of degrees of freedom used by some groups. Strain results for problem 2 (figure 8) are most consistent across submitted solutions, suggesting that this was the least challenging test. Problem 3 was the most challenging test, and a number of participants submitted several revised solutions before the close agreement in strains shown in figure 12 was achieved. These visualizations are richer, comparing the solutions across a wider area, and more clearly show local similarities and differences. However, they require a larger number of plots to show, and are more difficult to interpret and define in a reproducible way. Requiring only solutions of the deformation increased participation, given the varied capabilities of the software used by different participants, but limited the range of possible comparison methods. Further comparisons would have been possible by requiring participants to provide Cauchy–Green strain, or deformed fibre directions in problem 3. Although it is theoretically possible to obtain these metrics using finite-difference methods, in practice, we found this approach not robust enough in the VTK implementation, leading us to use more global strain metrics.
In total, 11 different groups submitted solutions to the benchmark problems. Although the choice of computational methods was left open, all participants used finite-element methods to solve the problems. Most commonly used were quadratic-order tetrahedral elements and linear hexahedral elements. In addition, to these standard solution methods, several unique approaches were applied in solving the benchmark problems. First, problem 2 and 3 were rotationally symmetric, and participants from Simula Research Laboratory exploited this feature by solving these problems using two-dimensional elements, allowing very high-resolution solutions. Second, participants from the University of Glasgow applied the immersed boundary method with finite-element extension (IB/FE) developed for their coupled fluid-structure implementation [40]. The IB/FE method is designed for dynamic fluid-structure analyses rather than for the quasi-static analyses considered in this study, but its inclusion in the study highlights the usefulness of the benchmark problems in verification of both static and dynamic solvers. Overall, there was broad agreement between participants, with typical differences in deformation at approximately 1% (figures 3, 7, 6, 9, 10). The largest differences that were encountered were attributed to
— under-converged results, e.g. the high discrepancy between solutions with a few hundred degrees of freedom and those with over 105 in problem 1 (figure 3). However, in problems 2 and 3, the solutions with larger difference from consensus solutions were not necessarily those with the fewest degrees of freedom used. Specifically, the use of two-dimensional elements exploiting problem symmetry by Simula Research Laboratory achieved excellent accuracy with very low degrees of freedom used. Nevertheless, the largest error for those using three-dimensional elements appears for LifeV, who use the fewest degrees of freedom.
— the use of a passive isotropic region near the apex in problem 3. This clearly shows differences in apical strain (figure 10), especially for earlier submitted results using a relatively large region with passive material properties, but is also still visible for several results in the final set. However, despite differences at the apex, results were consistent with other codes in the basal regions.
In addition, several participants reported potential stability problems. Fung-type constitutive laws, including the one used in this benchmark, can become unstable depending on the material parameters and loading conditions [47]. This was reported to lead to potential stability issues in problem 1, although all participants managed to solve to the load specified in the problem description. Participants from Simula Research Laboratory noted that problem 2 can fail to solve at around 3 kPa pressure when using P2P1 elements unless volumetric–deviatoric splitting of the deformation gradient is used. Similar stability problems were reported by the PUC group at around 10.5 kPa using Q1P0 elements, despite the use of volumetric–deviatoric splitting. The benchmark also tests the ability of software to handle problems with different properties in terms of their stiffness matrix, which potentially affects solver convergence. Specifically, problems 2 and 3 have a symmetric stiffness matrix owing to the boundary of the region where pressure is applied being completely fixed, whereas problem 1 has an asymmetric stiffness matrix (cf. Bonet & Wood [27], §6.5.2).
As the first significant benchmark in the field of cardiac mechanics, we have aimed to strike a balance between maximizing participation and testing more complex aspects of cardiac mechanical simulations. As such, this initial study has a number of potential limitations. First, problem 3 adds both fibre directions and active contraction, whereas an additional problem could test only passive properties, leading to more fine-grained verification. However, in the context of limiting the number of problems to be solved, we found it more important to introduce mesh geometry and fibre directions in separate problems, as both are difficult to unambiguously describe and reproduce. For problems 2 and 3, the curved geometry combined with the free choice of elements and meshing strategy, means that not all points in the problem domain appear in each mesh. This limits comparison with regions present in all submitted solutions, and specifically prevents comparison of solutions near the edge of the problem domain. In addition, the limited support for higher-order elements in VTK required interpolating cubic-order solutions to linear elements, which has the potential for introducing additional error. Finally, although this benchmark tests a number of important aspects specific to cardiac mechanics, future benchmarks could test several more detailed aspects not touched on by these benchmark problems. Specifically, an important aspect that was not tested is the use of time-dependent solutions of the cardiac cycle with heterogeneous activation patterns. These whole cycle simulations also require specialized numerics required to deal with length- and velocity-dependence of cardiac tension, and techniques for coupling to hemodynamic models, which were not tested in the current benchmark. Other aspects could involve using non-symmetric geometries, biventricular models or including the personalization of a mesh from a segmented image. In the context of the increase in patient-specific modelling, a verification of with local heterogeneities in material properties and contractile force, as observed in ischaemia, would be particularly important.
In conclusion, the development of a set of benchmark problems for simulating cardiac mechanics is an important step in the process of verification of cardiac modelling software. These results now provide us a standard and reproducible set of problems to drive forward the development and verification of simulation platforms and numerical methods tailored to the domain-specific characteristics of cardiac mechanics modelling.
Acknowledgements
Z.J.W., S.A. and M.P.N. thank Dr Vicky Wang.
Footnotes
Available at http://www.vtk.org/download/.
Repository of results: http://www.bitbucket.org/sander314/mechbench.
Data accessibility
All submitted solutions are available on the repository http://www.bitbucket.org/sander314/mechbench.
Authors' contributions
S.L. coordinated the project, developed problems 2 and 3, analysed deformation data and wrote the manuscript. V.G. co-coordinated the project, developed problem 1 and analysed strain data. S.A.N. participated in project conception, problem development and drafting the manuscript. All other authors contributed to preparing and submitting solutions to the benchmark. All authors critically revised and approved the final version of the manuscript.
Competing interests
We have no competing interests.
Funding
This work was supported by the Biotechnology and Biological Sciences Research Council grant no. BB/J017272/1 (S.L.), the National Institutes of Health grants nos. R01 HL103428 (N.T.), DP1 HL123271 (N.T.), R01 HL117063 (B.E.G.) and P50 GM071558 (B.E.G.), the National Science Foundation grant nos. IOS-1124804 (N.T.), ACI 1460334 (B.E.G.) and DMS 1460368 (B.E.G.), the British Heart Foundation grant no. PG/14/64/31043 (X.L.,H.G.), the Engineering and Physical Sciences Research Council grant no. EP/I029990 (X.L.,H.G.) and EP/M012492/1 (S.A.N.), B.O.F. (Ghent University) (S.A.), the Austrian Science Fund (FWF) grant no. F3210-N18 (G.P.), the European Union grant CardioProof 611232 (G.P.), a King's College London Graduate School Award (T.E.F.), the Chilean Fondo Nacional de Ciencia y Tecnología (FONDECYT) no. 11121224 (D.H.,S.C) and the British Heart Foundation grant no. PG∖13∖37∖30280 (S.A.N.). S.L., T.E.F., N.P.S. and S.A.N. acknowledge financial support from the Department of Health via the National Institute for Health Research (NIHR) comprehensive Biomedical Research Centre award to Guy's & St Thomas’ NHS Foundation Trust in partnership with King's College London and King's College Hospital NHS Foundation Trust.
References
- 1.Sheikh F. et al. 2012. Mouse and computational models link mlc2v dephosphorylation to altered myosin kinetics in early cardiac disease. J. Clin. Invest. 122, 1209–1221. (doi:10.1172/JCI61134) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Fritz T, Wieners C, Seemann G, Steen H, Dössel O. 2014. Simulation of the contraction of the ventricles in a human heart model including atria and pericardium. Biomech. Model. Mechanobiol. 13, 627–641. (doi:10.1007/s10237-013-0523-y) [DOI] [PubMed] [Google Scholar]
- 3.Land S. et al. 2014. Computational modeling of Takotsubo cardiomyopathy: effect of spatially varying β-adrenergic stimulation in the rat left ventricle. Am. J. Physiol. Heart Circ. Physiol. 307, H1487–H1496. (doi:10.1152/ajpheart.00443.2014) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.McDowell K, Zahid S, Vadakkumpadan F, Blauer J, MacLeod R, Trayanova N. 2015. Virtual electrophysiological study of atrial fibrillation in fibrotic remodeling. PLoS ONE 10, e0117110 (doi:10.1371/journal.pone.0117110) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Niederer S, Lamata P, Plank G, Chinchapatnam P, Ginks M, Rhode K, Rinaldi C, Razavi R, Smith N. 2012. Analyses of the redistribution of work following cardiac resynchronisation therapy in a patient specific model. PLoS ONE 7, e43504 (doi:10.1371/journal.pone.0043504) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Bradley C. et al. 2011. OpenCMISS: a multi-physics and multi-scale computational infrastructure for the VPH/Physiome project. Prog. Biophys. Mol. Biol. 107, 32–47. (doi:10.1016/j.pbiomolbio.2011.06.015) [DOI] [PubMed] [Google Scholar]
- 7.Mirams GR. et al. 2013. Chaste: an open source C++ library for computational physiology and biology. PLoS Comput. Biol. 9, e1002970 (doi:10.1371/journal.pcbi.1002970) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Gurev V, Pathmanathan P, Fattebert J-L, Wen H-F, Magerlein J, Gray RA, Richards DF, Rice JJ. 2015. A high-resolution computational model of the deforming human heart. Biomech. Model. Mechanobiol. 14, 829–849. (doi:10.1007/s10237-014-0639-8) [DOI] [PubMed] [Google Scholar]
- 9.Pathmanathan P, Gray RA. 2013. Ensuring reliability of safety-critical clinical applications of computational cardiac models. Front. Physiol. 4, 358 (doi:10.3389/fphys.2013.00358) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Committee on Mathematical Foundations of Verification, Validation, and Uncertainty Quantification; Board on Mathematical Sciences and Their Applications, Division on Engineering and Physical Sciences, National Research Council. 2012. Assessing the reliability of complex models: mathematical and statistical foundations of verification, validation, and uncertainty quantification. Washington, DC: The National Academies Press. [Google Scholar]
- 11.Sarkar AX, Sobie EA. 2010. Regression analysis for constraining free parameters in electrophysiological models of cardiac cells. PLoS Comput. Biol. 6, e1000914 (doi:10.1371/journal.pcbi.1000914) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Gemmell P, Burrage K, Rodriguez B, Quinn TA. 2014. Population of computational rabbit-specific ventricular action potential models for investigating sources of variability in cellular repolarisation. PLoS ONE 9, e90112 (doi:10.1371/journal.pone.0090112) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Land S, Niederer SA, Aronsen JM, Espe EKS, Zhang L, Louch WE, Sjaastad I, Sejersted OM, Smith NP. 2012. An analysis of deformation-dependent electromechanical coupling in the mouse heart. J. Physiol. 590, 4553–4569. (doi:10.1113/jphysiol.2012.231928) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Töndel K, Land S, Niederer SA, Smith NP. 2015. Quantifying inter-species differences in contractile function through biophysical modelling. J. Physiol. 593, 1083–1111. (doi:10.1113/jphysiol.2014.279232) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Xiu D, Sherwin SJ. 2007. Parametric uncertainty analysis of pulse wave propagation in a model of a human arterial network. J. Comput. Phys. 226, 1385–1407. (doi:10.1016/j.jcp.2007.05.020) [Google Scholar]
- 16.Elkins RC, Davies MR, Brough SJ, Gavaghan DJ, Cui Y, Abi-Gerges N, Mirams GR. 2013. Variability in high-throughput ion-channel screening data and consequences for cardiac safety assessment. J. Pharmacol. Toxicol. Methods 68, 112–122. (doi:10.1016/j.vascn.2013.04.007) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17.Sainani K. 2012. Getting it right: better validation key to progress in biomedical computing. Biomed. Comput. Rev. 9–17. [Google Scholar]
- 18.Niederer SA, Fink M, Noble D, Smith NP. 2009. A meta-analysis of cardiac electrophysiology computational models. Exp. Physiol. 94, 486–495. (doi:10.1113/expphysiol.2008.044610) [DOI] [PubMed] [Google Scholar]
- 19.Oberkampf WL, Trucano TG. 2002. Verification and validation in computational fluid dynamics. Prog. Aerosp. Sci. 38, 209–272. (doi:10.1016/S0376-0421(02)00005-2) [Google Scholar]
- 20.Sood A, Forster RA, Kent Parsons D. 2003. Analytical benchmark test set for criticality code verification. Prog. Nucl. Energy 42, 55–106. (doi:10.1016/S0149-1970(02)00098-7) [Google Scholar]
- 21.Niederer SA. et al. 2011. Verification of cardiac tissue electrophysiology simulators using an n-version benchmark. Phil. Trans. R. Soc. A 369, 4331–4351. (doi:10.1098/rsta.2011.0139) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Pathmanathan P, Gray RA. 2014. Verification of computational models of cardiac electro-physiology. Int. J. Numer. Methods Biomed. Eng. 30, 525–544. (doi:10.1002/cnm.2615) [DOI] [PubMed] [Google Scholar]
- 23.Rivlin RS. 1948. Large elastic deformations of isotropic materials. III. Some simple problems in cylindrical polar co-ordinates. Phil. Trans. R. Soc. Lond. A 240, 509–525. (doi:10.1098/rsta.1948.0004) [Google Scholar]
- 24.STACOM. 2014. LV mechanics challenge. See http://www.cardiacatlas.org/web/stacom2014/lv-mechanics-challenge.
- 25.K. Inc. 2006. VTK user's guide version 5, 5th edn Clifton Park, NY: Kitware Inc. [Google Scholar]
- 26.Holzapfel GA. 2000. Nonlinear solid mechanics: a continuum approach for engineering. Chichester, UK: John Wiley & Sons. [Google Scholar]
- 27.Bonet J, Wood RD. 2008. Nonlinear continuum mechanics for finite element analysis, 2nd edn Cambridge, UK: Cambridge University Press. [Google Scholar]
- 28.Guccione JM, Costa KD, McCulloch AD. 1995. Finite element stress analysis of left ventricular mechanics in the beating dog heart. J. Biomech. 28, 1167–1177. (doi:10.1016/0021-9290(94)00174-3) [DOI] [PubMed] [Google Scholar]
- 29.Humphrey JD, Yin FCP. 1987. On constitutive relations and finite deformations of passive cardiac tissue. I. A pseudostrain-energy function. J. Biomech. Eng. 109, 298 (doi:10.1115/1.3138684) [DOI] [PubMed] [Google Scholar]
- 30.Costa KD, Hunter PJ, Wayne JS, Waldman LK, Guccione JM, McCulloch AD. 1996. A three-dimensional finite element method for large elastic deformations of ventricular myocardium. II. Prolate spheroidal coordinates. J. Biomech. Eng. 118, 464 (doi:10.1115/1.2796032) [DOI] [PubMed] [Google Scholar]
- 31.Legrice IJ, Hunter PJ, Smaill BH. 1997. Laminar structure of the heart: a mathematical model. Am. J. Physiol. Heart Circ. Physiol. 272, H2466–H2476. [DOI] [PubMed] [Google Scholar]
- 32.Costa KD, Holmes JW, McCulloch AD. 2001. Modelling cardiac mechanical properties in three dimensions. Phil. Trans. R. Soc. Lond. A 359, 1233–1250. (doi:10.1098/rsta.2001.0828) [Google Scholar]
- 33.Nash MP, Hunter PJ. 2000. Computational mechanics of the heart. J. Elast. 61, 113–141. (doi:10.1023/A:1011084330767) [Google Scholar]
- 34.Holzapfel GA, Ogden RW. 2009. Constitutive modelling of passive myocardium: a structurally based framework for material characterization. Phil. Trans. R. Soc. A 367, 3445–3475. (doi:10.1098/rsta.2009.0091) [DOI] [PubMed] [Google Scholar]
- 35.Anderson RH, Smerup M, Sanchez-Quintana D, Loukas M, Lunkenheimer PP. 2009. The three-dimensional arrangement of the myocytes in the ventricular walls. Clin. Anat. 22, 64–76. (doi:10.1002/ca.20645). [DOI] [PubMed] [Google Scholar]
- 36.Healy LJ, Jiang Y, Hsu EW. 2011. Quantitative comparison of myocardial fiber structure between mice, rabbit, and sheep using diffusion tensor cardiovascular magnetic resonance. J. Cardiovasc. Magn. Reson. 13, 74 (doi:10.1186/1532-429X-13-74) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Augustin CM, Neic A, Liebmann M, Prassl AJ, Niederer SA, Haase G, Plank G. 2016. Anatomically accurate high resolution modeling of human whole heart electromechanics: a strongly scalable algebraic multigrid solver method for nonlinear deformation. J. Comput. Phys. 305, 622–646. (doi:10.1016/j.jcp.2015.10.045) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38.Land S, Niederer SA, Smith NP. 2012. Efficient computational methods for strongly coupled cardiac electromechanics. IEEE Trans. Biomed. Eng. 59, 1219–1228. (doi:10.1109/TBME.2011.2112359) [DOI] [PubMed] [Google Scholar]
- 39.Land S, Niederer SA, Lamata P, Smith NP. 2015. Improving the stability of cardiac mechanical simulations. IEEE Trans. Biomed. Eng. 62, 939–947. (doi:10.1109/TBME.2014.2373399) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40.Gao H, Wang H, Berry C, Luo X, Griffith BE. 2014. Quasi-static image-based immersed boundary-finite element model of left ventricle under diastolic loading. Int. J. Numer. Methods Biomed. Eng. 30, 1199–1222. (doi:10.1002/cnm.2652) [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Malossi ACI, Bonnemain J. 2013. Numerical comparison and calibration of geometrical multiscale models for the simulation of arterial flows. Cardiovasc. Eng. Technol. 4, 440–463. (doi:10.1007/s13239-013-0151-9) [Google Scholar]
- 42.Rossi S, Lassila T, Ruiz-Baier R, Sequeira A, Quarteroni A. 2014. Thermodynamically consistent orthotropic activation model capturing ventricular systolic wall thickening in cardiac electromechanics. Eur. J. Mech. A, Solids 48, 129–142. (doi:10.1016/j.euromechsol.2013.10.009) [Google Scholar]
- 43.Gaston D, Newman C, Hansen G, Lebrun-Grandié D. 2009. MOOSE: a parallel computational framework for coupled systems of nonlinear equations. Nucl. Eng. Des. 239, 1768–1778. (doi:10.1016/j.nucengdes.2009.05.021) [Google Scholar]
- 44.Logg A, Mardal K-A, Wells G (eds).. 2012. Automated solution of differential equations by the finite element method: the FEniCS book. New York, NY: Springer. [Google Scholar]
- 45.Pezzuto S, Ambrosi D. 2014. An orthotropic active–strain model for the myocardium mechanics and its numerical approximation. Eur. J. Mech. A, Solids 48, 83–96. (doi:10.1016/j.euromechsol.2014.03.006) [Google Scholar]
- 46.Simo JC, Taylor RL. 1991. Quasi-incompressible finite elasticity in principal stretches. Continuum basis and numerical algorithms. Comput. Methods Appl. Mech. Eng. 85, 273–310. (doi:10.1016/0045-7825(91)90100-K) [Google Scholar]
- 47.Ogden RW. 2003. Nonlinear elasticity, anisotropy, material stability and residual stresses in soft tissue. In Biomechanics of soft tissue in cardiovascular systems (eds GA Holzapfel and RW Ogden). International Centre for Mechanical Sciences 441, pp. 65–108. Vienna, Austria: Springer.
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Data Availability Statement
All submitted solutions are available on the repository http://www.bitbucket.org/sander314/mechbench.