Skip to main content
Scientific Reports logoLink to Scientific Reports
. 2021 Dec 20;11:24260. doi: 10.1038/s41598-021-03584-2

An efficient, localised approach for the simulation of elastic blood vessels using the lattice Boltzmann method

J W S McCullough 1, P V Coveney 1,2,
PMCID: PMC8688478  PMID: 34930939

Abstract

Many numerical studies of blood flow impose a rigid wall assumption due to the simplicity of its implementation compared to a full coupling with a solid mechanics model. In this paper, we present a localised method for incorporating the effects of elastic walls into blood flow simulations using the lattice Boltzmann method implemented by the open-source code HemeLB. We demonstrate that our approach is able to more accurately capture the flow behaviour expected in elastic walled vessels than ones with rigid walls. Furthermore, we show that this can be achieved with no loss of computational performance and remains strongly scalable on high performance computers. We finally illustrate that our approach captures the same trends in wall shear stress distribution as those observed in studies using a rigorous coupling between fluid dynamics and solid mechanics models to solve flow in personalised vascular geometries. These results demonstrate that our model can be used to efficiently and effectively represent flows in elastic blood vessels.

Subject terms: Biomedical engineering, Mechanical engineering

Introduction

Many fields of computational biomedicine are moving towards the realisation of the virtual human. This concept embodies the creation of a high fidelity and personalised digital representation of the biophysical processes occurring within a particular individual. Such a model requires scalable computational methods that can study human-scale systems such as a particular organ but can also be efficiently coupled to simulations of other physiological components in order to build a virtual human. With continuing advances in computational performance, especially with the approach of exascale computers, the capacity to conduct high-fidelity human-scale simulations is becoming achievable. The development of a virtual human will allow clinicians to determine the optimal course of treatment for a given individual.

Numerical simulation of any physical system requires some level of approximation of the fundamental physics involved. A particular example of this is the assumption of rigid walls in the study of fluid flow through pipe-like structures. Whilst this is appropriate in many mechanical settings, organic structures such as blood vessels often exhibit elastic properties. Whether the use of a rigid wall approximation is valid for vascular simulations, or the implementation of an elastic wall model is necessary, depends on the particular vessels being studied, the scale of the simulation and the flow features of interest. Both options are used in practice and both come with benefits and drawbacks. In 1D models, where blood vessels are represented by a network of connected nodes, the effect of elastic walls can be implemented with a constitutive relation between pressure and the cross-sectional area of the vessel at solution locations13. The updated area can then inform the flow velocity at those sites. The implementation of elastic walls in a 3D model is significantly more difficult as it typically demands explicit coupling of the wall boundaries of the fluid domain to a solid mechanics model for an elastic vessel wall. Depending on the fluid solver used, the changing wall position may demand the fluid domain to be modified in response. Both of these procedures are usually regarded as being complex and computationally costly to implement in 3D and this is a reason why a number of 3D models utilise a rigid wall assumption46.

With a view towards creating virtual human-scale models, we are developing the capability to conduct full human simulations of arterial and venous vascular geometries using the open-source blood flow simulator HemeLB612. This solver has been specifically optimised to deal with the complex and sparse geometries characteristic of vascular domains. It exhibits excellent strong scaling characteristics on tens to hundreds of thousands of computer cores6,13 thanks to the fundamental properties of the lattice Boltzmann method (LBM) on which it is based. Such performance has been achieved through the spatial decomposition of complex vascular models at various sizes up to full human scale. These properties make HemeLB a good candidate for being able to simulate the blood flow in a virtual human model. All the simulations described in this work have been performed using the HemeLB code.

In this paper, we introduce a boundary condition for representing the effect of elastic walls at the edge of a lattice Boltzmann fluid domain. Our approach both retains the inherent scalability of the LBM and more accurately captures the key features of elastic flow without a loss of performance compared to a rigid wall implementation. The structure of our paper is as follows. In Numerical methods we outline the lattice Boltzmann method and the boundary conditions relevant to this work. We then compare the behaviour of our model against analytical results and those obtained with a rigid wall assumption. In Model application we use our model to simulate flow in personalised arteries of the left forearm. We then further discuss our simulation results and provide an outlook for how this work can be incorporated into a full-scale virtual human model. Our conclusions are summarised in the final section. In the Appendix, we provide computational details for the simulations conducted in this work.

Numerical methods

In this paper we make use of the HemeLB code to solve 3D flow through a vascular geometry. In this section, we will give a brief outline of this approach followed by a description of our proposed method for replicating the impact of elastic walls. We then verify our implementation through comparison to analytical results that are relevant to blood flow simulation. In particular we will compare against results for Womersley flow in an elastic walled cylinder. This is suitable for comparison in that it resembles both the pulsatility that is characteristic of a heartbeat and explicitly allows for the impact of movable boundaries.

The lattice Boltzmann method

Here we will give a brief introduction to the LBM; for a deeper discussion of the technique we refer the reader to the wider literature1418. To describe a flow with the LBM, the domain is partitioned into a Cartesian grid with a constant spacing of Δx in all 3D directions. At each nodal location, x, a discrete set of values, fi(x,t), is assigned to represent the amount of fluid moving in direction i at time t. In this work, we use a D3Q19 model where fluid can stay at the current location or move to one of the 18 neighbours described by the sets: i=1-6 ±1,0,0,0,±1,0,0,0,±1 and i=7-18 ±1,±1,0,±1,0,±1,0,±1,±1. The flow described by fi(x,t) evolves over the time step Δt with a single relaxation time operator:

fi(x+ciΔt,t+Δt)=fi(x,t)-Δtτ(fi(x,t)-fieq(x,t)). 1

Here, ci indicates the velocity set necessary to move flow to neighbour i in a single time step. τ relaxes fi(x,t) towards the equilibrium state fieq(x,t), a discrete approximation of the Maxwell–Boltzmann distribution. As is demonstrated elsewhere in the literature, a Chapmann–Enskog expansion can be used to show that this framework represents the Navier–Stokes equation for fluid flow in a low Mach number limit. This expansion yields the expansion coefficients, wi, for the equilibrium function,

fieq(x,t)=wiρ(x,t)1+ci·uCs2+(ci·u)2Cs4-|u|2Cs2. 2

For D3Q19 these are 1/3 for i=0 (the source node), 1/18 for i=1-6 and 1/36 for i=7-18. Cs represents the speed of sound of the fluid and evaluates to 13. Local macroscopic properties of density and momentum can be determined from moments of the fi(x,t) population as,

ρ(x,t)=ifi(x,t), 3

and,

ρ(x,t)u=ifi(x,t)ci, 4

respectively. Other relevant physical properties of pressure,

p(x,t)=Cs2ρ(x,t), 5

and viscosity,

ν=Cs2τ-12, 6

arise from the Chapmann–Enskog expansion procedure and associated assumptions.

Elastic wall theory

The analytical derivations of Womersley19,20 represents some of the seminal work in fluid flow through pipes. These two papers focus on idealised results for pulsatile flow through rigid and flexible pipes and provide a reference case that has been widely used as a verification model for computational fluid mechanics11,21,22. For a full derivation we refer to the source works or that of Figueroa21 or Filonova et al.22 but here we highlight equations of particular relevance to the later development of our elastic wall model. These field equations describe properties at a given radial, r, and axial, z, position in time, t, as a combination of steady and oscillatory components of flow. In the derivation of these equations, complex variables are used to simplify the expressions associated with the presence of oscillating flow, thus i=-1. The oscillatory component is represented by the term associated with the eiωt-zc. In the cases where complex components appear in the final field equations, the output should be taken as the real part of the expression. The pressure field is described by:

p(r,z,t)=Heiωt-zc+p0+ks(z-z0), 7

the axial component of velocity is given by:

w(r,z,t)=ks4μ(r2-R2)+Hρc1-MJ0ΛrRJ0Λeiωt-zc, 8

and the radial component of velocity is given by:

u(r,z,t)=HiωR2ρc2rR-M2J1ΛrRΛJ0Λeiωt-zc. 9

In these expressions, Jn(x) is the nth order Bessel function of the first kind. Within these equations are parameters governed by the vessel and fluid being studied. Here R is the radius of the vessel, z0 is the location of the entry of the cylinder whilst c is the wave speed within the elastic cylinder; p0 represents the static background pressure whilst ks is the static pressure gradient. H represents the amplitude, and ω the frequency, of the oscillatory pressure. The Womersley number (α=Rωρμ) is represented by the complex term Λ=i3/2α. The terms ρ and μ represent the fluid density and fluid viscosity respectively. M is an elasticity factor derived from vessel and fluid properties.

Proposed elastic wall boundary condition

Many existing representations of elastic walls within an uncoupled LBM simulation require the explicit changing of node types between fluid and solid to represent the change in wall location2325. Whilst it is possible to take advantage of the inherent locality of LBM, this approach typically requires each lattice site to have a notion of how far away it is from the centre of the vessel. This is easy to achieve in simple representations of blood vessels as cylinders where the coordinates of the node can be used to deduce the local radial position. In patient-specific representations of blood vessels, this can become a much more challenging task as the vessel geometry and orientation can often deviate substantially from such simplifying assumptions. Similarly, the geometry and orientation of patient-specific vessels, combined with the often large number of lattice sites representing them, means that pre-computing such radial data is itself non-trivial. It is therefore advantageous to have a representation of elastic walls that does not fundamentally rely on knowledge of a site’s position within the vessel.

From a conceptual point of view, our approach assumes that the set of LBM fluid nodes represents the minimum fluid volume of the elastic vessel. We then implement a wall boundary condition that provides a non-zero fluid velocity at that location to mimic the effect of the vessel expanding beyond that point. For the generally small changes in vessel diameter26, combined with geometrical uncertainty in image-derived vascular simulation models, such an approach provides a useful compromise for capturing the effects of elastic walled vessels between simple rigid wall modelling and the complex and computationally expensive coupling to a solid mechanics model.

In our implementation, we build upon the Guo et al.27 (GZS) wall boundary condition. This method was selected due to its basis as an extrapolation condition—a similar concept to what we are trying to achieve. The GZS scheme was proposed as a method for representing curved boundaries. The non-equilibrium component of the distribution at the wall node is constructed from the neighbouring fluid node whilst the equilibrium component is constructed based on the desired location and characteristics of the curved boundary. For cases where the curved boundary is close to the wall (where Δ, being the fraction of the unit cell the boundary is from the fluid node, is 0.75), the wall node velocity is proposed by GZS to be Uw=(Uboundary+(Δ-1)Uf)/Δ. This is used to construct fieq(xw,t) whilst fineq(xw,t) is taken to be the same as fineq(xf,t) in the post-collision construction of fi(xw,t)=fieq(xw,t)+(1-τ-1)fineq(xw,t).

In our boundary condition implementation, we consider the case of Δ=1 to apply a non-zero velocity at the wall node that is approximated to replicate the effect of an elastic boundary stretching beyond this point. The conceptual layout of this is given in Fig. 1.

Figure 1.

Figure 1

Schematic layout of fluid node, wall node and hypothetical wall location for the proposed boundary scheme. The extended wall location represents the position of the edge of the wall when it extends beyond the physically simulated domain.

If it is assumed that there is a linear change between UR and Uf, then Uw=UR+Δr-ΔxΔr(Uf-UR). The Δr term can be computed using common relations between pressure and the stiffness of the elastic wall. This expression for Uw can then be fully derived in terms of the known value Uf but taking into account analytical expressions for elastic vessels. Here we particularly look for the ratio between the edge of the elastic walled pipe and the location of the fluid node Δr inside of it. For a ratio of F=URUf, the value of Uw can be solely computed from Uf as Uw=(FΔx+Δr-ΔxΔrUf. For this computation we will only consider the oscillating part of the axial component of flow. At the extended wall location, the axial velocity is the real part of:

w(R,z,t)=Hρc1-Meiωt-zc, 10

whilst at the location of the fluid node it is the real part of:

w(R-Δr,z,t)=Hρc1-MJ0Λ(R-Δr)RJ0Λeiωt-zc. 11

Combining these two expressions we get the following for the boundary velocity ratio F:

F=w(R,z,t)w(R-Δr,z,t)=1-M1-MJ0Λ(R-Δr)RJ0Λ=1-M1-MJ0Λ(1-ΔrR)J0Λ. 12

The value of F is dependent on the Womersley number (α) of the local flow through Λ and the extension of the flow Δr/R. α varies widely throughout the human vascular system from O(10-3) in the capillaries to O(10) in the aorta. In our simulation efforts, the resolution of available human-scale domains means that we typically consider relatively large vessels where α>1. Equally, within blood vessels, the amount of flow induced radial dilation is typically a relatively small value and often less than 10% of the radius26. Whilst M also varies based on vessel radius and Womersley number, its variation is much less than that of Λ and ΔE.

Based on these variations of parameters, we can generate a map of values of F for human vessels to apply for a given simulation. In cases where the variation in vessel characteristics is relatively small, this can help to narrow the selected value of F from this map. We precompute F for our boundary condition as the local Womersley number may not be known for a given boundary location within a large vascular tree. In Fig. 2 we illustrate the distribution of values of F for vessels of radius 1 mm.

Figure 2.

Figure 2

Distribution of boundary velocity ratio for a range of physiologically relevant values of ΔE (0–10%) and Womersley number (0–10) in vessels with a radius of 1 mm.

Model verification

The capability of the HemeLB code to capture Womersley flow in a rigid vessel has been demonstrated to very good accuracy for a range of Womersley numbers in the work of Nash et al.11. The purpose of the following section is to build upon this to examine how the new and existing boundary conditions are able to replicate the elastic wall conditions. In21,22, the problem of flow through the carotid artery is examined as a test case for an elastic wall model. We demonstrate how our model is able to capture the essence of elastic wall flow in a similar domain whilst not losing computational performance compared to a rigid wall model. The performance of our model is verified through the comparison to the analytical solutions for Womersley flow in an elastic vessel with a particular focus on the oscillatory component of flow. We consider a cylinder of R = 3 mm and total length of 4 cm. The vessel walls are set at a thickness of h = 0.1R and have material properties of: Young’s modulus Y = 20 kPa, Poisson ratio σ = 0.5 and density of 1000 kg/m3. We assume that the fluid has a density of 1000 kg/m3 and viscosity of 0.004 Pa s. The applied oscillating pressure gradient has a period of π2 s. The flow corresponds to a Womersley number of 3.0. We link the expansion of the vessel to the pressure via ΔE=(1-σ2)R2Yh(p-P0), where P0 is the pressure at which ΔE=0. We use three different levels of grid refinement to study this case. Here we chose the lattice spacing, Δx, such that: R=50Δx, 100Δx and 200Δx. The time step was chosen for each level of grid refinement to ensure that the Young’s modulus of the vessel was consistent between cases. We also examined two levels of applied pressure gradient amplitude: kp=-50 Pa/m and -150 Pa/m. We compare the numerical results to those obtained from the analytical solutions. In particular we will examine the axial velocity obtained along the centreline of the cylindrical test domain and across the radius at a plane in the centre of the domain. As the radius of the cylinder is 3 mm, and the extension was observed to be relatively small, we decided to use a boundary velocity ratio of F=0.85. All simulations were conducted on the SuperMUC-NG supercomputer situated at the Leibniz Supercomputing Centre, Germany (https://doku.lrz.de/display/PUBLIC/SuperMUC-NG). We provide details on the computational configurations used for our simulations in the Appendix.

In Fig. 3 we compare the relative error of the central plane velocity profiles for the two pressure gradient cases at each of the geometric resolutions examined. Throughout this work, we have defined the error with the following function: error[%]=100(abs(VLBM)-abs(VTheory))max(abs(VTheory)), where VLBM and VTheory represent the calculated and analytical longitudinal velocity along the plane of interest. In our results, we allowed the simulation to overcome initialisation effects and then compared the calculated profiles at 5 stages within an oscillation period. Generally speaking, our model is able to replicate the expected analytical results with less than 10% error, with the greatest error being observed at the time steps with the lowest flow velocity magnitudes in the central plane where relative errors can be magnified. It should also be noted that there is varying error behaviour as the resolution of the cylinder is increased which may be related to the choice of boundary velocity ratio providing a better approximation of the elastic wall flows in some circumstances. In Fig. 4, we demonstrate similar trends for the axial velocity recorded along the central axis of the cylinder for the case of kp=-50 Pa/m. In several of the error plots presented in Figs. 3 and 4, the largest errors occur at t=0.45period and t=0.97period. These two cases represent the instantaneous flow profiles with the lowest velocity magnitudes and are where any absolute errors—perhaps induced by the choice of boundary velocity ratio—present within our model are magnified by the relative perspective presented by the plots.

Figure 3.

Figure 3

Relative error at the centre plane of the test cylinder comparing the current elastic wall model to the elastic wall analytical equations for the cases of (a)–(c) kp=-50 Pa/m and (d)–(f) kp=-150 Pa/m. (g)–(i) compare the rigid wall model to the elastic wall analytical equations for kp=-50 Pa/m. Note the significantly larger error at the walls compared to the equivalent results for the elastic wall model, In all cases, the centre of the cylinder is at R=0.0 m and the edge at R=0.003 m.

Figure 4.

Figure 4

Relative error along the central axis of the test cylinder comparing (a)–(c) the current elastic wall method and (d)–(f) the rigid wall method to the elastic wall analytical solution for the case of kp=-50 Pa/m. The flow inlet was at L=0.0 m and the outlet at L=0.04 m.

For the case kp=-50 Pa/m we also generated results when a rigid wall assumption is in place. Here we use the well-known LBM bounceback condition to represent the solid walls. Error profiles at the central plane are presented in Fig. 3 whilst comparison to the central axis velocity is provided in Fig. 4. In both of these cases, the error observed when rigid walls are enforced is notably greater than that seen with the our proposed elastic wall condition. These collective results indicate that we are able to capture the key flow results associated with an elastic wall better using our model than can be achieved with a rigid wall implementation.

To evaluate the performance change brought about by the use of our model for elastic walls, we conducted a small strong scaling study using the R=100Δx domain. In this comparison, we measured the simulation time to complete 5000 steps with both our elastic wall implementation and rigid walls using the bounceback method. This was conducted using between 1 and 256 nodes on SuperMUC-NG (48–12,288 cores). As can be seen in Fig. 5, the observed walltime and relative speed up to complete the simulation is almost identical for the two boundary implementations. This demonstrates that our model is able to better capture the expected flow in elastic vessels without a loss in performance compared to a rigid wall model. This shows that our approach overcomes the argument often used to justify the use of rigid wall models in a vascular simulation.

Figure 5.

Figure 5

Strong scaling results of HemeLB using our elastic wall implementation and the bounceback rigid wall model. The walltime and speed up results are virtually identical for the two cases. We provide lines of ideal performance and 75% efficiency as a guide.

Model application

In this section we demonstrate the behaviour of our model in patient specific vessels. The domain we are studying consists of the radial and ulnar arteries of the left forearm (see Fig. 6). To drive the flow, we provide a velocity profile to the inlet plane that is representative of the pulsatile flow within the vessels at this point in the vasculature, our profile contains an initial warm-up period before completing four heartbeat cycles (Fig. 6b). Since our model is in 3D, we provide a scaling factor at each point in the inlet plane to generate a Poiseuille-like flow profile within the vessel (Fig. 6c). Fixed pressure conditions11 were applied to the outlets. Based on the geometry of the vessels we have chosen a value for the boundary velocity ratio of F=0.025. To replicate larger vessels, we have taken the same domain and adjusted the size of the lattice spacing to dilate the vessels by a factor of approximately four. Whilst not representative of a particular vessel it carries the characteristics of a patient-specific geometry and allows us to present results representative of a more flexible vascular domain. In this second case we have used a value of F=0.5. Simulations of both domains with elastic and rigid walls were conducted on SuperMUC-NG; the computational details for these simulations are presented in the Appendix. Figure 7 illustrates the wall shear stress fields observed approximately 60% through the simulation time for both size scales. In both cases the lower shear stress observed in the elastic wall cases is consistent with observations made in other numerical studies of patient specific vessels28,29. This is made more explicitly clear when we compare the local, instantaneous wall shear stress between the rigid and elastic cases in Fig. 7e, f. Here the shape of our agreement plot of instantaneous wall shear stress is very similar to that presented in McGah et al.28 for time-averaged wall shear stress. This again demonstrates that our model is able to effectively capture behaviour expected from a fully coupled elastic wall model.

Figure 6.

Figure 6

Simulation domain and inlet conditions used in for the demonstration arterial studies. Here we simulated four heartbeats of pulsatile flow within the vessels using our elastic wall model and a rigid wall model. We also compared the behaviour at two different size scales to examine the effect of different boundary velocity ratios. (a) Illustrates the original flow domain itself within the left forearm. (b) Details the flow velocity provided to the inlet of the arterial geometry for the forearm flow cases. The first 0.8 s of the flow represents an initial warm-up period of flow within the system. (c) indicates the distribution of scaling weights applied to the flow velocity at the inlet of the arterial geometry.

Figure 7.

Figure 7

Wall shear stress fields for the arterial domain in their original (a, b) and dilated (c, d) dimensions after approximately 60% of the total simulation time. In figures (e, f) we present a pointwise comparison of instantaneous wall shear stress seen across the full domain of the arterial geometry in the rigid and elastic walled cases, the solid line represents the identity line. The shape of the plot—generally recording higher wall shear stress in the rigid walled case, especially at higher stress magnitudes—is consistent with that generated in other work using a fully coupled elastic wall model28. This result further demonstrates that our model is able to generate the elastic wall behaviour expected from a fully coupled approach whilst retaining the performance characteristics of a rigid wall implementation. The greater discrepancy between the rigid and elastic shear stresses in the dilated case also indicates how the choice of a larger boundary velocity ratio provides a more elastic vessel.

Discussion

When compared to other sources of uncertainty related to measuring and validating blood flow in personalised geometries—particularly those associated with clinical measurement techniques such as ultrasound or MRI, the error indicated by our simple model is of a similar order of magnitude. For example, Merkx et al.30,31 record a significant difference between the diameters recorded using an MRI technique and ultrasound and state that the MRI technique may overestimate vessel diameters by 38% potentially in part due to the sensitivity of the technique to patient position. Furthermore, Merkx et al.31 note that the diameter of the radial artery may vary by up to 4–7% during day-to-day function. Image analysis techniques used to assess medical images can generate similar levels of variation and uncertainty32. The uncertainty in velocity measurements from MRI is further discussed in Bruschewski et al.33. Indeed, Brindise et al.34 summarises the challenge in validating against MRI derived data as “A major challenge for any multi-modality study that uses in vivo measurements is that no ‘ground-truth’ flow field can be established”. Keeping these factors in mind, the errors presented from our model compared to those generated with a rigid wall approximation are more than acceptable.

One advantage of including elastic walls to a model is the inclusion of a windkessel effect that can smooth flow changes. We implemented a sinusoidal driving velocity to the R=50Δx cylinder and observed that, whilst initialisation transients lasted slightly longer in our model than with the rigid wall implementation, they possessed a smaller amplitude. Once flow was established, both models illustrated the same behaviour. This indicates that our boundary condition can provide a limited windkessel effect to flow when compared to a rigid wall boundary condition.

Further development of this model would be best focussed on how its implementation could be improved to effectively study domains with a greater spread in vascular diameters and resolution whilst retaining the locality of the implementation. As noted above this could be achieved with a local specification of the boundary velocity ratio. How a global (or regional) value for this term could be better tuned to different flow scenarios would also be of interest to the study of large-scale vascular structures. From the definition of the boundary velocity ratio, we would anticipate that vascular regions requiring a more flexible wall—such as larger arterial vessels or aneurysms—would demand a value of F closer to unity. Stiffer regions would require smaller values of the boundary velocity ratio, with F=0 being the limit for a rigid wall.

Conclusion

In this paper we have presented a boundary condition that allows key features of elastic walled flow such as velocity profiles near walls and wall shear stress variations to be captured without the need to implement a complex computational coupling with a solid mechanics solver. This has been implemented within the LBM-based, 3D blood flow simulator HemeLB. Our boundary condition is based on the application of a slip velocity at the wall of the domain that represents the flow at that physical location if an elastic wall was extended beyond it. This is calculated through a boundary velocity ratio that can be estimated based on the physical properties of the simulated vessel and the expressions for Womersley flow in an elastic cylinder. Whilst our model does not, and is not intended to, perfectly capture the analytical flow profiles expected within an elastic walled cylinder, it is significantly more accurate than results found using a rigid wall assumption. This was achieved with no loss of computational performance compared to the implementation of the bounceback boundary condition for rigid walls in HemeLB. These results indicate that our model would represent an effective return on the investment of implementing it within other LBM-based vascular simulation tools. Although we have discussed the boundary velocity ratio as a global parameter within this paper, there is no fundamental reason why it could not be tuned locally within a geometry of widely varying vessel diameters such as a whole human vascular tree.

With a view towards the development of a virtual human, our model will now permit HemeLB to conduct efficient, high resolution, 3D blood flow simulations with the effect of elastic walls included. Not having to support an explicit coupling for the solid mechanics of the vessel walls will reduce the communication burden of the simulation and allow resources to be deployed to other components of a virtual human model.

Supplementary Information

Acknowledgements

The authors acknowledge the Foundation for Research on Information Technologies in Society (IT’IS), particularly B. Lloyd and E. Neufeld, for providing the anatomical geometries used in this project as part of a collaboration within the CompBioMed Centre of Excellence.

Author contributions

J.M. developed and implemented the described method, conducted the simulations, prepared the figures and wrote the main manuscript text. P.C. led the funding project, supervised the work and obtained funding. Both authors reviewed the manuscript.

Funding

We acknowledge funding support from European Commission CompBioMed Centre of Excellence (Grant Nos. 675451 and 823712). Support from the UK Engineering and Physical Sciences Research Council under the project ‘UK Consortium on Mesoscale Engineering Sciences (UKCOMES)’ (Grant No. EP/R029598/1) is gratefully acknowledged. We acknowledge funding support from MRC for a Medical Bioinformatics grant (MR/L016311/1), and special funding from the UCL Provost. The authors gratefully acknowledge the Gauss Centre for Supercomputing e.V. (www.gauss-centre.eu) for funding this project by providing computing time on the GCS Supercomputer SuperMUC-NG at Leibniz Supercomputing Centre (www.lrz.de).

Competing interests

The authors declare no competing interests.

Footnotes

Publisher's note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary Information

The online version contains supplementary material available at 10.1038/s41598-021-03584-2.

References

  • 1.Sheng C, Sarwal SN, Watts KC, Marble AE. Computational simulation of blood flow in human systemic circulation incorporating an external force field. Med. Biol. Eng. Comput. 1995;33(1):8–17. doi: 10.1007/BF02522938. [DOI] [PubMed] [Google Scholar]
  • 2.Müller LO, Toro EF. A global multiscale mathematical model for the human circulation with emphasis on the venous system. Int. J. Numer. Methods Biomed. Eng. 2014;30(7):681–725. doi: 10.1002/cnm.2622. [DOI] [PubMed] [Google Scholar]
  • 3.Mynard JP, Smolich JJ. One-dimensional haemodynamic modeling and wave dynamics in the entire adult circulation. Ann. Biomed. Eng. 2015;43(6):1443–1460. doi: 10.1007/s10439-015-1313-8. [DOI] [PubMed] [Google Scholar]
  • 4.Feiger B, Gounley J, Adler D, Leopold JA, Draeger EW, Chaudhury R, Ryan J, Pathangey G, Winarta K, Frakes D, Michor F, Randles A. Accelerating massively parallel hemodynamic models of coarctation of the aorta using neural networks. Sci. Rep. 2020;10(1):9508. doi: 10.1038/s41598-020-66225-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5.Feiger B, Adebiyi A, Randles A. Multiscale modeling of blood flow to assess neurological complications in patients supported by venoarterial extracorporeal membrane oxygenation. Comput. Biol. Med. 2021;129:104155. doi: 10.1016/j.compbiomed.2020.104155. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.McCullough JWS, Richardson RA, Patronis A, Halver R, Marshall R, Ruefenacht M, Wylie BJN, Odaker T, Wiedemann M, Lloyd B, Neufeld E, Sutmann G, Skjellum A, Kranzlmueller D, Coveney PV. Towards blood flow in the virtual human: Efficient self-coupling of hemelb. Interface Focus. 2021;11(1):20190119. doi: 10.1098/rsfs.2019.0119. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.HemeLB. (2019). www.hemelb.org.
  • 8.Mazzeo MD, Coveney PV. HemeLB: A high performance parallel lattice-Boltzmann code for large scale fluid flow in complex geometries. Comput. Phys. Commun. 2008;178(12):894–914. doi: 10.1016/j.cpc.2008.02.013. [DOI] [Google Scholar]
  • 9.Bernabeu MO, Nash RW, Groen D, Carver HB, Hetherington J, Krüger T, Coveney PV. Impact of blood rheology on wall shear stress in a model of the middle cerebral artery. Interface Focus. 2013;3(2):20120094. doi: 10.1098/rsfs.2012.0094. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Bernabeu MO, Jones ML, Nielsen JH, Krüger T, Nash RW, Groen D, Schmieschek S, Hetherington J, Gerhardt H, Franco CA, Coveney PV. Computer simulations reveal complex distribution of haemodynamic forces in a mouse retina model of angiogenesis. J. R. Soc. Interface. 2014;11(99):20140543. doi: 10.1098/rsif.2014.0543. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Nash RW, Carver HB, Bernabeu MO, Hetherington J, Groen DK, Krüger T, Coveney PV. Choice of boundary condition for lattice-Boltzmann simulation of moderate-Reynolds-number flow in complex domains. Phys. Rev. E. 2014;89:023303. doi: 10.1103/PhysRevE.89.023303. [DOI] [PubMed] [Google Scholar]
  • 12.Groen D, Richardson RA, Coy R, Schiller UD, Chandrashekar H, Robertson F, Coveney PV. Validation of patient-specific cerebral blood flow simulation using transcranial doppler measurements. Front. Physiol. 2018;9:721. doi: 10.3389/fphys.2018.00721. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Patronis A, Richardson RA, Schmieschek S, Wylie BJN, Nash RW, Coveney PV. Modeling patient-specific magnetic drug targeting within the intracranial vasculature. Front. Physiol. 2018;9:331. doi: 10.3389/fphys.2018.00331. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Succi S. The Lattice Boltzmann Equation for Fluid Dynamics and Beyond. Oxford: Oxford University Press; 2001. [Google Scholar]
  • 15.Mohamad AA. Lattice Boltzmann Method: Fundamentals and Engineering Applications with Computer Codes. London: Springer; 2011. [Google Scholar]
  • 16.Guo Z, Shu C. Lattice Boltzmann Method and Its Applications in Engineering. Singapore: World Scientific; 2013. [Google Scholar]
  • 17.Krüger T, et al. The Lattice Boltzmann Method: Principles and Practice. Berlin: Springer; 2017. [Google Scholar]
  • 18.Succi S. The Lattice Boltzmann Equation: For Complex States of Flowing Matter. Oxford: Oxford University Press; 2018. [Google Scholar]
  • 19.Womersley JR. Oscillatory motion of a viscous liquid in a thin-walled elastic tube—I: The linear approximation for long waves. Lond. Edinb. Dublin Philos. Mag. J. Sci. 1955;46(373):199–221. doi: 10.1080/14786440208520564. [DOI] [Google Scholar]
  • 20.Womersley JR. Oscillatory flow in arteries: The constrained elastic tube as a model of arterial flow and pulse transmission. Phys. Med. Biol. 1957;2(2):178–187. doi: 10.1088/0031-9155/2/2/305. [DOI] [PubMed] [Google Scholar]
  • 21.Figueroa, C. A. A Coupled-Momentum Method to Model Blood Flow and Vessel Deformation in Human Arteries: Applications in Disease Research and Simulation-Based Medical Planning. PhD thesis, Stanford University, (2006). https://bloodflow.engin.umich.edu/wp-content/uploads/sites/165/2014/08/Thesis-Final-corrected.pdf.
  • 22.Filonova V, Arthurs CJ, Vignon-Clementel IE, Figueroa CA. Verification of the coupled-momentum method with Womersley’s deformable wall analytical solution. Int. J. Numer. Methods Biomed. Eng. 2020 doi: 10.1002/cnm.3266. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Fang H, Lin Z, Wang Z. Lattice Boltzmann simulation of viscous fluid systems with elastic boundaries. Phys. Rev. E. 1998;57:R25–R28. doi: 10.1103/PhysRevE.57.R25. [DOI] [Google Scholar]
  • 24.Leitner D, Wassertheurer S, Hessinger M, Holzinger A. A lattice Boltzmann model for pulsative blood flow in elastic vessels. Elektrotechn. Inform. 2006;123(4):152–155. doi: 10.1007/s00502-006-0332. [DOI] [Google Scholar]
  • 25.Descovich, X., Pontrelli, G., Succi, S., Melchionna, S. & Bammer, M. Modeling elastic walls in lattice boltzmann simulations of arterial blood flow. in 7th Vienna International Conference on Mathematical Modelling. IFAC Proceedings Volumes, vol. 45(2), 936–941. 10.3182/20120215-3-AT-3016.00165 (2012).
  • 26.Atkinson G, Batterham AM. The percentage flow-mediated dilation index: A large-sample investigation of its appropriateness, potential for bias and causal nexus in vascular medicine. Vasc. Med. 2013;18(6):354–365. doi: 10.1177/1358863X13508446. [DOI] [PubMed] [Google Scholar]
  • 27.Guo Z, Zheng C, Shi B. An extrapolation method for boundary conditions in lattice Boltzmann method. Phys. Fluids. 2002;14(6):2007–2010. doi: 10.1063/1.1471914. [DOI] [Google Scholar]
  • 28.McGah PM, Leotta DF, Beach KW, Aliseda A. Effects of wall distensibility in hemodynamic simulations of an arteriovenous fistula. Biomech. Model. Mechanobiol. 2014;13(3):679–695. doi: 10.1007/s10237-013-0527-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Reymond P, Crosetto P, Deparis S, Quarteroni A, Stergiopulos N. Physiological simulation of blood flow in the aorta: Comparison of hemodynamic indices as predicted by 3-D FSI, 3-D rigid wall and 1-D models. Med. Eng. Phys. 2013;35(6):784–791. doi: 10.1016/j.medengphy.2012.08.009. [DOI] [PubMed] [Google Scholar]
  • 30.Merkx, M. A. G., Huberts, W., Bosboom, E. M. H., Bode, A. S., Oliván Bescós, J., Tordoir, J. H. M., Breeuwer, M., & van de Vosse, F. N. The benefit of non contrast-enhanced magnetic resonance angiography for predicting vascular access surgery outcome: A computer model perspective. PLOS ONE8(2), 1–9. 10.1371/journal.pone.0053615 (2013a). [DOI] [PMC free article] [PubMed]
  • 31.Merkx MAG, Bosboom EMH, Bode AS, Oliván Bescós J, Breeuwer M, Tordoir JHM, van de Vosse FN. Non contrast-enhanced MRA versus ultrasound blood vessel assessment to determine the choice of hemodialysis vascular access. J. Vasc. Access. 2013;14(4):348–355. doi: 10.5301/jva.5000153. [DOI] [PubMed] [Google Scholar]
  • 32.Kaufhold L, Harloff A, Schumann C, Krafft AJ, Hennig J, Hennemuth A. Image-based assessment of uncertainty in quantification of carotid lumen. J. Med. Imaging. 2018;5(3):1–9. doi: 10.1117/1.JMI.5.3.034003. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Bruschewski M, Freudenhammer D, Buchenberg WB, Schiffer H, Grundmann S. Estimation of the measurement uncertainty in magnetic resonance velocimetry based on statistical models. Exp. Fluids. 2016;57(5):83. doi: 10.1007/s00348-016-2163-3. [DOI] [Google Scholar]
  • 34.Brindise MC, Rothenberger S, Dickerhoff B, Schnell S, Markl M, Saloner D, Rayz VL, Vlachos PP. Multi-modality cerebral aneurysm haemodynamic analysis: In vivo 4D flow MRI, in vitro volumetric particle velocimetry and in silico computational fluid dynamics. J. R. Soc. Interface. 2019;16(158):20190465. doi: 10.1098/rsif.2019.0465. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

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

Supplementary Materials


Articles from Scientific Reports are provided here courtesy of Nature Publishing Group

RESOURCES