Nothing Special   »   [go: up one dir, main page]

Skip to main content
NIHPA Author Manuscripts logoLink to NIHPA Author Manuscripts
. Author manuscript; available in PMC: 2024 Jan 3.
Published in final edited form as: IEEE Trans Med Imaging. 2024 Jan 2;43(1):203–215. doi: 10.1109/TMI.2023.3294128

Patient-specific Heart Geometry Modeling for Solid Biomechanics using Deep Learning

Daniel H Pak 1, Minliang Liu 2, Theodore Kim 3, Liang Liang 4, Andres Caballero 5, John Onofrey 6, Shawn S Ahn 7, Yilin Xu 8, Raymond McKay 9, Wei Sun 10, Rudolph Gleason 11, James S Duncan 12
PMCID: PMC10764002  NIHMSID: NIHMS1933560  PMID: 37432807

Abstract

Automated volumetric meshing of patient-specific heart geometry can help expedite various biomechanics studies, such as post-intervention stress estimation. Prior meshing techniques often neglect important modeling characteristics for successful downstream analyses, especially for thin structures like the valve leaflets. In this work, we present DeepCarve (Deep Cardiac Volumetric Mesh): a novel deformation-based deep learning method that automatically generates patient-specific volumetric meshes with high spatial accuracy and element quality. The main novelty in our method is the use of minimally sufficient surface mesh labels for precise spatial accuracy and the simultaneous optimization of isotropic and anisotropic deformation energies for volumetric mesh quality. Mesh generation takes only 0.13 seconds/scan during inference, and each mesh can be directly used for finite element analyses without any manual post-processing. Calcification meshes can also be subsequently incorporated for increased simulation accuracy. Numerous stent deployment simulations validate the viability of our approach for large-batch analyses. Our code is available at https://github.com/danpak94/Deep-Cardiac-Volumetric-Mesh.

Keywords: shape modeling, deep learning, deformation energies, finite element analysis, TAVR

I. Introduction

AORTIC stenosis (AS) is one of the most common valvular heart diseases that affects up to 1.5 million patients in the U.S. [1]. Transcatheter Aortic Valve Replacement (TAVR) is an emerging treatment option that replaces the diseased native valve with a prosthetic device. TAVR is now the standard-of-care treatment for inoperable severe AS [2] and has recently been approved for all risk-level patients [3], [4]. In 2019, TAVR has been performed more often than surgical aortic valve replacement in the U.S., estimated at ~73,000 vs. ~57,000 procedures per year [5].

As standard practice for TAVR planning, interventional cardiologists often collect pre-operative 3D cardiac computed tomography angiography (CT) scans to assess the patient geometry [6], [7]. To better utilize these images, studies have extracted anatomical structures and used finite element (FE) analyses to simulate the biomechanical interactions between the individual patients’ hearts and valve prostheses [8]. Using the stress/strain output, studies have accurately predicted patient outcome and helped devise better treatment strategies [9], [10].

Despite their strengths, FE methods are severely limited by the delineation process of patient-specific geometry. Manual delineation from 3D medical images is extremely laborious and error-prone, and can take several hours per scan for a trained expert. Crowdsourcing the task is also difficult; in addition to patient privacy issues, the labeling process spans multiple expert domains including human anatomy, complex image and mesh processing techniques, and FE meshing requirements. Therefore, it is currently infeasible to apply the developed computational tools for large-scale population analyses or clinical use.

Automated meshing techniques have been widely explored within the medical imaging context (Section III). However, most methods were not designed to effectively handle downstream tasks such as large-batch solid mechanics simulations. In this study, we propose a novel deformation-based deep learning approach that can obtain patient-specific heart geometries from pre-operative 3D CT scans, where the outputs can be directly used for large-batch solid biomechanics simulations without any manual post-processing (Fig. 1). Our method, dubbed DeepCarve (Deep Cardiac Volumetric Mesh), takes only ~ 0.13 seconds to generate each patient-specific mesh via a single neural network forward-pass on a NVIDIA GPU GTX1080Ti.

Fig. 1.

Fig. 1.

We propose a method that automatically generates patient-specific heart geometries that are directly usable for biomechanical simulations. Top: the image analysis pipeline from a 3D CT to the final simulation-ready mesh. Bottom: a stent deployment simulation and the resulting stress distribution around the aortic valve leaflets. More details on both processes can be found in later figures.

A preliminary version of our work was presented at MIC-CAI 2021 [11]. The extensions for this work include: (1) methodological improvements to allow for a single template prediction instead of a double template approach, (2) significant expansion of modeled anatomical structures, (3) incorporation of stitched calcification meshes, and (4) more comprehensive simulations and method analyses. The reduction to a single template significantly increases the applicability of our method, and all other extensions were crucial for accurate geometry modeling and better clinical utility. In this work, we focused on demonstrating the usage of our automatically generated meshes for assessing the TAVR procedure.

II. Background and Design Considerations

Four main types of patient geometry representations will be referenced throughout this paper: voxel-grid segmentation, pointcloud, surface mesh, and volumetric mesh (Fig. 2).

Fig. 2.

Fig. 2.

The aortic valve commissural plane view of the LV myocardium (red), aorta (blue), and 3 aortic valve leaflets (green, orange, purple). The 4 different geometrical representations show clear differences in spatial resolution and modeling capabilities. We are able to obtain patient-specific volumetric meshes from base surface mesh labels using on-surface pointclouds for correspondence-agnostic surface matching.

A voxel-grid segmentation is a grid of class occupancy values. It often provides a good estimate of patient geometry, but it has limited spatial resolution and is not directly usable for biomechanical simulations. Following the medical imaging field’s convention, we will use “segmentation” to refer exclusively to voxel-grid segmentation, not the final mesh.

A pointcloud is a collection of nodes, which can theoretically be of infinite spatial resolution, but again is not directly usable for biomechanical simulations. Instead, pointclouds are useful for calculating the average surface error metrics between meshes with no mesh correspondence.

A mesh is a graph with nodes and edges. A surface mesh denotes only the surface of an object using 2D elements (e.g. triangle, quadrilateral, etc.), whereas a volumetric mesh uses 3D elements (e.g. tetrahedral, hexahedral, etc.) to additionally denote the inner volume of an object. A volumetric mesh is highly desired for several classes of biomechanical simulations to enable calculations throughout the discretized inner volume, and previous studies have often employed volumetric meshes to simulate the mechanics of the aortic valve [12], [13]. Although others have also proposed representing the valve leaflets as surface meshes due to their thin structure [9], this can limit accurate geometry modeling for leaflet thickness and calcification positioning, as well as quantification of clinically-relevant metrics such as paravalvular gap. Volumetric meshes can also allow for more accurate quantification of through-thickness distribution of stress/strain. Therefore, we focused on generating patient-specific volumetric meshes.

For successful application to downstream tasks, there are additional desirable properties for the final mesh. First, mesh correspondence between predicted meshes is desirable because it enables large-scale FE analyses by allowing us to simply replace the node coordinates from one simulation file to another. Mesh correspondence also enables intuitive node-based statistical shape modeling. Second, stitched nodes between different mesh components provides better simulation stability than surface-based constraints.

In summary, the main considerations for our final patient geometry are:

  1. volumetric mesh representation

  2. mesh correspondence

  3. stitched nodes between different mesh components

III. Related Works

A common meshing workflow in medical imaging is to first segment the image and use the resulting segmentation to perform downstream meshing tasks [14]. The main drawback of this approach is that most segmentation-based meshing techniques do not allow for control over the mesh topology, which leads to difficulties in achieving mesh correspondence for the final predicted geometries [15]. Instead of directly generating the mesh from segmentation, another common approach is to utilize deformable shape modeling, where a template mesh is deformed to reflect the geometries in the target image [16]. This approach can easily satisfy all of our design criteria given the right template, and will thus be the focus for the rest of the paper.

For all deformable shape modeling methods, the final goal is to obtain an optimal set of displacement vectors for the nodes on the template mesh. The process of finding those vectors can be formulated using various levels of supervision, displacement types, and amortized optimization.

Using no supervision, this problem can be posed as an image registration task, where a source image-mesh pair is deformed using a source-to-target image registration field to generate the target mesh [17], [18]. For images with clear intensity boundaries, hand-crafted image features have also been used to fit the template mesh [19], [20]. However, for complex geometries with small structures of interest (e.g. valve leaflets) and sporadic intensity changes (e.g. calcification), intensity-based registration techniques alone often fail to deliver satisfactory results [11].

As such, studies have proposed using landmarks or segmentation as supervision to parametrically generate valve shapes [21] or apply shape-based and point-based registration techniques [20], [22]. The main weakness of these approaches is their inherent limited usability by non-experts at test time due to the need for manual labels. To circumvent this issue in a similar framework, studies have used predicted segmentation as the estimated supervision for deformable modeling [23]. Recent deep learning-based valve segmentation methods [24], [25] may also be used for increased segmentation accuracy. However, the sequential segmentation-to-registration approach leads to suboptimal performance, as shown later in our results.

Another class of valve modeling approaches broadly entails two sequential steps: (1) rough global pose estimation and (2) surface refinement. Ionasec et al. [26] used handcrafted image features and probabilistic boosting trees to automatically detect landmarks to first align the template mesh, and subsequently used detected boundaries to fine-tune the leaflet curvatures. Others have used dictionary learning [27] or marginal space deep learning [28] for landmark detection and fine-tuned the mesh alignment in the surface-normal directions. For downstream tasks, the predicted surface meshes were often converted to volumetric meshes via simple offsetting operations [27], [29]. Although offsetting may be suitable in certain applications, it has the potential to quickly become ill-defined for complex multi-part geometry that requires node-stitching. Also, hand-crafted features and the sequential modeling approach are both very dependent on the imaging modality and the structures of interest. Our approach is able to learn the image features for an end-to-end image-to-mesh optimization.

Deep learning has also gained much interest as a tool for fast meshing from imaging data. Dalca et al. [30] proposed training neural networks to either perform unsupervised registration or semi-supervised registration + segmentation to generate a deformation field that fits a template mesh to target images. Lee et al. [31] proposed a similar approach that learns a segmentation-deforming b-spline field. Studies have also expanded upon the Wang et al.’s approach [32] and combined convolutional neural network (CNN)-extracted image features with graph convolutional networks (GCN) to predict node-specific displacements for the template mesh [33], [34]. More recently, [35] used a similar CNN-GCN approach on control handles for improved cardiac surface meshing.

However, all of these methods have only considered (1) surface meshes and (2) meshes with a closed-surface topology, and are generally not suitable for generating volumetric meshes for thin structures like the valve leaflets. Our baseline comparisons also suggest that incorporating GCNs for node-specific displacement predictions is not necessary and may even lead to suboptimal results for volumetric meshing.

In summary, our approach provides improved accuracy and speed compared to past aortic valve modeling approaches. Compared to other deep learning-based meshing approaches, ours specifically focuses on using limited labels to generate patient-specific volumetric meshes that are directly usable for solid biomechanics simulations. Our work also tackles a more complex geometry involving the aortic valve leaflets, which introduces significantly different modeling challenges.

IV. Methods

A. Problem Formulation

Let M=(V,E) be a target mesh M with vertices V and edges E. Here, VNV×3 and ENE×(2+1), where ℝ is real numbers, ℕ is natural numbers, NV is the number of vertices, and NE is the number of edges. Each entry of V is a vertex in 3D space. Each entry of E is (1) a pair of vertex indices that indicates a connection between those two vertices and (2) a mesh component index that indicates the edge belonging to a specific component of M. For our task, we defined 5 mesh components: the left ventricular (LV) myocardium, the aortic wall of the ascending aorta, and the three aortic valve leaflets. This allowed us to design more component-specific losses and adjust various hyperparameters to fit our modeling needs.

The goal of template deformation strategies is to find the optimal displacement vectors at every vertex of a template mesh M0=(V0,E0). Here, V0NV0×3 and E0NE0×(2+1). Given a set of displacement vectors δNV0×3, the predicted vertices V¯ are simply V¯=V0+δ. We also use an alternative notation for vertex displacement V¯=δ(V0), and further extend the notation for the predicted mesh M¯=δ(M0) because E0 is identical before and after deformation.

“Optimal” deformation is defined by a loss function , which in our task takes input parameters M, M0, and δ:

δ*=arg minδ(M,M0,δ) (1)

·* denotes the final optimized values. The exact details of will be further explained in later subsections. Assuming we have a proper , Eq. 1 can be used to optimize the deformation for each patient mesh separately. However, that would complicate the meshing task during inference time due to the need for the ground-truth mesh label M and the need to perform the optimization for each new set of geometries.

In this work, we instead used a neural network hθ as a function approximator that generates the displacements with a single forward pass with the input image (hθ(I;M0)=δ). Here, IH×W×D is the input image of height H, width W, and depth D, and θ is the network parameters. Then, our problem boils down to optimizing θ with respect to the expected loss over our paired image-mesh training set Ω:

θ*=arg minθ[𝔼(I,M)Ω[(M,M0,hθ(I;M0))]] (2)

The overall training process is summarized in Fig. 3. After the model hθ has been successfully trained, each test set image can be processed via a single forward pass to obtain δ, from which δ(M0) is the final predicted patient-specific mesh with mesh correspondence.

Fig. 3.

Fig. 3.

A high-level overview of DeepCarve. Pointcloud labels are used to accurately align the base surfaces of the predicted geometry, and a combination of isotropic and anisotropic energies are used to preserve the volumetric mesh quality after template deformation.

B. Space-deforming Field via CNN

Broadly, there are two approaches for mesh deformation: (1) directly predicting node-specific displacement vectors, or (2) implicitly deforming the embedded object using a space-deforming field [36]. Within our problem formulation, this mainly affects our design choices for hθ. Our final proposed model predicts a regular-grid space-deforming field ϕH×W×D×3, from which we can trilinearly interpolate at V0 to obtain δ.

Following existing works [15], [37], we modeled hθ as a 3D CNN, in the form of a modified U-net. The input was a 3D image, and the output was a set of control point displacements at specified isotropic intervals of the original image coordinates. The control point displacements were used to fill in the rest of the image coordinates using a 3rd order b-spline interpolation, which was approximated using iterative mean-filtering [38]. The resulting output was then treated as a stationary vector field of the final diffeormorphic flow, estimated using the scaling-and-squaring method [38], [39].

There are two main advantages to this approach. First, by predicting uniformly spaced displacements using a 3D voxel-grid input, we can leverage robust 3D CNN architectures without any major modifications. In contrast, directly predicting node-displacement vectors has generally involved geometric deep learning, which requires more complex network modifications and additional model parameters [33], [34]. Second and more importantly, we are able to control the field smoothness using the control point spacing instead of explicitly increasing the weighting on the field regularization terms. This exact mechanism helped significantly improve our mesh quality while maintaining spatial accuracy (Section V-E).

C. Loss Functions for Label-efficient Volumetric Meshing

Our proposed loss is a linear combination of an accuracy term acc and a volumetric mesh quality term mesh:

(M,M0,δ)=acc(P(M),P(δ(M˜0)))+mesh(δ(M0)) (3)

P(M) denotes randomly sampled points on the surface of M [40], and M˜0 is a partial mesh of the template mesh M0 that spatially matches the provided mesh labels. To better explain M˜0 and M, we first discuss acc, which is defined as the mean symmetric Chamfer distances averaged across all mesh components:

acc(P(M),P(δ(M˜0)))=1Ci=1Cch(P(mi),P(δ(m˜i,0))) (4)
ch(A;B)=1|A|aAminbBab22+1|B|bBminaAba22 (5)

In Eq. 4, mi and m˜i,0 denote the ith mesh component for M and M˜0, respectively. C is the total number of components. In Eq. 5, A and B are arbitrary pointclouds with potentially different numbers of sampled points. In our task, we set the number of samples to be [150K, 40K, 3K, 3K, 3K] for [LV, aorta, leaflet1, leaflet2, leaflet3], which is roughly 15 points/mm2 * SurfaceArea(mi). We used the same number of samples between the target and predicted pointclouds.

To mitigate the difficulty of obtaining training labels, we aimed to reduce the dependency of our model to volumetric mesh labels by using minimally sufficient surface labels for M. The selection criteria of minimal sufficiency depends on each mesh component’s unique structural characteristics. Thus, the definition of mi and the associated m˜i,0 is different for each mesh component. The rationale and selection process for each mesh component is described below.

For the leaflets, segmentation alone is often not spatially accurate enough due to the limitations in the label resolution and quality. This was confirmed in our own experiments, where methods using only segmentation labels often suffered from poor spatial accuracy of the leaflets. (Table I). Additionally, the native leaflet thickness information is often obscured in CTA scans due to the high levels of calcification and limited image resolution. From these observations, we wanted leaflet labels that (1) use a node-based representation and (2) delineate the overall leaflet positioning and curvature instead of the leaflet volume. Based on these criteria, we chose the “base surface” representation from Fig. 2 because it was the simplest label to obtain that satisfies both of our constraints.

TABLE I.

Surface accuracy and volumetric mesh quality for the aortic wall and leaflet elements

CD (mm) HD (mm) Corr (mm) Thick diff (mm) | Jac | ≤ 0 1 – | Jac | Skew
Traditional: seg → reg 1.352 ± 0.303 7.078 ± 2.484 3.886 ± 1.242 0.207 ± 0.052 0 0.183 ± 0.039 0.429 ± 0.051
Traditional: warp seg 1.525 ± 0.627 5.323 ± 1.492 2.433 ± 0.607 0.261 ± 0.081 0 0.137 ± 0.030 0.362 ± 0.045

CNN-GCN: surf geo 1.159 ± 0.404 5.405 ± 1.398 2.765 ± 0.628 0.460 ± 0.046 109934 0.604 ± 0.101 0.596 ± 0.047
CNN-GCN: ARAP only 1.095 ± 0.381 4.762 ± 1.264 2.568 ± 0.591 0.121 ± 0.021 419 0.118 ± 0.023 0.285 ± 0.027
CNN-GCN: ARAP & ASqrt 1.121 ± 0.355 4.877 ± 1.415 2.533 ± 0.642 0.068 ± 0.013 210 0.114 ± 0.020 0.282 ± 0.025

CNN: surf geo 0.862 ± 0.367 5.011 ± 1.529 4.343 ± 0.734 1.054 ± 0.041 127452 0.786 ± 0.072 0.812 ± 0.037
CNN: smooth field 1.167 ± 0.410 4.713 ± 1.333 2.302 ± 0.519 0.216 ± 0.064 0 0.119 ± 0.029 0.332 ± 0.044
CNN: ARAP only 0.877 ± 0.315 4.521 ± 1.392 2.410 ± 0.538 0.122 ± 0.021 0 0.106 ± 0.018 0.280 ± 0.029
CNN: double-template 0.860 ± 0.282 4.416 ± 1.388 2.420 ± 0.543 0.117 ± 0.021 0 0.110 ± 0.015 0.278 ± 0.023

DeepCarve: half img res 0.950 ± 0.370 4.903 ± 1.707 2.771 ± 0.833 0.084 ± 0.015 0 0.105 ± 0.013 0.284 ± 0.023
DeepCarve (Ours) 0.835 ± 0.333 * 4.267 ± 1.390 * 2.342 ± 0.572 0.067 ± 0.013 * 0 0.101 ± 0.014 * 0.268 ± 0.024 *

CD: mean symmetric Chamfer distance, HD: Hausdorff distance, Corr: landmark correspondence error, Thick diff: thickness difference of hexahedra after deformation, | Jac |: scaled Jacobian determinant, mm: millimeter.

For | Jac |≤ 0, the values were summed across both mesh components and patients. For all other metrics, the values were first averaged across the mesh components, and then the mean and standard deviation were calculated across patients (mean ± std).

*:

p < 0.05 between the best and second-best performing single-template methods.

†:

p < 0.05 between DeepCarve and CNN: double-template.

For the aorta, segmentation labels can still be problematic. First, CTA scans only allow for good segmentation of the blood pool, which only delineates the inner surface of the aortic wall, not the aortic wall volume. Second, the 0-genus ellipsoidal blood pool segmentation cannot be directly compared against the desired 1-genus tube-like mesh. Therefore, we also chose the “base surface” representation as our minimally sufficient surface label for the aorta.

For the LV myocardium, where the muscle mass is clearly visible in the CTA and is thick enough to be labeled accurately via conventional segmentation methods, the surface label is simply the marching cubes of the segmentation label.

After deciding on our minimally sufficient label representation, we can select parts of M0 that spatially correspond to those labels. For the leaflets and the aorta, this is the “base surface” (Fig. 2), or the quadrilateral surface elements comprised of the bottom 4 nodes of each hex element (Fig. 4). For the LV myocardium, this is the extracted outer surface of the original volume elements. Note that M and M0 do not need mesh correspondence because we used the sampled points for measuring surface accuracy.

Fig. 4.

Fig. 4.

Graphic illustration of the anisotropic energy direction d (black arrow) and the nodes used to calculate d for the selected hex elements. Refer to Fig. 7, 8, 9 for the overall layout of elements.

While the use of surface labels greatly increases the flexibility of our method, it also fails to capture important mesh constraints, such as (1) the element thickness for the leaflets and the aortic wall and (2) the positioning of the inner volume elements for the LV myocardium. This leads to suboptimal performance of existing methods for our task (Table I). To address this, we directly incorporated a volumetric mesh quality term to minimize undue deformation from the initial mesh template.

The key starting ingredient for calculating various deformation energies is the deformation gradient F3×3 [41]:

F=DsDm1Ds=[x1x0|x2x0|x3x0]Dm=[x¯1x¯0|x¯2x¯0|x¯3x¯0] (6)

where x¯i and xi=δi(x¯i) are the original and transformed node coordinates, respectively, of each tetrahedral element. Note that the computation of F for hexahedral elements requires the use of quadrature points, but we achieved similar performance by simply splitting all elements into tetrahedra via triangulation and applying Eq. 6.

Using F, we can calculate various isotropic and anisotropic energies to measure the amount of element distortion in the specified directions. For overall isotropic element stiffness, we used the as-rigid-as-possible (ARAP) energy, where the energy density for each element is defined as:

ΨARAP(i)=FRF2=R(SI)F2=(SI)F2 (7)

Here, I is the identity matrix, F is the Frobenius norm, and R and S are the rotation and stretch components of F obtained via polar decomposition F = RS. More precisely, F=UΣVT via singular value decomposition, from which R=UVT and S=VΣVT. The first two equalities of Eq. 7 are from the definitions of ARAP energy and polar decomposition, and the last equality is from the rotational invariance of the Frobenius norm.

To ensure end-to-end differentiability, F needs to be full rank (i.e. no degenerate elements) and Σ needs to have distinct singular values (i.e. FI). In our experiments, both conditions were satisfied as long as we initialized the network output with uniformly sampled values within [−1e-3, 1e-3].

While the sole addition of isotropic energy showed some promise in a previous study [11], the prediction quality was hindered by the trade-off between surface accuracy and element quality due to the over-stiffening effect. Since this effect was observed most prominently for the leaflets, where the element conformation can vary significantly based on the degree of valve opening, the previously proposed solution was to use two mesh templates in open vs. closed valve states and measure the distance-based weighted average of the isotropic distortion energies from the two templates.

In this study, we instead incorporated an anisotropic energy term to maintain the desired overall mesh quality while applying less penalization of the isotropic energy. This allowed for greater flexibility of the leaflet and aortic wall elements, which lead to increased spatial accuracy of the predicted meshes for the desired level of mesh quality, while using a single template.

The anisotropic energy we used was a slight variation of the anisotropic St. Venant Kirchhoff (AStVK) energy, dubbed anisotropic square root (ASqrt) [41]. The energy density for each element is:

ΨASqrt(i)=(dTFTFd1)2 (8)

where d3 is the normalized direction vector for measuring the anisotropic energy. In our task, d was calculated for each leaflet and aortic wall element independently in the thickness direction using the template mesh. More precisely, the 4 direction vectors going from the bottom 4 nodes to the corresponding top 4 nodes of each hex element were averaged and normalized (Fig. 4).

To combine these energy densities in a way that is minimally restrictive, we applied different weighting factors across the thick (LV myocardium) and thin (leaflet and aortic wall) elements:

mesh(M)=λ01Jj=1JΨARAP(j)+λ11Kk=1KΨARAP(k)+λ21Kk=1KΨASqrt(k) (9)

for J LV myocardium elements and K leaflet and aortic wall elements. This assumes equal weighting across all elements of the same class of structures, but different overall weighting across different classes. [λ0,λ1,λ2]=[5,1,10] for our proposed model. The final loss is now fully defined by combining Eq. 3, 4, and 9.

D. Calcification Modeling

Calcification (Ca2) is crucial for accurate structural modeling and stress simulations. In this work, we first used our proposed deep learning method to obtain the patient-specific heart geometry, and subsequently used traditional techniques to generate and stitch Ca2 meshes onto the predicted structure. A few reasons for the sequential process were: (1) deformation strategies are inadequate for Ca2 due to its arbitrary amount and positioning, (2) Ca2 can be easily segmented using traditional techniques, and (3) most Ca2 attachment points were spatially consistent with our accurately predicted heart structures.

The exact implementation of the Ca2 meshing process described below is available in our published code. However, it should be noted that the Ca2 meshing technique was not the focus of this work; we merely aimed to demonstrate that our heart geometry is accurate enough for reliable incorporation of calcification meshes. We will be investigating faster and more robust calcification meshing techniques in future works.

Ca2 was first segmented using a fixed-window intensity thresholding, where the thresholds were determined empirically for each patient to account for the contrast agent-induced intensity differences. The selected threshold was often around [590, upper limit] HU. The final segmentation was then produced by trimming the portions outside of the boundary of predicted geometries and removing small islands with fewer than 5 connected voxels.

To convert the Ca2 segmentation to stitched meshes, we performed a series of automated post-processing steps. First, we eliminated mesh collisions by subtracting the heart geometry from the Ca2 segmentation. Since mesh boolean operations are notoriously unreliable, we first voxelized the predicted heart mesh, performed the subtraction in the voxel space, and converted the resulting Ca2 segmentation back to surface meshes using isosurface extraction [42].

Then, we extended the Ca2’s attachment surfaces closer to the heart surface. To calculate the direction of extension, we first used surface-normal ray-tracing to determine the first non-self intersection of all heart surface nodes with both the heart and Ca2 meshes. Valid ray-tracings were selected based on distance thresholding ([0, 3] mm for heart-to-Ca2, and heart-to-Ca2 must be closer than heart-to-heart). For each Ca2 connected component, the final extension direction was calculated as the average direction of all valid ray-tracings. We selected Ca2 nodes based on the angular difference between their surface normals and the extension direction, and extended them slightly past the heart surface based on the ray-tracing distances. The extended meshes were morphologically closed and subtracted in voxel space as described in the previous paragraph to prevent mesh collisions. We performed re-meshing via voronoi clustering to uniformly space the Ca2 nodes, and merged the surface-contacting Ca2 nodes onto the closest neighboring heart surface nodes. Surface contact was defined as nodes closer than 0.3 mm. After a few smoothing and mesh cleaning operations, such as removing non-stitched Ca2 meshes, we used TetGen [43] to generate the final Ca2 tetrahedra.

V. Experiments and Results

A. Data Acquisition and Preprocessing

1). Images:

We used an anonymized dataset of 80 standard cardiac CTA scans from 69 patients. Of the 80 total scans, 66 were pre-operative scans from IRB-approved TAVR patients at Hartford hospital. The remaining 14 were from the training set of the MM-WHS public dataset [44], which consisted of routine scans from healthy subjects. Scans were selected from random phases of the cardiac cycle to include various degrees of valve opening. We included more than one phase for some of the Hartford patients’ scans. The field-of-view typically spanned from the apex of the heart to the ascending aorta. The scans had a wide range of calcification and LV muscle volume (Fig. 5). All scans had tricuspid aortic valves.

Fig. 5.

Fig. 5.

Histogram of all patients’ labeled segmentation volumes for the calcification and the LV myocardium. The wide range in both metrics partially demonstrate the high diversity of our image data.

The splits for training, validation, and testing were 35, 10, 35 scans, respectively. We ensured that the testing set had no overlapping patients with the training/validation sets, which means that we randomly shuffled our splits until we only had the single-phase patients’ scans in the testing set. We preprocessed all scans by thresholding the Hounsefield Units with identical upper/lower bounds [−158, 864] across all patients and renormalizing to [0, 1]. The raw images’ in-plane pixel spacing ranged from 0.281 to 0.727 mm, with a median of 0.488m. The slice thickness ranged from 0.450 to 1.000 mm, with a median of 0.625 mm. Slices were acquired in the axial view. We resampled all images to a coarser-than-original isotropic spatial resolution of 1.25 mm3, and cropped them at the center of the labeled geometries, resulting in final images with [128, 128, 128] voxels. Note that the images were not pre-aligned with any additional transforms.

2). Surface labels:

We focused on a total of 5 main components: the upper half of the LV myocardium, the aortic wall of the aortic root and the ascending aorta, and the 3 aortic valve leaflets. For the LV, we obtained the ground truth surface label by first manually segmenting the LV and then applying marching cubes on the segmentation. Similarly for the ascending aorta, we used manual segmentation followed by marching cubes, but with one additional step of slicing open the top and bottom to create an open cylindrical surface. For the 3 leaflets, we used a semi-automated process [27], which included manual annotation of the component boundaries and points on the surface.

3). Landmark labels for correspondence accuracy:

We defined 9 important aortic valve landmarks: 3 commissures, 3 hinges, and 3 leaflet tips. Commissures were defined as the intersecting upper corners of the three leaflets. Hinges were defined as the midpoints of the leaflet attachment curves to the aorta. Leaflet tips were defined as the midpoints of the leaflet free edges (Fig. 6).

Fig. 6.

Fig. 6.

Graphic illustration of the landmarks used for evaluation.

4). Mesh template:

We created a mesh template for a half-open valve using the representative anatomical parameters in [45]. We used Solidworks and Hypermesh for surface modeling and meshing, respectively. The template has a total of 145,528 nodes. The LV component has 565,093 tetrahedra, 19,390 pyramids, and 396 hexahedra. The aorta has 11,298 hexahedra, each leaflet has 1,440 hexahedra. The template also includes a mitral annulus cover, composed of 1,612 hexahedra, to represent a simplified closed mitral valve.

B. Baseline experiments

For baseline experiments, we implemented various combinations of existing approaches from Section III.

1). Traditional methods:

For the “seg → reg” experiment, we first trained a standard multilabel segmentation network using a paired image-segmentation dataset and the same U-net architecture as our model with a modified final output layer. At test time, we used the predicted segmentation to perform shape-based registration using robust point matching [46].

For the “warp seg” experiment, we trained a deformation network, identical to our proposed model, that instead warps a segmentation template to match to segmentation labels. Following previous works [30], [31], we regularized the field using the bending energy field smoothness term, which penalizes non-affine transformations.

2). CNN-GCN hybrid model:

We tested a hybrid CNN-GCN model that predicts a displacement vector at each node, similar to previous deep learning-based surface meshing approaches [32], [33]. The CNN-GCN is described in more detail in Section V-C.

3). Displacement regularization techniques:

Following previous studies, we explored 3 different types of displacement regularization techniques: (1) surface geometric constraints, (2) field smoothness, and (3) isotropic energy (ARAP) only. For surface geometric constraints, we used the popular combination of surface normal consistency, Laplacian smoothness, and edge losses [15], [32]. For field smoothness, we used the bending energy term [30], [31]. For the isotropic-energy-only condition, we simply set λ2=0 in Eq. 9.

Note that the “CNN-GCN: ARAP only” and “CNN:ARAP only” conditions are essentially the single-template version of our MICCAI work with minor adjustments, such as the template valve shape, range of structures, and image preprocessing technique. For completeness, we have also included the double-template version of our MICCAI work with similar modifications, but with the open and closed valve templates instead of the half-open valve template.

C. Implementation Details

We used Pytorch ver. 1.13.1 [47] to implement a variation of a 3D U-net for our CNN [48], and Pytorch3d ver. 0.7.3 [40] to implement the GCN. The basic Conv unit was Conv3D-InstanceNorm-LeakyReLu, and the network had 4 encoding layers of ConvStride2-Conv with residual connections and dropout, and 4 decoding layers of Concatenation-Conv-Conv-Upsampling-Conv. The base number of filters was 16, and was doubled at each encoding layer and halved at each decoding layer. The GCN had 3 layers of graph convolution operations defined as ReLU(w0Tfi+j𝒩(i)w1Tfj) and a last layer without ReLU. The input to the initial GCN layer was the concatenation of vertex positions and point-sampled features from the last 3 U-net decoding layers. The GCN feature sizes were 227 for input, 128 for hidden, and 3 for output layers. We found λi for every experiment with a grid search based on validation error, ranging 7 orders of magnitude. We used the Adam optimizer [49] with a fixed learning rate of 1e-4, batch size of 1, and 4000 training epochs. The models were trained with a B-spline deformation augmentation step, resulting in 140k total training samples (35 · 4000). All operations were performed on a single NVIDIA GTX 1080 Ti, with around ~2 days of training time and maximum GPU memory usage of ~6.5 GB. Inference takes 0.13 seconds/scan on the same GPU.

D. Spatial Accuracy and Volumetric Mesh Quality

For spatial accuracy, we computed the mean surface distance (CD), the worst-case surface distance (HD), and landmark correspondence error using the Euclidean distance of specific mesh nodes from 3 commissures, 3 hinges, and 3 leaflet tips (Corr). For volumetric mesh quality, we first evaluated two standard FE mesh metrics: |Jac| and skew [42], [50]. Then, since zero-volume elements and element inversions break FE simulations, we counted their number of occurrences using |Jac| ≤ 0 across all test-set patients. As one measure of deviation from the representative anatomical parameters, we also calculated the magnitude of thickness differences for the thin elements post-deformation (Thick diff). Refer to Table. I for abbreviations.

Our method outperformed all existing methods in every category except landmark correspondence error, where it came in second (Table I, II). It also outperformed the previous state-of-the-art ARAP-only condition in every category, demonstrating its superiority in the single-template deformation task.

TABLE II.

Surface accuracy and volumetric mesh quality for the LV myocardium elements

CD (mm) 1– |Jac| |Jac|≤ 0
CNN: smooth field 2.053 ± 0.442 0.472 ± 0.019 0
CNN: ARAP only 1.673 ± 0.333 0.451 ± 0.011 1
DeepCarve (Ours) 1.616 ± 0.328* 0.449 ± 0.010 0

Symbols are defined in Table I.

Even compared against the double-template condition, our method had the best overall performance. This can be attributed to the fact that the distance-based deformation energy weighting strategy proposed in our MICCAI work is only truly effective when we have the input images aligned at the valve region. The image preprocessing for this work was a simpler and more realistic center crop with respect to the LV-aorta-valve complex, which does not necessarily guarantee valve alignment.

We also tested the viability of our approach for using half of the original image resolution, i.e. 2.5mm3 and 643 voxels. The method generally performed as expected, with similar element quality and slightly lower spatial accuracy compared to the main result.

DeepCarve’s stitched calcification meshes were evaluated for all test-set patients. We compared the initial calcification segmentation and the final stitched meshes. To convert between the two representations, we used isosurface extraction and voxelization [42]. Our calcification meshing technique maintained the spatial accuracy of the initial input segmentation and generated nice quality elements for simulations (Table III). For all patients, there were 0 elements with |Jac| ≤ 0.

TABLE III.

Spatial accuracy of and volumetric mesh quality of the final calcification mesh

DSC CD (mm) 1– |Jac|
DeepCarve (Ours) 0.790 ± 0.128 0.690 ± 0.994 0.394 ±0.026

DSC: Dice Similarity Coefficient.

Other symbols are defined in Table I.

Qualitatively, our model produced patient-specific meshes with great spatial accuracy (Fig. 7). Our approach also significantly reduced the amount of thickness alterations (Fig. 8) and adverse element distortions (Fig. 9) compared to the ARAP-only condition. The final mesh with stitched calcification elements also illustrate the high quality of our final simulation-ready geometry (Fig. 7). We were only able to show one test-set patient’s final mesh due to space constraints, but all other test-set predictions exhibited similar mesh quality for both the heart and stitched calcification elements.

Fig. 7.

Fig. 7.

(Top) 2D Visualization in 2 different viewing planes for 3 different test-set patients. Our method generates meshes with great spatial accuracy. (Bottom) 3D Visualization in 2 different camera positions for 1 test-set patient. Our method generates meshes with great mesh quality and can be accurately combined with segmented calcification.

Fig. 8.

Fig. 8.

Commissural plane view with Thick diff values. Both the overall heatmap and the zoomed-in visualization indicate much better consistency of element thickness for our method.

Fig. 9.

Fig. 9.

Leaflet view with 1 - |Jac| values. Qualitatively, our method generates leaflet elements with much better element quality for the same level of spatial accuracy.

E. Hyperparameter Trade-off Analysis

From Eq. 9, different values of hyperparameters λi can lead to vastly different meshes. For λi1, the predicted meshes would be nearly identical to the template mesh due to high deformation penalties, whereas for λi0, the predicted meshes would be unusable for downstream tasks due to poor mesh quality. This is true for the two top baselines as well, i.e. the smooth-field and ARAP-only conditions. We used the idea of Pareto front approximation sets from multiobjective optimization [51] to demonstrate the differences in the degree of this trade-off between the 3 top performing methods (Fig. 10).

Fig. 10.

Fig. 10.

2D visualization of the Pareto front approximation sets for the relevant experiments. The scatter plot values are test-set evaluation metrics on the aorta and leaflet elements. For each experiment denoted in its unique color, each scatter point represents a model trained with a different set of regularization weighting hyperparameters. Circles indicate models that produced ≤ 3 total bad elements across all test-set patients, and x’s are models that produced > 3 bad elements. Bad elements were defined as elements with | Jac |≤ 0, including the LV, aorta, and leaflet elements. Hypervolume boundaries were plotted using only the valid models, i.e. circles. σ is a unitless scaling factor: control point spacing = σ⋅image spacing.

The first observation for Fig. 10 is the effect of the b-spline control point spacing in the final mesh viability. Between σ=1 and σ=3, where σ is a unitless scaling factor (b-spline control point spacing=σ*image spacing), we can clearly see that only the σ=3 condition is able to generate valid models within the relevant range of λi. Although there is some observable difference in the lowest possible surface accuracy attainable by σ=3 presumably due to the coarser displacement calculations, this difference is minimal compared to the benefits of generating viable meshes. This phenomenon is further detailed in Table IV for 3 different values of σ across 2 top performing methods. Following these observations, we used σ=3 for all subsequent model training and analyses. As briefly mentioned in Section IV-B, this ability to improve field smoothness without additional explicit regularization losses is one of the main reasons why a space-deforming field is preferred over node-specific displacements.

TABLE IV.

B-spline control point spacing evaluations using all ELEMENTS (I.E. LV myocardium, aorta, and leaflets)

σ CD (mm) 1– |Jac| |Jac|≤ 0
CNN: smooth field 1 1.799 ± 0.347 0.467 ± 0.017 56
DeepCarve 1 1.413 ± 0.260* 0.444 ± 0.010* 43

CNN: smooth field 2 1.842 ± 0.380 0.462 ± 0.017 0
DeepCarve 2 1.444 ± 0.280* 0.443 ± 0.010* 12

CNN: smooth field 3 1.811 ± 0.376 0.465 ± 0.019 0
DeepCarve (Ours) 3 1.402 ± 0.272* 0.442 ± 0.010* 0

σ is a unitless scaling factor: control point spacing = σ⋅image spacing.

Other symbols are defined in Table I.

The second observation for Fig. 10 comes from the differences in hypervolume boundaries between the three σ=3 conditions. Since lower is better for all metrics, boundaries closer to the origin is better. Our method consistently outperformed the others for all metrics, where the improvement is especially large from the smooth-field condition. From the ARAP-only condition, there are consistent improvements throughout the metrics, and they especially stand out for the thickness difference vs. chamfer distance plot. This is especially beneficial for generating valid thin elements for the leaflets, where adjusting only the isotropic energy leads to over-stiffening and reduced spatial accuracy.

In terms of computational costs, the execution time for the most dense b-spline interpolation is in the order of milliseconds, so there is essentially no noticeable effect associated with different control point spacings. The diffeomorphic flow estimation also runs in the order of milliseconds, so it does not incur significant costs.

F. Post-TAVR Stress/Strain Analysis

To demonstrate the feasibility of our auto-generated meshes for biomechanical computations, we performed finite element analysis (FEA) to simulate the TAVR deployment procedure with Abaqus. We used a 26 mm, self-expandable, first-generation Medtronic CoreValve device, and selected 6 test-set patients that are suitable for this device based on each patient’s aortic valve annulus diameter and the manufacturer’s sizing recommendations [52]. We were not able to test all test-set patients due to our limited inventory of TAVR stent geometries. The superelastic Nitinol stent was modeled with a built-in material library in Abaqus [53]. Briefly, the TAVR simulations were performed in these three main steps:

  1. The TAV stent was aligned co-axially within the aortic root and centered into the aortic annulus. The stent was positioned such that the lowest point of the crimped stent is 5mm below the aortic annulus [52].

  2. The stent was then crimped with a cylindrical sheath to an exterior diameter of 6 mm [12].

  3. The crimped stent was released by axially moving the cylindrical sheath away from the aortic root. The tissue-device contact interaction was then enabled during this procedure, with the stent-to-tissue friction coefficient set to 0.1 [54]. The finite element nodes at the distal end of the aorta and bottom of the left ventricle were constrained, which allows radial expansion only.

The deployed configuration of the stent with a patient’s left heart model is shown in Fig. 1 11, 12. The maximum principal stress and the maximum principal logarithmic strain distributions are shown in Fig. 11, 12. The stress was 0.1~3 MPa, and strain on the aortic root was 0~0.4. The stress concentrations and the maximum strain and stress on the leaflets occurred near the calcification. These results are in line with previous studies [12], [13], which indicates that our auto-generated meshes produce accurate simulation results. The approximate run-time of each simulation was around 10 hours using 3 Dual Intel Xeon Gold 6226 CPUs @ 2.7 GHz (24 cores/node). In future work, we will implement an FEA input file generator to fully automate the simulations.

Fig. 11.

Fig. 11.

Post-TAVR strain distribution around the aortic root for the 6 test-set patients. Gray denotes the calcification and the stent.

Fig. 12.

Fig. 12.

Post-TAVR strain (top) and stress (bottom) distributions around the entire patient geometry (left) and the valve leaflets (right) for 1 test-set patient.

VI. Discussion

The traditional baseline methods exhibited the lowest spatial accuracy and element quality, most likely due to the low resolution of segmentation labels and the disconnect from the network-optimized task and the final meshing task. The CNN-GCN methods showed some improvements, but still exhibited lower spatial accuracy and much more frequent element distortions than the CNN methods. Element distortion may be attributed to the lack of field smoothing operations, but the inability to achieve high spatial accuracy, even with the increased displacement resolution, indicate model optimization issues caused by the addition of GCNs. Although various network modifications have been suggested to improve the CNN-GCN performance for surface meshing [33]–[35], we demonstrated here that a simple CNN implementation can achieve great performance for volumetric meshing when we properly constrain the predicted deformation field.

For the choice of deformation energies, our philosophy was to select the simplest solution that would accomplish our goal. Studies have proposed numerous isotropic energies (e.g. Dirichlet, Neo-Hookean, and co-rotational energies) and anisotropic energies (e.g. AStvk and Anisotropic ARAP) [41]. The isotropic ARAP energy was appealing for our task because (1) it is well-behaved (rotation-invariant, non-negative, no undesirable zero-energy deformation states), (2) it has reasonable quadratic scaling to F, and (3) it has no extra volume preservation terms to additionally restrict scaling to patient geometeries of varying sizes. The ASqrt energy is a standard anisotropic energy that is quadratic with respect to F. The main weakness of the ASqrt energy is its inability to penalize inverted elements, but we observed no issues related to element inversion, presumably due to the isotropic energy and the use of b-spine diffeomorphic field.

Since we used a single volumetric mesh template, patients with thicker LV walls will induce stretching of the inner LV elements, which could lead to degenerate elements in extreme cases. In this work, we avoided this by simply tuning the hyperparameter for the isotropic energy penalty to achieve both satisfactory myocardial surface matching and good inner element quality for downstream simulations. In future works, we could explicitly circumvent this issue by either re-meshing the inner elements or modeling the LV as a surface and filling in the elements post-hoc. This would break inter-patient mesh correspondence for the inner LV elements, but maintain surface element correspondence. Given these trade-offs, we chose our proposed method because (1) it maintains full volumetric mesh correspondence across patients for easier automated simulation setup, and (2) accurate LV myocardial surface was not critical for our downstream analysis.

Shell meshes for all structures can be easily extracted from our final volumetric meshes. For hex elements, we can extract the “base surfaces” by simply indexing the first four nodes of each 8-node element. We can also obtain any volumetric mesh’s outer surface elements using a combination of “merge” and “extract surface” operations [42]. This makes our meshes adaptable to various other simulation setups that may benefit from shell elements (e.g. prescribed node displacements for fluid simulations, etc.). The exact implementation of these operations can be found in our published code.

The focus of this work was on the heart geometry volumetric meshing technique. Therefore, we demonstrated our meshes’ viability for solid mechanics via stent deployment simulations. The immediate use case for this particular simulation is aortic rupture risk identification [13]. The main determining factors for post-TAVR stress distributions are (1) the location of calcification on the leaflets and (2) the aortic wall geometry [12], [13], both of which are quite accurately modeled using our approach.

Due to the scarcity of aortic rupture and other structure-based clinical data, there was no good metric to assess the accuracy of our solid mechanics simulations. Our simulation validation was thus limited to showing that (1) our generated meshes are robust enough to handle complicated solid interactions caused by the stent deployment, and (2) our simulation results concur with previous results that calcified regions exhibit higher stress distributions.

In future studies, we aim to clinically validate our method using flow-based measurements, which are more readily available and may be more relevant for assessing cardiac function. To accomplish this, we will extend the LV geometry to cover the entire LV blood pool and demonstrate the adaptability of our method to computational fluid dynamics (CFD) and fluid structure interaction (FSI) simulations. These simulations can help predict post-TAVR hemodynamics based on the device geometry and placement. It should also be noted that our meshes are not limited to TAVR simulations; the exact formulation of analyses will largely depend on the end user, but our meshes can be automatically converted to all other geometrical representations shown in Fig. 2 to fit to the desired tasks.

The 9 landmarks we evaluated were chosen similarly to [55], [56]. The hinges and commissures are important features of the aortic annulus and the sinotubular junction, and the leaflet tips provide additional information about the leaflet positioning. The coronary ostia were omitted because our labels and template did not account for the coronary arteries. It should be noted that, in contrast to previous studies, we did not use any landmarks as intermediate labels for the meshing process; they were simply a byproduct of our final mesh prediction.

Our method aims to maintain the template leaflet elements’ thicknesses post-deformation, which means it is not designed to handle variable leaflet thicknesses. Our main reasoning was that the limited resolution in both the input images and training labels prohibit us from accurately modeling variable leaflet thicknesses. Instead, we incorporated calcification, which can be much more reliably reconstructed from CT and is the main contributor of leaflet thickening in aortic stenosis patients [57].

Models were trained and evaluated on all phases of the cardiac cycle (Section V-A.1). Even so, all models struggled with accurately modeling a fully closed valve with surface contacts, due to a variety of factors including limited image quality, training labels, and deformation formulation. This issue was not critical for our simulations, since the overall positioning of the leaflets still allowed for accurate calcification meshing. However, if we were to use the predicted meshes as the ground-truth prescribed node positions and perform fluid simulations without any fluid-to-structure FSI coupling, we would likely estimate partially inaccurate flow patterns, such as false prediction of aortic regurgitation. We hope to address this in future studies by either improving the training labels for fully closed valves or incorporating additional flow-based measurements, such as Doppler echocardiography, during the training phase.

A few more interesting future directions include faster and more robust Ca2 meshing techniques, feasibility studies with multi-layer aorta/leaflet elements, and further reducing labeling burden to allow for easier training on novel structures.

VII. Conclusion

We proposed a novel deformation-based deep learning method that automatically generates simulation-ready patient-specific heart geometry meshes from 3D CT images. Our predicted geometries are highly accurate and can be directly used to perform large-batch FE analyses.

Acknowledgments

This work was supported by the NIH NHLBI R01HL142036 and F31HL162505.

Contributor Information

Daniel H. Pak, Yale University, New Haven, CT 06520 USA

Minliang Liu, Georgia Institute of Technology, Atlanta, GA 30332 USA.

Theodore Kim, Yale University, New Haven, CT 06520 USA.

Liang Liang, University of Miamia, Coral Gables, FL 33146 USA.

Andres Caballero, Georgia Institute of Technology, Atlanta, GA 30332 USA.

John Onofrey, Yale University, New Haven, CT 06520 USA.

Shawn S. Ahn, Yale University, New Haven, CT 06520 USA

Yilin Xu, Georgia Institute of Technology, Atlanta, GA 30332 USA.

Raymond McKay, Hartford hospital, Hartford, CT 06102 USA.

Wei Sun, Georgia Institute of Technology, Atlanta, GA 30332 USA.

Rudolph Gleason, Georgia Institute of Technology, Atlanta, GA 30332 USA.

James S. Duncan, Yale University, New Haven, CT 06520 USA.

References

  • [1].Bevan GH, Zidar DA, Josephson RA, and Al-Kindi SG, “Mortality due to aortic stenosis in the united states, 2008-2017,” Jama, vol. 321, no. 22, pp. 2236–2238, 2019. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [2].Carabello BA, “Transcatheter aortic-valve implantation for aortic stenosis in patients who cannot undergo surgery,” Current Cardiology Reports, vol. 13, no. 3, pp. 173–174, 2011. [DOI] [PubMed] [Google Scholar]
  • [3].U.S. Food and Drug Administration. (2016) FDA approves expanded indication for two transcatheter heart valves for patients at intermediate risk for death or complications associated with open-heart surgery. [Google Scholar]
  • [4]._____. (2019) FDA expands indication for several transcatheter heart valves to patients at low risk for death or major complications associated with open-heart surgery.
  • [5].Carroll JD, Mack MJ, Vemulapalli S, Herrmann HC, Gleason TG, Hanzel G, Deeb GM, Thourani VH, Cohen DJ, Desai N et al. , “Sts-acc tvt registry of transcatheter aortic valve replacement,” Journal of the American College of Cardiology, vol. 76, no. 21, pp. 2492–2516, 2020. [DOI] [PubMed] [Google Scholar]
  • [6].Blanke P, Schoepf UJ, and Leipsic JA, “Ct in transcatheter aortic valve replacement,” Radiology, vol. 269, no. 3, pp. 650–669, 2013. [DOI] [PubMed] [Google Scholar]
  • [7].Leipsic JA, Blanke P, Hanley M, Batlle JC, Bolen MA, Brown RK, Desjardins B, Eberhardt RT, Gornik HL, Hurwitz LM et al. , “Acr appropriateness criteria® imaging for transcatheter aortic valve replacement,” Journal of the American College of Radiology, vol. 14, no. 11, pp. S449–S455, 2017. [DOI] [PubMed] [Google Scholar]
  • [8].Caballero A, Mao W, McKay R, and Sun W, “The impact of balloon-expandable transcatheter aortic valve replacement on concomitant mitral regurgitation: a comprehensive computational analysis,” Journal of the Royal Society Interface, vol. 16, no. 157, p. 20190355, 2019. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [9].Morganti S, Conti M, Aiello M, Valentini A, Mazzola A, Reali A, and Auricchio F, “Simulation of transcatheter aortic valve implantation through patient-specific finite element analysis: two clinical cases,” Journal of biomechanics, vol. 47, no. 11, pp. 2547–2555, 2014. [DOI] [PubMed] [Google Scholar]
  • [10].El Faquir N, De Backer O, Bosmans J, Rudolph T, Buzzatti N, Bieliauskas G, Collas V, Wienemann H, Schiavi D, Cummins P et al. , “Patient-specific computer simulation in tavr with the self-expanding evolut r valve,” Cardiovascular Interventions, vol. 13, no. 15, pp. 1803–1812, 2020. [DOI] [PubMed] [Google Scholar]
  • [11].Pak DH, Liu M, Kim T, Liang L, McKay R, Sun W, and Duncan JS, “Distortion energy for deep learning-based volumetric finite element mesh generation for aortic valves,” in International Conference on Medical Image Computing and Computer-Assisted Intervention. Springer, 2021, pp. 485–494. [Google Scholar]
  • [12].Caballero A, Mao W, McKay R, and Sun W, “The impact of self-expandable transcatheter aortic valve replacement on concomitant functional mitral regurgitation: a comprehensive engineering analysis,” Structural Heart, vol. 4, no. 3, pp. 179–191, 2020. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [13].Wang Q, Kodali S, Primiano C, and Sun W, “Simulations of transcatheter aortic valve implantation: implications for aortic root rupture,” Biomechanics and modeling in mechanobiology, vol. 14, pp. 29–38, 2015. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [14].Mohamed A and Davatzikos C, “Finite element mesh generation and remeshing from segmented medical images,” in 2004 2nd IEEE International Symposium on Biomedical Imaging: Nano to Macro (IEEE Cat No. 04EX821). IEEE, 2004, pp. 420–423. [Google Scholar]
  • [15].Pak DH, Liu M, Ahn SS, Caballero A, Onofrey JA, Liang L, Sun W, and Duncan JS, “Weakly supervised deep learning for aortic valve finite element mesh generation from 3d ct images,” in International Conference on Information Processing in Medical Imaging. Springer, 2021, pp. 637–648. [Google Scholar]
  • [16].Staib LH and Duncan JS, “Model-based deformable surface finding for medical images,” IEEE transactions on medical imaging, vol. 15, no. 5, pp. 720–731, 1996. [DOI] [PubMed] [Google Scholar]
  • [17].Baghdadi L, Steinman DA, and Ladak HM, “Template-based finite-element mesh generation from medical images,” Computer methods and programs in biomedicine, vol. 77, no. 1, pp. 11–21, 2005. [DOI] [PubMed] [Google Scholar]
  • [18].Barber DC, Oubel E, Frangi AF, and Hose D, “Efficient computational fluid dynamics mesh generation by image registration,” Medical image analysis, vol. 11, no. 6, pp. 648–662, 2007. [DOI] [PubMed] [Google Scholar]
  • [19].Liu Y, Foteinos P, Chernikov A, and Chrisochoides N, “Mesh deformation-based multi-tissue mesh generation for brain images,” Engineering with Computers, vol. 28, no. 4, pp. 305–318, 2012. [Google Scholar]
  • [20].Lorenz C and von Berg J, “A comprehensive shape model of the heart,” Medical image analysis, vol. 10, no. 4, pp. 657–670, 2006. [DOI] [PubMed] [Google Scholar]
  • [21].Labrosse MR, Beller CJ, Boodhwani M, Hudson C, and Sohmer B, “Subject-specific finite-element modeling of normal aortic valve biomechanics from 3d+ t tee images,” Medical image analysis, vol. 20, no. 1, pp. 162–172, 2015. [DOI] [PubMed] [Google Scholar]
  • [22].Astorino M, Hamers J, Shadden SC, and Gerbeau J-F, “A robust and efficient valve model based on resistive immersed surfaces,” International Journal for Numerical Methods in Biomedical Engineering, vol. 28, no. 9, pp. 937–959, 2012. [DOI] [PubMed] [Google Scholar]
  • [23].Pouch AM, Tian S, Takebe M, Yuan J, Gorman R Jr, Cheung AT, Wang H, Jackson BM, Gorman III JH, Gorman RC et al. , “Medially constrained deformable modeling for segmentation of branching medial structures: Application to aortic valve segmentation and morphometry,” Medical image analysis, vol. 26, no. 1, pp. 217231, 2015. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [24].Pak DH, Caballero A, Sun W, and Duncan JS, “Efficient aortic valve multilabel segmentation using a spatial transformer network,” in 2020 IEEE 17th International Symposium on Biomedical Imaging (ISBI). IEEE, 2020, pp. 1738–1742. [Google Scholar]
  • [25].Aoyama G, Zhao L, Zhao S, Xue X, Zhong Y, Yamauchi H, Tsukihara H, Maeda E, Ino K, Tomii N et al. , “Automatic aortic valve cusps segmentation from ct images based on the cascading multiple deep neural networks,” Journal of Imaging, vol. 8, no. 1, p. 11, 2022. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [26].Ionasec RI, Voigt I, Georgescu B, Wang Y, Houle H, Vega-Higuera F, Navab N, and Comaniciu D, “Patient-specific modeling and quantification of the aortic and mitral valves from 4-d cardiac ct and tee,” IEEE transactions on medical imaging, vol. 29, no. 9, pp. 1636–1651, 2010. [DOI] [PubMed] [Google Scholar]
  • [27].Liang L, Kong F, Martin C, Pham T, Wang Q, Duncan J, and Sun W, “Machine learning–based 3-d geometry reconstruction and modeling of aortic valve deformation using 3-d computed tomography images,” International journal for numerical methods in biomedical engineering, vol. 33, no. 5, p. e2827, 2017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [28].Ghesu FC, Krubasik E, Georgescu B, Singh V, Zheng Y, Horneg-ger J, and Comaniciu D, “Marginal space deep learning: efficient architecture for volumetric image parsing,” IEEE transactions on medical imaging, vol. 35, no. 5, pp. 1217–1228, 2016. [DOI] [PubMed] [Google Scholar]
  • [29].Grbic S, Mansi T, Ionasec R, Voigt I, Houle H, John M, Schoebinger M, Navab N, and Comaniciu D, “Image-based computational models for tavi planning: from ct images to implant deployment,” in International Conference on Medical Image Computing and Computer-Assisted Intervention. Springer, 2013, pp. 395–402. [DOI] [PubMed] [Google Scholar]
  • [30].Dalca AV, Balakrishnan G, Guttag J, and Sabuncu MR, “Unsupervised learning of probabilistic diffeomorphic registration for images and surfaces,” Medical image analysis, vol. 57, pp. 226–236, 2019. [DOI] [PubMed] [Google Scholar]
  • [31].Lee MCH, Petersen K, Pawlowski N, Glocker B, and Schaap M, “Tetris: Template transformer networks for image segmentation with shape priors,” IEEE transactions on medical imaging, vol. 38, no. 11, pp. 2596–2606, 2019. [DOI] [PubMed] [Google Scholar]
  • [32].Wang N, Zhang Y, Li Z, Fu Y, Liu W, and Jiang Y-G, “Pixel2mesh: Generating 3d mesh models from single rgb images,” in Proceedings of the European conference on computer vision (ECCV), 2018, pp. 52–67. [Google Scholar]
  • [33].Wickramasinghe U, Remelli E, Knott G, and Fua P, “Voxel2mesh: 3d mesh model generation from volumetric data,” in International Conference on Medical Image Computing and Computer-Assisted Intervention. Springer, 2020, pp. 299–308. [Google Scholar]
  • [34].Kong F, Wilson N, and Shadden S, “A deep-learning approach for direct whole-heart mesh reconstruction,” Medical image analysis, vol. 74, p. 102222, 2021. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [35].Kong F and Shadden SC, “Learning whole heart mesh generation from patient images for computational simulations,” IEEE Transactions on Medical Imaging, 2022. [DOI] [PubMed] [Google Scholar]
  • [36].Botsch M, Kobbelt L, Pauly M, Alliez P, and Lévy B, Polygon mesh processing. CRC press, 2010. [Google Scholar]
  • [37].Balakrishnan G, Zhao A, Sabuncu MR, Guttag J, and Dalca AV, “Voxelmorph: a learning framework for deformable medical image registration,” IEEE transactions on medical imaging, vol. 38, no. 8, pp. 1788–1800, 2019. [DOI] [PubMed] [Google Scholar]
  • [38].Sandkühler R, Jud C, Andermatt S, and Cattin PC, “Airlab: Autograd image registration laboratory,” arXiv preprint arXiv:1806.09907, 2018. [Google Scholar]
  • [39].Dalca AV, Balakrishnan G, Guttag J, and Sabuncu MR, “Unsupervised learning for fast probabilistic diffeomorphic registration,” in International Conference on Medical Image Computing and Computer-Assisted Intervention. Springer, 2018, pp. 729–738. [Google Scholar]
  • [40].Ravi N, Reizenstein J, Novotny D, Gordon T, Lo W-Y, Johnson J, and Gkioxari G, “Accelerating 3d deep learning with pytorch3d,” arXiv:2007.08501, 2020. [Google Scholar]
  • [41].Kim T and Eberle D, “Dynamic deformables: implementation and production practicalities,” in ACM SIGGRAPH 2020 Courses, 2020, pp. 1–182. [Google Scholar]
  • [42].Schroeder W, Martin KM, and Lorensen WE, The visualization toolkit an object-oriented approach to 3D graphics. Prentice-Hall, Inc., 1998. [Google Scholar]
  • [43].Hang S, “Tetgen, a delaunay-based quality tetrahedral mesh generator,” ACM Trans. Math. Softw, vol. 41, no. 2, p. 11, 2015. [Google Scholar]
  • [44].Zhuang X and Shen J, “Multi-scale patch and multi-modality atlases for whole heart segmentation of mri,” Medical image analysis, vol. 31, pp. 77–87, 2016. [DOI] [PubMed] [Google Scholar]
  • [45].Sun W, Martin C, and Pham T, “Computational modeling of cardiac valve function and intervention,” Annual review of biomedical engineering, vol. 16, p. 53, 2014. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [46].Chui H and Rangarajan A, “A new point matching algorithm for non-rigid registration,” Computer Vision and Image Understanding, vol. 89, no. 2–3, pp. 114–141, 2003. [Google Scholar]
  • [47].Paszke A, Gross S, Chintala S, Chanan G, Yang E, DeVito Z, Lin Z, Desmaison A, Antiga L, and Lerer A, “Automatic differentiation in pytorch,” 2017. [Google Scholar]
  • [48].Ronneberger O, Fischer P, and Brox T, “U-net: Convolutional networks for biomedical image segmentation,” in International Conference on Medical image computing and computer-assisted intervention. Springer, 2015, pp. 234–241. [Google Scholar]
  • [49].Kingma DP and Ba J, “Adam: A method for stochastic optimization,” arXiv preprint arXiv:1412.6980, 2014. [Google Scholar]
  • [50].Sullivan CB and Kaszynski A, “PyVista: 3d plotting and mesh analysis through a streamlined interface for the visualization toolkit (VTK),” Journal of Open Source Software, vol. 4, no. 37, p. 1450, may 2019. [Online]. Available: 10.21105/joss.01450 [DOI] [Google Scholar]
  • [51].Emmerich M and Deutz AH, “A tutorial on multiobjective optimization: fundamentals and evolutionary methods,” Natural computing, vol. 17, no. 3, pp. 585–609, 2018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [52].Medtronic LLC. (2017) Medtronic corevalve system instructions for use.
  • [53].Tzamtzis S, Viquerat J, Yap J, Mullen M, and Burriesci G, “Numerical analysis of the radial force produced by the medtronic-corevalve and edwards-sapien after transcatheter aortic valve implantation (tavi),” Medical engineering & physics, vol. 35, no. 1, pp. 125–130, 2013. [DOI] [PubMed] [Google Scholar]
  • [54].Mao W, Wang Q, Kodali S, and Sun W, “Numerical parametric study of paravalvular leak following a transcatheter aortic valve deployment into a patient-specific aortic root,” Journal of biomechanical engineering, vol. 140, no. 10, p. 101007, 2018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • [55].Grbic S, Ionasec R, Vitanovski D, Voigt I, Wang Y, Georgescu B, Navab N, and Comaniciu D, “Complete valvular heart apparatus model from 4d cardiac ct,” Medical image analysis, vol. 16, no. 5, pp. 1003–1014, 2012. [DOI] [PubMed] [Google Scholar]
  • [56].Zheng Y, John M, Liao R, Boese J, Kirschstein U, Georgescu B, Zhou SK, Kempfert J, Walther T, Brockmann G et al. , “Automatic aorta segmentation and valve landmark detection in c-arm ct: application to aortic valve implantation,” in Medical Image Computing and Computer-Assisted Intervention–MICCAI 2010: 13th International Conference, Beijing, China, September 20-24, 2010, Proceedings, Part I 13. Springer, 2010, pp. 476–483. [DOI] [PubMed] [Google Scholar]
  • [57].Lindman BR, Clavel M-A, Mathieu P, Iung B, Lancellotti P, Otto CM, and Pibarot P, “Calcific aortic stenosis,” Nature reviews Disease primers, vol. 2, no. 1, pp. 1–28, 2016. [DOI] [PMC free article] [PubMed] [Google Scholar]

RESOURCES