Cardiac mechanics Benchmark - Problem 2#
This code implements problem 2 in the Cardiac Mechanic Benchmark paper
Land S, Gurev V, Arens S, Augustin CM, Baron L, Blake R, Bradley C, Castro S, Crozier A, Favino M, Fastl TE. Verification of cardiac mechanics software: benchmark problems and solutions for testing active and passive material behaviour. Proc. R. Soc. A. 2015 Dec 8;471(2184):20150641.
from pathlib import Path
import dolfin
try:
from dolfin_adjoint import Constant, DirichletBC, Mesh, interpolate
except ImportError:
from dolfin import DirichletBC, Constant, interpolate, Mesh
import pulse
import cardiac_geometries as cg
from fenics_plotly import plot
geo_path = Path("geometry")
if not geo_path.is_dir():
cg.create_benchmark_geometry_land15(outdir=geo_path)
geo = cg.geometry.Geometry.from_folder(geo_path)
geometry = pulse.HeartGeometry(
mesh=geo.mesh,
markers=geo.markers,
marker_functions=pulse.MarkerFunctions(vfun=geo.vfun, ffun=geo.ffun),
microstructure=pulse.Microstructure(f0=geo.f0, s0=geo.s0, n0=geo.n0),
)
2024-09-05 11:57:36,322 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:57:36,444 [888] DEBUG UFL_LEGACY: Blocks of each mode:
2024-09-05 11:57:37,314 [888] DEBUG UFL_LEGACY: Blocks of each mode:
2024-09-05 11:57:37,961 [888] WARNING cardiac_geometries.fibers._utils: Unable to write XDMF file:
*** -------------------------------------------------------------------------
*** DOLFIN encountered an error. If you are not able to resolve this issue
*** using the information listed below, you can ask for help at
***
*** fenics-support@googlegroups.com
***
*** Remember to include the error message listed below and, if possible,
*** include a *minimal* running example to reproduce the error.
***
*** -------------------------------------------------------------------------
*** Error: Unable to find element family.
*** Reason: Element Quadrature not yet supported.
*** Where: This error was encountered inside XDMFFile.cpp.
*** Process: 0
***
*** DOLFIN version: 2019.2.0.dev0
*** Git changeset: fd662efc1c0ddefa341c1dac753f717f6b6292a8
*** -------------------------------------------------------------------------
# Create the material
material_parameters = pulse.Guccione.default_parameters()
material_parameters["C"] = 10.0
material_parameters["bf"] = 1.0
material_parameters["bfs"] = 1.0
material_parameters["bt"] = 1.0
material = pulse.Guccione(parameters=material_parameters)
# Define Dirichlet boundary. Fix the base_spring
def dirichlet_bc(W):
V = W if W.sub(0).num_sub_spaces() == 0 else W.sub(0)
return DirichletBC(
V,
Constant((0.0, 0.0, 0.0)),
geometry.ffun,
geometry.markers["BASE"][0],
)
# Traction at the bottom of the beam
lvp = Constant(0.0)
neumann_bc = pulse.NeumannBC(traction=lvp, marker=geometry.markers["ENDO"][0])
# Collect Boundary Conditions
bcs = pulse.BoundaryConditions(dirichlet=(dirichlet_bc,), neumann=(neumann_bc,))
# Create problem
problem = pulse.MechanicsProblem(geometry, material, bcs)
# Solve problem
pulse.iterate.iterate(problem, lvp, 10.0, initial_number_of_steps=200)
2024-09-05 11:57:38,345 [888] INFO pulse.iterate: Iterating to target control (f_166)...
2024-09-05 11:57:38,346 [888] INFO pulse.iterate: Current control: f_166 = 0.000
2024-09-05 11:57:38,347 [888] INFO pulse.iterate: Target: 10.000
2024-09-05 11:57:38,431 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:57:38,432 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:57:38,433 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:57:38,433 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:57:39,156 [888] DEBUG UFL_LEGACY: Blocks of each mode:
99 full
2024-09-05 11:57:39,366 [888] DEBUG UFL_LEGACY: Blocks of each mode:
18 full
2024-09-05 11:58:36,580 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:58:36,581 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:58:36,582 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:58:36,583 [888] INFO UFL_LEGACY: Adjusting missing element cell to tetrahedron.
2024-09-05 11:58:36,792 [888] DEBUG UFL_LEGACY: Blocks of each mode:
10 full
2024-09-05 11:58:36,989 [888] DEBUG UFL_LEGACY: Blocks of each mode:
3 full
([Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 182),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 212),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 237),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 262),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 287),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 312),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 337),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 370),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 411),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 460),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 509),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 550),
Coefficient(FunctionSpace(Mesh(VectorElement(FiniteElement('Lagrange', tetrahedron, 1), dim=3), 115), MixedElement(VectorElement(FiniteElement('Lagrange', tetrahedron, 2), dim=3), FiniteElement('Lagrange', tetrahedron, 1))), 583)],
[Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 180),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 210),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 235),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 260),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 285),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 310),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 335),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 368),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 409),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 458),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 507),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 548),
Coefficient(FunctionSpace(None, FiniteElement('Real', None, 0)), 581)])
# Get displacement and hydrostatic pressure
u, p = problem.state.split(deepcopy=True)
endo_apex_marker = geometry.markers["ENDOPT"][0]
endo_apex_idx = geometry.vfun.array().tolist().index(endo_apex_marker)
endo_apex = geometry.mesh.coordinates()[endo_apex_idx, :]
endo_apex_pos = endo_apex + u(endo_apex)
print(
("\n\nGet longitudinal position of endocardial apex: {:.4f} mm" "").format(
endo_apex_pos[0],
),
)
Get longitudinal position of endocardial apex: -26.5405 mm
epi_apex_marker = geometry.markers["EPIPT"][0]
epi_apex_idx = geometry.vfun.array().tolist().index(epi_apex_marker)
epi_apex = geometry.mesh.coordinates()[epi_apex_idx, :]
epi_apex_pos = epi_apex + u(epi_apex)
print(
("\n\nGet longitudinal position of epicardial apex: {:.4f} mm" "").format(
epi_apex_pos[0],
),
)
Get longitudinal position of epicardial apex: -28.1947 mm
V = dolfin.VectorFunctionSpace(geometry.mesh, "CG", 1)
u_int = interpolate(u, V)
mesh = Mesh(geometry.mesh)
dolfin.ALE.move(mesh, u_int)
fig = plot(geometry.mesh, color="red", show=False)
fig.add_plot(plot(mesh, opacity=0.3, show=False))
fig.show()