The mechanics of biological fluids is an important topic in biomechanics, often requiring the use of computational tools to analyze problems with realistic geometries and material properties. This study describes the formulation and implementation of a finite element framework for computational fluid dynamics (CFD) in FEBio, a free software designed to meet the computational needs of the biomechanics and biophysics communities. This formulation models nearly incompressible flow with a compressible isothermal formulation that uses a physically realistic value for the fluid bulk modulus. It employs fluid velocity and dilatation as essential variables: The virtual work integral enforces the balance of linear momentum and the kinematic constraint between fluid velocity and dilatation, while fluid density varies with dilatation as prescribed by the axiom of mass balance. Using this approach, equal-order interpolations may be used for both essential variables over each element, contrary to traditional mixed formulations that must explicitly satisfy the inf-sup condition. The formulation accommodates Newtonian and non-Newtonian viscous responses as well as inviscid fluids. The efficiency of numerical solutions is enhanced using Broyden's quasi-Newton method. The results of finite element simulations were verified using well-documented benchmark problems as well as comparisons with other free and commercial codes. These analyses demonstrated that the novel formulation introduced in FEBio could successfully reproduce the results of other codes. The analogy between this CFD formulation and standard finite element formulations for solid mechanics makes it suitable for future extension to fluid–structure interactions (FSIs).
Introduction
The mechanics of biological fluids is an important topic in biomechanics, most notably for the study of blood flow through the cardiovascular system and related biomedical devices, cerebrospinal fluid flow, airflow through the respiratory system, biotribology by fluid film lubrication, and flow through microfluidic biomedical devices. Therefore, the application domain of multiphysics computational frameworks geared toward biomechanics and biophysics, such as the free finite element software FEBio,1 can be expanded by incorporating solvers for computational fluid dynamics (CFD). Biological fluids are generally modeled as incompressible materials, though compressible flow may be needed to analyze wave propagation, for example, in acoustics (airflow through vocal folds) and the analysis of ultrasound propagation for imaging blood flow.
Many open-source CFD codes are currently available in the public domain, though few are geared specifically for applications in biomechanics. OpenFOAM2 has many solvers applicable to a very broad range of fluid analyses, using the finite volume method. Other open-source CFD codes are typically more specialized: SU23 is geared toward aerospace design, Fluidity4 is well suited for geophysical fluid dynamics, and REEF3D5 is focused on marine applications. Some CFD codes explore alternative solution methods: Palabos6 uses the lattice Boltzmann method, LIGGGHTS7 uses a discrete-element method particle simulation, the Gerris Flow Solver8 uses an octree finite volume discretization, and COOLFluiD9 uses either a spectral finite difference solver or a finite element solver. Currently, the CFD code most relevant to biomechanics is SimVascular, a finite element code specifically designed for cardiovascular fluid mechanics, “providing a complete pipeline from medical image data segmentation to patient-specific blood flow simulation and analysis.”10 This open-source code [1] is based on the original work of Taylor [2]; it uses the flow solver from the PHASTA project11 [3].
In contrast, FEBio was originally developed with a focus on the biomechanics of soft tissues, providing the ability to model nonlinear anisotropic tissue responses under finite deformation. It accommodates hyperelastic, viscoelastic, biphasic (poroelastic), and multiphasic material responses which can combine solid mechanics and mass (solvent and solute) transport, with a wide range of constitutive models relevant to biological tissues and cells [4–6]. It also provides robust algorithms to model tied or sliding contact under large deformations between elastic, biphasic, or multiphasic materials [7,8]. More recently, FEBio has incorporated reactive mechanisms, including chemical reactions in multiphasic media, growth mechanics, reactive viscoelasticity, and reactive damage mechanics [9–11]. Many of these features are specifically geared toward applications in biomechanics, including growth and remodeling and mechanobiology.
Our medium-term goal is to expand the capabilities of FEBio by including robust fluid–structure interactions (FSIs). Such interactions occur commonly in biomechanics and biophysics, most notably in cardiovascular mechanics where blood flows through the deforming heart and vasculature [12–14], diarthrodial joint lubrication where pressurized synovial fluid flows between deforming articular layers [15], cerebrospinal mechanics where fluid flow through ventricular cavities may cause significant deformation of surrounding soft tissues [16–18], vocal fold and upper airway mechanics [19,20], viscous flow over endothelial cells [21,22], canalicular and lacunar flow around osteocytes resulting from bone deformation [23–25], and many applications in biomedical device design [26–28]. Some FSI capabilities already exist in several of the open-source CFD codes referenced previously; these implementations were developed as addendums to sophisticated fluid analyses, often employing a limited range of solid material responses, such as small strain analyses of linear isotropic elastic solids. By formulating a CFD code in FEBio, we expect to capitalize on the much broader library of solid and multiphasic material models already available in that framework to considerably expand the range of FSI analyses in biomechanics. Our long-term goal is to expand these FSI features to incorporate chemical reactions within the fluid and at the fluid–solid interface, growth, and remodeling of the solid matrix of multiphasic domains interfaced with the fluid, active transport of solutes across cell membranes as triggered by mechanical, electrical, or chemical signals at fluid–membrane interfaces, cellular and muscle contraction mechanisms, and a host of other mechanisms relevant to biomechanics, biophysics, and mechanobiology, complementing many of the similar features already implemented in FEBio's elastic, biphasic, and multiphasic domain frameworks. The FEBio CFD formulation proposed in this study represents a significant milestone toward that long-term goal.
Since FEBio uses the finite element method, this study formulates a finite element CFD code. Finite element analyses of incompressible flow typically enforce the incompressibility condition using either mixed formulations [29], which solve for the fluid pressure by enforcing zero divergence of the velocity, or the penalty method [30,31], where the fluid pressure is proportional to the divergence of the fluid velocity via a penalty factor [32]. The mixed formulation results in a coefficient matrix that must pass the inf-sup condition to produce accurate results, using a finite element interpolation of the fluid pressure with a lower order than that of the fluid velocity [32–34].
The most broadly adopted CFD schemes today rely on stabilization methods, such as streamline-upwind/Petrov–Galerkin (SUPG), pressure-stabilizing/Petrov–Galerkin and Galerkin/least-squares [35–39]. These schemes have three principal benefits: They stabilize the flow and produce smooth results even on coarse meshes; they allow the use of equal interpolation for the velocity and pressure; and the resulting equations are amenable to iterative solving, with suitable preconditioning. They also have some drawbacks: The finite element formulation is more complex because it requires additional terms to supplement the standard Galerkin residual; these terms involve second-order spatial derivatives, which may be neglected in linear elements [40] but must be included in higher-order interpolations [39,41,42]; and they require the careful formulation of a weight factor, called the stabilization parameter τ, whose value depends on the local Reynolds number, some characteristic element length along the streamline direction, and some special considerations for the element shape and interpolation order [41,42]; this parameter critically controls the effectiveness of this stabilization scheme.
In this study, we overcame the constraint of the inf-sup condition by employing a novel approach to analyze isothermal compressible flow using fluid dilatation (the relative change in fluid volume) as an essential variable, instead of fluid pressure or density. This approach also allowed us to forgo the application of stabilization methods, reducing the complexity of the implementation and avoiding the need to formulate and use a stabilization parameter suitable for various element types and orders. Just like fluid velocity, dilatation is a kinematic quantity that may further serve as a state variable in the formulation of functions of state (such as viscous stress and elastic pressure). Another benefit of this approach is that the dependence of density on dilatation is obtained by analytically integrating the mass balance equation, as conventionally done in finite elasticity. In effect, we adapted an approach from finite deformation elasticity to describe the elastic compressibility of the fluid, using the dilatation as the only required component of the strain tensor, since fluids are isotropic and cannot sustain shear stresses under steady shear strains. In this approach, fluid velocity and dilatation may be obtained by satisfying the momentum balance equation as well as the fundamental kinematic relation between the material time derivative of the dilatation and the divergence of the velocity. The finite element implementation, using a standard Galerkin residual formulation, produces accurate numerical solutions even when using equal-order interpolation for the velocity and dilatation.
Finite Element Implementation
Governing Equations.
where is the density in the reference configuration (when ). Since is obtained by integrating the above-mentioned material time derivative of , it is an intrinsic material property that must be invariant in time and space.
and is the free energy density of the fluid (free energy per volume of the continuum in the reference configuration). The axiom of entropy inequality dictates that cannot be a function of the rate of deformation . In contrast, the viscous stress is generally a function of .
In our finite element treatment, we use as nodal variables, implying that our formulation automatically enforces continuity of these variables across element boundaries, thus and . Based on Eqs. (2.7) and (2.9), it follows that the density and elastic pressure are continuous across element boundaries in this formulation, . Thus, the mass jump in Eq. (2.10) is automatically satisfied, and the momentum jump in Eq. (2.11) reduces to , requiring continuity of the traction, or more specifically according to Eq. (2.8), the continuity of the viscous traction , since p is automatically continuous.
Virtual Work and Weak Form.
Here, is the boundary of is a differential area on is the viscous component of the traction , and is the velocity normal to the boundary , with representing the outward normal on . From these expressions, it becomes evident that essential (Dirichlet) boundary conditions may be prescribed on , while natural (Neumann) boundary conditions may be prescribed on and . The appearance of velocity in both essential and natural boundary conditions may seem surprising at first. To better understand the nature of these boundary conditions, it is convenient to separate the velocity into its normal and tangential components, , where . In particular, for inviscid flow, the viscous stress and its corresponding traction are both zero, leaving as the sole natural boundary condition; similarly, J becomes the only essential boundary condition in such flows, since is unknown a priori on a frictionless boundary and must be obtained from the solution of the analysis.
In general, prescribing J is equivalent to prescribing the elastic fluid pressure, since p is only a function of J. On a boundary where no conditions are prescribed explicitly, we conclude that and , which represents a frictionless wall. Conversely, it is possible to prescribe on a boundary to produce a desired inflow or outflow while simultaneously stabilizing the flow conditions by prescribing a suitable viscous traction. Prescribing essential boundary conditions and J determines the tangential velocity on a boundary as well as the elastic fluid pressure p, leaving the option to also prescribe the normal component of the viscous traction, , to completely determine the normal traction (or else naturally equals zero). Mixed boundary conditions represent common physical features: Prescribing completely determines the velocity on a boundary; prescribing completely determines the traction on a boundary. Note that are mutually exclusive boundary conditions, and the same holds for and the tangential component of the viscous traction, .
Temporal Discretization and Linearization.
Here, is the current time increment and ξ is a parameter chosen as described in Ref. [44]; for example, yields the backward Euler scheme, in which case and , where are the velocity and volume ratio, respectively, at the previous time . More generally, ξ is evaluated from the spectral radius for an infinite time-step, (see Appendix).
Note that exhibits minor symmetries because of the symmetries of ; in Cartesian components, we have and . In general, does not exhibit major symmetry (), though the common constitutive relations adopted in fluid mechanics produce such symmetry as shown below.
We may define the fluid dilatation as an alternative essential variable, since initial and boundary conditions are more convenient to handle in a numerical scheme than . It follows that and . Therefore, the changes to the above-mentioned equations are minimal, simply requiring the substitution . Steady-state analyses may be obtained by setting the terms involving to zero in Eqs. (2.18)–(2.20), and (2.22).
Constitutive Relations.
The term containing is the only one that does not exhibit major symmetry. In Newtonian fluids, and are independent of ; in incompressible fluids, they are independent of J (since remains constant and ). Thus, for both of these cases the term containing drops out and exhibits major symmetry.
Explicit forms for the dependence of are not illustrated here, since viscosity generally shows negligible dependence on pressure (thus J) over typical ranges of pressures in fluids, hence in most analyses.
where is a time constant, is a parameter governing the power-law response, is the viscosity when and is the viscosity as .
By definition, the effective bulk modulus of a fluid is , and K is the value of evaluated at . Thus, for an ideal gas we have , which is the absolute pressure in the reference state.
Spatial Discretization.
Here, are nodal values of and J that evolve with time. In contrast to classical mixed formulations for incompressible flow [32], which solve for the pressure instead of Eq. (2.6), equal-order interpolation is acceptable in this formulation since the governing equations for involve spatial derivatives of both variables (). The expressions of Eq. (2.32) may be used to evaluate , , etc. Similar interpolations are used for virtual increments , as well as real increments and .
Condition Number.
The effective fluid bulk modulus only appears within , as a linear term, as may be construed from Eqs. (2.38) and (2.23). Furthermore, is not zero in general, as may be noted from Eq. (2.38). For this matrix structure, it can be shown that the condition number becomes proportional to the bulk modulus as . Nevertheless, similar to the argument presented by Ryzhakov et al. [48], the stabilization provided by the nonzero submatrix is sufficient to produce a well-behaved solution even for very large values of .
In contrast, mixed formulations solve for the velocity and pressure p using the momentum balance, Eq. (2.1), supplemented by the mass balance for incompressible flow. The resulting tangent matrix has a zero entry in lieu of , and this type of matrix must pass the inf-sup condition to prevent an overconstrained system of equations [32–34]. Stabilization methods such as the SUPG method, which have been introduced to minimize spurious velocity oscillations on coarse meshes [35], populate this matrix entry [2,36], allowing the use of equal-order interpolations for velocity and pressure. The characteristic-based split algorithm presented by Zienkiewicz and Codina similarly produces a nonzero entry for arbitrary velocity and pressure interpolations, when using a suitable dual time-stepping scheme [49,50]. Indeed, these and other investigators have solved for the pressure p using the relation [48–50], which may be reproduced from our treatment by evaluating (valid at constant temperature), substituting from Eq. (2.6), and using the definition of above. However, it should be noted that these prior studies [48–50] used this relation with , which is only appropriate in a material description, whereas the above-mentioned derivations show that should be evaluated in a spatial description for consistency.
Special Boundary Conditions
Backflow Stabilization.
A (viscous) tangential traction is implemented as a separate flow stabilization method in Sec. 2.7.2, applicable to inlet or outlet surfaces, without a conditional requirement based on the sign of .
Tangential Flow Stabilization.
For certain outlet conditions, using the natural boundary condition may lead to flow instabilities. It is possible to minimize these effects by prescribing a tangential viscous traction onto the boundary surface, which opposes this tangential flow. Optionally, this condition may be combined with the backflow stabilization described previously.
Flow Resistance.
where is the resistance. Using the pressure–dilatation relation Eq. (2.30), equivalent to , this pressure may be prescribed as an essential boundary condition on the dilatation e.
Solver.
The numerical solution of the nonlinear system of equations is performed using Newton's method for the first iteration of a time point, followed by Broyden quasi-Newton updates [54], until convergence is achieved at that time-step. The stiffness matrix is thus evaluated only once for that time-step. Optionally, the stiffness matrix evaluation and Newton update may be postponed at the start of subsequent time-steps until Broyden updates exceed a user-defined value (e.g., 50 updates); this approach offers considerable numerical efficiency as illustrated in the results later. Relative convergence is achieved at each discrete time when the vector of nodal degree-of-freedom (DOF) increments (consisting of or values at all unconstrained nodes) at the kth iteration satisfies , where represents the relative tolerance criterion ( for both in the problems analyzed later, unless specified otherwise). An absolute convergence criterion is also set based on the magnitude of the residual vector. For Newton updates, FEBio uses a variety of linear equation solvers, among which the most efficient is the PARDISO parallel direct sparse solver for the solution of a linear system of equations with nonsymmetric coefficient matrix [55].12 Results reported later employ the Intel Math Kernel Library implementation of PARDISO.13
Verifications and Validations
In the sections below, we report the results of standard benchmark problems for computational fluid dynamics, followed by some comparisons of FEBio simulations with Simvascular and the commercial code ANSYS Fluent.14 All analyses use a Newtonian fluid with ; similarly, all analyses use the backward Euler time integration scheme unless specified. Additional analyses are described in the Supplementary Materials section, which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection, including two-dimensional (2D) flow past a cylinder at Re = 100 (Sec. S3 of the Supplementary Materials section, which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection.), exhibiting the characteristic Kármán vortex street and fluctuations in drag and lift coefficients, and flow in a model of an ascending and descending aorta, illustrating flow resistance, backflow stabilization, and tangential stabilization.
Lid-Driven Cavity Flow.
This is a benchmark 2D steady flow problem, defined over a square region with boundary conditions described in Fig. 1. In the current implementation, it was necessary to set the dilatation e to zero at the top corners, as they represent singularity points where e would otherwise blow up in a numerical analysis (since at those points). The Reynolds number for this problem, , is based on the length of the square sides, and the velocity V of the lid. FEBio results are shown for (with , ), using an unstructured mesh of linear (four-node) tetrahedral elements with mesh refinement near the boundaries (96,318 elements, 26,838 nodes), as well as a biased mesh of linear (eight-node) hexahedral elements (128 × 128 elements, 33,282 nodes). All analyses used a bulk modulus . Transient analyses were performed using increasing time increments up to time 103, at which point a steady response was observed. Representative vorticity contours are shown in Fig. 1. A comparison of steady-state horizontal and vertical velocity profiles across the midsections of the domain is provided against the benchmark numerical solution of Ghia et al. [56] in Fig. 2. The results show equally good velocity agreement for structured hexahedral and unstructured tetrahedral meshes, though contour plots of pressure and vorticity are evidently smoother when using the structured mesh.

Lid-driven cavity flow: Unstructured tetrahedral mesh (left column) and structured hexahedral mesh (right column). Vorticity contours are shown for (middle row) and (bottom row).
![Velocity profiles in lid-driven cavity flow, for hexahedral and tetrahedral meshes, compared to Ghia et al. [56]: (a) v1 versus x2 along vertical centerline (x1=0.5); and (b) v2 versus x1 along horizontal centerline (x2=0.5)](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f002.png?Expires=1683090161&Signature=24gHnS8Zd5z48aoIejG8FW1xh~vKYzNZu5BZKQ1mluQYwLtYhTv0DVXlb58F~gvKpo-ZqGvoIZtL35QAaFZ1OgwE17TUy9aYwmamU2VaK9LfwcVKE0A-sdPaDoBR8GPNii2k4aPdUyxEqFuxC~THJ2P9PclCAaRcCw~P3A78fPOiAaFL3vbNN2n7djwBw7GsTK11oJASQ0nb06SW1Ng-PAXCQtBkNQVnyFvW4MQMDAY7Y8yuoF1WT6B2ETqfJ8qOWA--e~nkJQAj62kEOWvqtwgi4LZ8A0Ur2qWJKO9g6U6qnNrDmK7xmwi-c9z0Er2gjC3IwMNUfNOxJA9CTlO5-Q__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Velocity profiles in lid-driven cavity flow, for hexahedral and tetrahedral meshes, compared to Ghia et al. [56]: (a) versus x2 along vertical centerline (); and (b) versus x1 along horizontal centerline ()
![Velocity profiles in lid-driven cavity flow, for hexahedral and tetrahedral meshes, compared to Ghia et al. [56]: (a) v1 versus x2 along vertical centerline (x1=0.5); and (b) v2 versus x1 along horizontal centerline (x2=0.5)](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f002.png?Expires=1683090161&Signature=24gHnS8Zd5z48aoIejG8FW1xh~vKYzNZu5BZKQ1mluQYwLtYhTv0DVXlb58F~gvKpo-ZqGvoIZtL35QAaFZ1OgwE17TUy9aYwmamU2VaK9LfwcVKE0A-sdPaDoBR8GPNii2k4aPdUyxEqFuxC~THJ2P9PclCAaRcCw~P3A78fPOiAaFL3vbNN2n7djwBw7GsTK11oJASQ0nb06SW1Ng-PAXCQtBkNQVnyFvW4MQMDAY7Y8yuoF1WT6B2ETqfJ8qOWA--e~nkJQAj62kEOWvqtwgi4LZ8A0Ur2qWJKO9g6U6qnNrDmK7xmwi-c9z0Er2gjC3IwMNUfNOxJA9CTlO5-Q__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Velocity profiles in lid-driven cavity flow, for hexahedral and tetrahedral meshes, compared to Ghia et al. [56]: (a) versus x2 along vertical centerline (); and (b) versus x1 along horizontal centerline ()
Flow Past a Backward Facing Step.
This benchmark 2D flow problem, described in Ref. [50], may be compared to experimental measurements of fluid velocity [57], thus serving as a code validation problem. The domain dimensions in the plane and mesh are shown in Fig. 3, with a step height ; the unstructured mesh consisted of 27,008 four-node tetrahedral elements (28,872 nodes) with a thickness 0.1 along . The fluid properties were , and and the prescribed inlet velocity varied along according to experimental data, with a mean value V producing . A steady-state analysis was performed in FEBio, producing velocity and pressure contours as shown in Fig. 3. Velocity profiles were compared to experimental results in Fig. 4, showing very good agreement.

Flow past backward facing step with . Top panel shows the geometry, tetrahedral mesh, and boundary conditions. Middle panel shows contours of horizontal velocity component ; bottom panel shows pressure contours.
![Velocity profiles v1(x1,x2) in the flow past a backward facing step. Solid curves represent the finite element solution and symbols represent experimental data [57].](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f004.png?Expires=1683090161&Signature=RgoeKGHLkyoh9Q167grB5XG39qKiOT7uQUrba5ImJS8xDu8ZEGHeYLrE0eSFU6NuUUP0Uoijl~A4p2q8rQ5AaLOBMbisbdV0loAX1uSY37ZoJyVgwlv5I97KryWjnv-uy4HjmZOq5ASYNTn~GopQHjNcBiNGr1hYA1zSjkhS78Kn0FwewwxkSPebsRDvT3357wUym3Xi2z7BH8EVdIFMgN9n52XdWOPzoeybbtOvo1Se7fX5n2kQ0pCReR56nWPgbBNv1eTlk1qpEIjqxqiGtAJC8wfIgtjd1lhqFdYD2xxiuP6osR~or6eUm0QcHTqtujRBKtXYGR2MuBWQzzORVw__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Velocity profiles in the flow past a backward facing step. Solid curves represent the finite element solution and symbols represent experimental data [57].
![Velocity profiles v1(x1,x2) in the flow past a backward facing step. Solid curves represent the finite element solution and symbols represent experimental data [57].](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f004.png?Expires=1683090161&Signature=RgoeKGHLkyoh9Q167grB5XG39qKiOT7uQUrba5ImJS8xDu8ZEGHeYLrE0eSFU6NuUUP0Uoijl~A4p2q8rQ5AaLOBMbisbdV0loAX1uSY37ZoJyVgwlv5I97KryWjnv-uy4HjmZOq5ASYNTn~GopQHjNcBiNGr1hYA1zSjkhS78Kn0FwewwxkSPebsRDvT3357wUym3Xi2z7BH8EVdIFMgN9n52XdWOPzoeybbtOvo1Se7fX5n2kQ0pCReR56nWPgbBNv1eTlk1qpEIjqxqiGtAJC8wfIgtjd1lhqFdYD2xxiuP6osR~or6eUm0QcHTqtujRBKtXYGR2MuBWQzzORVw__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Velocity profiles in the flow past a backward facing step. Solid curves represent the finite element solution and symbols represent experimental data [57].
Inviscid Flow One-Dimensional Wave Propagation.
where , and V is the spatial domain volume. A plot of the total energy (Fig. 5(b)) shows that the Euler scheme caused considerable damping in this analysis, with decreasing by 65% of its peak value, whereas (the midpoint rule) produced zero dissipation (no damping, within six significant digits), as would be expected from theory. Moreover, produced only a small amount of energy dissipation over the duration of this analysis (less than two percent), whereas produced less than 0.1% loss. In contrast, Euler's method required only 2978 iterations for the entire analysis (averaging 2.48 iterations for solving the nonlinear system of equations at each time-step); for the remaining analyses, the total number of iterations was , , and .

1D wave propagation in an inviscid fluid: (a) pressure profile as wave propagates rightward starting from , reflects at right wall (), and reverses direction; finite element result using Euler integration is shown in orange, generalized α-method with is shown in blue and (b) fluid internal + kinetic energy , evaluated over entire domain , as it varies with time t, using Euler method and generalized α-method with various values of .

1D wave propagation in an inviscid fluid: (a) pressure profile as wave propagates rightward starting from , reflects at right wall (), and reverses direction; finite element result using Euler integration is shown in orange, generalized α-method with is shown in blue and (b) fluid internal + kinetic energy , evaluated over entire domain , as it varies with time t, using Euler method and generalized α-method with various values of .
Flow Past Block in a Narrow Channel.
This 2D flow problem examined the effectiveness of backflow and tangential stabilization. A channel of length and height was used, with a 1 × 1 block placed at the channel bottom, a distance D = 3 from the inflow boundary; the dimensions and mesh (3292 eight-node hexahedral elements and eight 6-node pentahedral elements, with 6880 nodes) are shown in Fig. 6, along with boundary conditions. The fluid properties were , . A uniform horizontal velocity V was prescribed at the inflow boundary, ramping up linearly from 0 to , and then maintained constant up to , producing based on the block size. Time increments were used for this transient flow analysis. Both backflow stabilization (β = 1) and tangential stabilization (β = 1) were prescribed at the outlet boundary. Using Euler integration, significant vortex shedding was observed until , after which the flow settled into a metastable state until , then transitioned toward the steady-state response, achieved at . Using generalized α-integration, the solution never achieved a steady-state; instead, it settled into a periodic response around , with a Strouhal number of 0.153. This periodic response was characterized by vortices alternatively shedding from the block and top boundary, producing periodic flow reversals across the top and bottom halves of the outlet (Fig. 6). Without backflow and tangential stabilization, the solution failed to converge beyond with Euler integration, and for generalized α-integration, soon after flow reversal began to develop at the outlet boundary.

Flow past block in a narrow channel. Top panel shows geometry, mesh, and boundary conditions. Remaining panels show vorticity contour plots and velocity vector plots () at four time points within a cycle of the periodic response achieved after .
Carotid Bifurcation.
A bifurcated carotid artery model was obtained from the GrabCAD online community,15 converted to the length unit of meter, imported into SimVascular10 and meshed to include a boundary layer refinement, using four-node tetrahedral elements. Four meshes were created as listed in Table 1, with two of these meshes (“coarse” and “finer”) shown in Fig. 7(a). Finite element models with identical meshes, boundary conditions, material properties (, ), and time increments (250 increments of ), were created in FEBio, SimVascular (version 2.0.20624), and ANSYS Fluent (Version 16.2). The inlet has a diameter of 6.28 mm and the two outlets have respective diameters of 4.26 mm and 3.04 mm. An inlet velocity was prescribed with a parabolic spatial profile, and an average value whose time history is shown in Fig. 7(b), ranging from a minimum of to a maximum of (). A constant pressure was prescribed at the outlet boundaries, as well as on the rim of the inlet boundary. SimVascular solutions were obtained using the default solver (svLS-NS) with , residual criteria of 0.001 (as recommended by the SimVascular Simulation Guide), and step construction consisting of a minimum of three and a maximum of twelve nonlinear iteration sequences. The Fluent solutions used the pressure-based solver and SIMPLE scheme with least squares cell based gradient, second-order pressure, and second-order upwind momentum; the transient formulation was first-order implicit; absolute convergence criteria were used, with values of 10−4 for “continuity” and 10−5 for velocity components; iterations per time-step were set to a maximum of 20. All models were solved on the same desktop computer, using either a single processor or eight processors. For this problem, no noticeable differences were observed in the FEBio responses when comparing Euler integration with or , beyond the first 22 ms; similarly, no noticeable differences could be observed in the SimVascular responses with Euler integration, beyond the first 14 ms.

(a) Model of bifurcated carotid artery using coarse mesh (top) and finer mesh (bottom) of four-node tetrahedral elements. Boundary conditions are shown on the coarse mesh; in addition, on the arterial wall. The prescribed inlet velocity has a parabolic profile, with average value v0 and (b) time history of the average inlet velocity v0

(a) Model of bifurcated carotid artery using coarse mesh (top) and finer mesh (bottom) of four-node tetrahedral elements. Boundary conditions are shown on the coarse mesh; in addition, on the arterial wall. The prescribed inlet velocity has a parabolic profile, with average value v0 and (b) time history of the average inlet velocity v0
Bifurcated carotid artery mesh parameters. All elements are four-node tetrahedra. Solution times are based on single-processor and eight-processor computations for all three software programs. SimVascular times include the solution time + time to convert results to viewable plot files, whereas FEBio and Fluent automatically produce viewable plot/data files.
Solution time, 1 thread (min) | Solution time, 8 threads (min) | |||||||
---|---|---|---|---|---|---|---|---|
Mesh | Elements | Nodes | FEBio | SimVascular | Fluent | FEBio | SimVascular | Fluent |
Coarse | 120,383 | 21,671 | 16 | 31 + 3 = 34 | 31 | 8 | 15 + 3 = 18 | 19 |
Medium | 233,899 | 41,218 | 38 | 62 + 7 = 69 | 73 | 19 | 28 + 6 = 34 | 35 |
Fine | 396,341 | 68,843 | 78 | 115 + 12 = 127 | 114 | 41 | 49 + 10 = 59 | 54 |
Finer | 498,196 | 86,124 | 108 | 142 + 19 = 161 | 153 | 56 | 62 + 13 = 75 | 68 |
Solution time, 1 thread (min) | Solution time, 8 threads (min) | |||||||
---|---|---|---|---|---|---|---|---|
Mesh | Elements | Nodes | FEBio | SimVascular | Fluent | FEBio | SimVascular | Fluent |
Coarse | 120,383 | 21,671 | 16 | 31 + 3 = 34 | 31 | 8 | 15 + 3 = 18 | 19 |
Medium | 233,899 | 41,218 | 38 | 62 + 7 = 69 | 73 | 19 | 28 + 6 = 34 | 35 |
Fine | 396,341 | 68,843 | 78 | 115 + 12 = 127 | 114 | 41 | 49 + 10 = 59 | 54 |
Finer | 498,196 | 86,124 | 108 | 142 + 19 = 161 | 153 | 56 | 62 + 13 = 75 | 68 |
Solution times for all models are reported in Table 1. A representative FEBio solution for the coarse mesh is presented in Fig. 8, displaying the wall shear stress (WSS) and flow velocity field at time (when WSS has peaked). For each mesh, a comparison of the FEBio, SimVascular and Fluent responses (wall shear stress, pressure and velocity magnitude) was performed at six distinct locations. The pressure and WSS results for two of these points (P1 and P2 in Fig. 7(a)) are reported here. An examination of the FEBio results for the fluid pressure p at point P1 shows that all four meshes produce nearly identical responses (Fig. 9(a)). A comparison of FEBio with SimVascular and Fluent, using the finer mesh, shows near identical responses as well (Fig. 9(b)). The value of WSS at P1 also shows good agreement among the three software programs (Fig. 9(c)). At P2, Fluent showed the least variation in the WSS response with increasing mesh density, followed by FEBio, then SimVascular (Fig. 10(a)–10(c)). However, a comparison of the three software programs, using the finer mesh, demonstrated better agreement between FEBio and SimVascular, with Fluent producing lower values of WSS (Fig. 10(d)). The Courant–Friedrichs–Lewy (CFL) number was evaluated for all elements in the coarse and finer meshes, at the instant when the input velocity peaked. The maximum CFL number among all elements was 7.0 for the coarsest mesh and 9.8 for the finer mesh. In both models, the median CFL number for all elements was 1.1.

FEBio solution for bifurcated carotid artery model (coarse mesh) at time t = 0.2 s, showing the WSS distribution (top) and the velocity vector field in a sectioned transparent model (bottom); the largest velocity magnitude at this time point was 1.05 m/s.

Bifurcated carotid artery results at point P1: (a) FEBio mesh convergence analysis for fluid pressure p. Comparison of SimVascular, Fluent and FEBio results for (b) p and (c) WSS, using finite element model with finer mesh

Bifurcated carotid artery results at point P2: Mesh convergence analyses for WSS with (a) SimVascular, (b) Fluent, (c) FEBio, and (d) comparison of WSS results using finite element model with finer mesh
Idealized Model of Arterial Stenosis.
An experimental study by Seeley and Young explored the pressure loss across an idealized model of arterial stenosis [58]. These authors simulated a stenosis by placing a cylindrical plug of length L and outer diameter , with a hole of diameter , inside a long tube of inner diameter . Using water and water–glycerol mixtures, they related the Euler number, , to the Reynolds number, , between two locations, 0.3 m upstream of the plug and 0.61 m downstream of it. In the expression for is the pressure drop between the pressure ports in the presence of the plug, minus the pressure drop over the same distance in the absence of a plug (Poiseuille flow); is the mean flow velocity upstream and downstream of the plug. An additional length of pipe, 1.5 m long, extended upstream of the first pressure port, to ensure fully developed flow at that location. Detailed experimental results for Eu versus Re were provided for the specific case of a concentric hole, where , and , which are reproduced here (Fig. 11).
![Experimental and CFD results for simulated stenosis, plotting the Euler number against the Reynolds number: Experimental measurements using water and water + glycerol mixtures are from [58]. CFD results from this study include FEBio analyses at 18 increasing values of Re (from 25 to 1100), and Fluent analyses at a subset of 15 values of Re.](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f011.png?Expires=1683090161&Signature=BpYPPxTm54nXJpynCPm4byuz-066BVlcaCLN-QeqCAbjBmzLbiH9jB1PLwflMCnZssZOWbEofoB9Ylfg9y-cBU8cRssNWi-scs5-eyBrVw0r9Z49s3s9ckP4B20zOJakHwwOzBuiLS~Vsczi4z1pOAWr3gs8Y1qjNBKhvdjvOI1Rg~sO2Zph53B5zCag8JVzvP2iO8SRDsH~hgCWuYg3yYwYmWeZkfYZTCdZeakAjQOwgv2c4u-AVGPM4xEE2Vv3zDaTsrKqD3Gxv~DnQfTewnKuAVrQYtaXJM2CEUtooViJ4ZHkOAmOTTe0s~OSFAGlicHcsrVYp9L07bdYFUVDJg__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Experimental and CFD results for simulated stenosis, plotting the Euler number against the Reynolds number: Experimental measurements using water and water + glycerol mixtures are from [58]. CFD results from this study include FEBio analyses at 18 increasing values of Re (from 25 to 1100), and Fluent analyses at a subset of 15 values of Re.
![Experimental and CFD results for simulated stenosis, plotting the Euler number against the Reynolds number: Experimental measurements using water and water + glycerol mixtures are from [58]. CFD results from this study include FEBio analyses at 18 increasing values of Re (from 25 to 1100), and Fluent analyses at a subset of 15 values of Re.](https://asmedc.silverchair-cdn.com/asmedc/content_public/journal/biomechanical/140/2/10.1115_1.4038716/16/m_bio_140_02_021001_f011.png?Expires=1683090161&Signature=BpYPPxTm54nXJpynCPm4byuz-066BVlcaCLN-QeqCAbjBmzLbiH9jB1PLwflMCnZssZOWbEofoB9Ylfg9y-cBU8cRssNWi-scs5-eyBrVw0r9Z49s3s9ckP4B20zOJakHwwOzBuiLS~Vsczi4z1pOAWr3gs8Y1qjNBKhvdjvOI1Rg~sO2Zph53B5zCag8JVzvP2iO8SRDsH~hgCWuYg3yYwYmWeZkfYZTCdZeakAjQOwgv2c4u-AVGPM4xEE2Vv3zDaTsrKqD3Gxv~DnQfTewnKuAVrQYtaXJM2CEUtooViJ4ZHkOAmOTTe0s~OSFAGlicHcsrVYp9L07bdYFUVDJg__&Key-Pair-Id=APKAIE5G5CRDK6RD3PGA)
Experimental and CFD results for simulated stenosis, plotting the Euler number against the Reynolds number: Experimental measurements using water and water + glycerol mixtures are from [58]. CFD results from this study include FEBio analyses at 18 increasing values of Re (from 25 to 1100), and Fluent analyses at a subset of 15 values of Re.
For these analyses we used , and varied to achieve the desired values of Re. The bulk modulus was set to . A total of 500 time-steps were used, with uniform time increments , and convergence settings were identical to the carotid bifurcation analysis; Euler integration was employed, as it proved to be the most efficient and reliable scheme, and results are presented here for the steady-state response. (Additional results are available in Sec. S5 of the Supplementary Materials section which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection) Six mesh refinements were examined to verify mesh convergence for the parameter Eu, spanning from 3126 to 33,250 elements (25,440–267,248 degrees-of-freedom), analyzing the case Re = 1000. Results of the mesh convergence analysis are presented in Fig. S10 of Supplementary Materials, which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection, showing that the highest two mesh refinements produced nearly indistinguishable results. All subsequent analyses were performed with the penultimate mesh (17,990 elements, 144,892 degrees-of-freedom), each requiring 15 min of wall clock time or less on a vintage 2011 desktop computer (eight threads) or 7 min on a higher end, vintage 2017 machine (12 threads).
The results of the FEBio analyses (minus the pressure drop evaluated from Poiseuille flow) are plotted with the experimental data of Seeley and Young [58] in Fig. 11, showing good overall agreement with experimental trends and very good accuracy for . With increasing Re, FEBio results tended to moderately overestimate the experimental data, though the lack of measurement uncertainty ranges in the experimental study precluded a definitive assessment of agreement in this higher range of Re. To further examine whether this small overestimation might result from the specific finite element formulation developed in this study, we used the same mesh to perform a 2D axisymmetric analysis in Fluent, with the solver settings described in the carotid bifurcation analysis. Though the prescribed tolerances could not be met exactly, even when allowing up to 4000 iterations, Fluent was nevertheless able to produce solutions similar to those of FEBio (Fig. 11). These findings suggest that the small deviation between CFD and experimental results in the higher range of Re are not peculiar to one type of CFD solver; they may be attributed to measurement or modeling uncertainties, perhaps associated with the length of pipe and valve downstream of the second pressure transducer, which were not modeled in these CFD analyses. More detailed results are presented in Sec. S5 of the Supplementary Materials, which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection.
Discussion
The objective of this study was to implement a computational fluid dynamics solver in FEBio, with the long-term objective of modeling fluid–structure interactions, including flow alterations driven by active contractile elements in the solid domain, chemical reactions in fluid and solid or multiphasic domains and at their interfaces, as well as growth and remodeling of the solid matrix triggered by signals transduced by fluid flow, relevant to biomechanics, biophysics, and mechanobiology. A novel CFD finite element formulation was developed, using a thermodynamically exact formulation of isothermal compressible flow, which produced a stable numerical scheme without explicitly appealing to stabilization methods.
The code was successfully verified and validated against standard benchmark solutions, including the lid-driven cavity flow (Figs. 1 and 2), flow past a backward-facing step (Figs. 3 and 4), 2D flow past a cylinder (Figs. S3 and S4 in Supplementary Materials which are available under “Supplemental Data” tab for this paper on the ASME Digital Collection), along with comparisons of arterial flow against other open-source and commercial software (Table 1, Figs. 7–10, and Figs. S5 and S6 which are available under “Supplemental Data” tab for this paper on the ASME Digital Collection). We also validated our code against an experimental study of a simulated stenosis [58] (Fig. 11); to the best of our knowledge, this is the first reported CFD investigation of that experimental study. Features employed in vascular flow simulations, such as backflow stabilization [51,52] and flow resistance [53], were adapted to the current formulation. Backflow and tangential stabilization were shown to be effective for stabilizing outlet conditions when strong fluctuations were observed (Fig. 6).
As reviewed earlier, many solution methods have been proposed previously for CFD analyses of nearly incompressible fluids, which typically require special handling to produce stable numerical solutions [2,32,35,36,48–50,59]. In this study, we developed a novel Galerkin-based finite element formulation that uses velocity and dilatation degrees-of-freedom, instead of the velocity–pressure formulations employed traditionally. For this purpose, we specialized the equations of mass, momentum and energy balance to the case of isothermal conditions (Appendix), which allowed us to limit our state variables to (i.e., excluding temperature); in particular, we used the integrated form of the mass balance to solve for the density in terms of the referential (invariant) density . To solve for and J we employed the linear momentum balance, Eq. (2.1), and the kinematic constraint between , Eq. (2.6). This kinematic constraint is typically derived in solid mechanics using a material frame, starting from the definition of F. Few investigators appear to avail themselves of the validity of Eq. (2.6) in the spatial frame (i.e., using the spatial descriptions of J and and applying the material time derivative of J in the spatial frame). Thus, both governing equations involve spatial gradients of , producing a well-conditioned, fully populated stiffness matrix, Eq. (2.43). We used a function of state, Eq. (2.9), to relate the fluid pressure p to the volume ratio J, which naturally introduced the bulk modulus K (a physical property of the fluid) into our formulation, Eq. (2.30). In standard penalty methods [30], the introduction of a similar parameter compromises the stiffness matrix conditioning, the accuracy of the inverted stiffness matrix and thus the convergence of the nonlinear solver [60]. In contrast, varying K in our formulation from had no effect on the nonlinear convergence behavior, as evidenced by analyses of the convergence rate presented in Sec. S2 of Supplementary Materials which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection.
From a theoretical perspective, it should be noted that our adoption of J as a nodal degree-of-freedom implies that we enforce continuity of fluid strain across element boundaries. Since is also a nodal degree-of-freedom, it follows that the mass flux is similarly continuous across element boundaries, consistent with mass balance requirements (recall that is constant). Had we chosen as a nodal degree-of-freedom in lieu of , mass balance across element boundaries would also be automatically satisfied. However, the kinematic constraint of Eq. (2.6) would have reduced to ; since this expression does not contain , the numerical scheme would not produce the same stability as achieved in the above-mentioned formulation. Therefore, using appears to be the better choice for numerical stability.
The introduction of dilatation as a nodal degree-of-freedom implies that essential or boundary conditions must be applied in relation to this variable. In some cases, the dilatation needed to be prescribed on a corner edge as an essential boundary condition. Had it not been prescribed, it would be naturally assumed that the normal velocity is zero on that edge. However, normal velocity is ambiguous on an edge (e.g., a corner) that separates two surfaces, since the normal is not defined uniquely. By not specifying the dilatation, the burden would be placed on the numerical scheme to resolve this ambiguity. Sometimes, this approach fails to produce good numerical convergence, whereas prescribing the dilatation succeeds, as shown in some of our illustrations. Therefore, users of this velocity–dilatation formulation should keep in mind the occasional necessity to employ this essential boundary condition, rather than relying on the natural boundary condition on a corner edge. This type of decision in the choice of boundary conditions is not unusual in fluid analyses where the real fluid domain is truncated for the purpose of creating a finite element domain with inlet and outlet boundaries. The true boundary conditions at the inlet and outlet are not known; they are approximated for the purpose of the finite element analysis, as also demonstrated in the scheme for stabilizing backflow conditions on a truncated downstream boundary (Sec. 2.7) [51,52].
The fact that the fluid is modeled as compressible implies that dilatational (pressure) waves travel at a finite speed in this material. In principle, for any transient problem being analyzed, the wave propagation may be examined explicitly by using time increments small enough to capture its temporal evolution, as illustrated in the 1D problem in Fig. 5. Conversely, for problems whose salient time scale is much larger than the time required for waves to propagate through the domain, time increments may be chosen to capture those salient phenomena, such as vortex shedding frequency (Fig. 6) or pulsatile velocity frequency (Fig. 9). For such analyses, wave propagation has a negligible effect and does not interfere with the investigation of those lower frequency phenomena. Thus, modeling the fluid as a real compressible material does not produce any complication in the analysis of problems where the effects of its compressibility are negligible.
As a consequence of this velocity–dilatation formulation, our finite element formulation for isothermal compressible flow employs a straightforward implementation of Galerkin's method, which does not require the explicit satisfaction of the inf-sup condition [32–34] or the use of stabilization methods such as SUPG, Galerkin/least-squares, and pressure-stabilizing/Petrov–Galerkin [35–39], or characteristic-based split [49,50]. Unlike methods that employ stabilization schemes, such as SUPG, no special consideration is required for linear or higher order element interpolations (see lid-driven cavity flow solved with quadratic elements in Sec. S1 of Supplementary Materials which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection), nor is it necessary to carefully develop ad hoc formulas for the stabilization parameter τ that serves as a weight factor between the Galerkin residual and least-squares terms [39,41,42]. We expect that the resulting simplicity of this formulation makes it more amenable for future extensions, such as the incorporation of chemical reactions as previously done in FEBio's multiphasic domain [9], and FSI.
Based on the variety of problems examined in this study, we observed that FEBio produced significantly more accurate results when mesh refinement was introduced near nonslip boundaries (boundary layer meshing), in comparison with global refinement of uniform meshes. It was also necessary to prescribe the dilatation e along edges where a large gradient in velocity might occur, as noted at corners of the lid-driven cavity flow (Fig. 1), or the edges of inlet boundaries where velocity was prescribed, as in the channel flow (Fig. 6) and the carotid bifurcation (Fig. 7). Additionally, FEBio analyses occasionally benefited from ramping up prescribed velocities or pressures from zero to the desired initial value using short time increments, as done in the lid-driven cavity flow, the steady-state analysis for flow past a backward-facing step, the flow past a block in a narrow channel, and the idealized model of arterial stenosis, rather than imposing a step jump in those boundary conditions at the very first time-step, since Broyden updates might fail under these conditions.
The generalized α-method [44] was implemented successfully in FEBio as part of this study, demonstrating considerably less energy dissipation than Euler's method as shown in the one-dimensional wave propagation analysis using inviscid flow (Fig. 5). In viscous flows, the natural energy dissipation resulting from the fluid viscosity may sometimes dominate over numerical damping, as suggested in the bifurcated artery analysis where little difference was noted between Euler integration and the generalized α-method; in other cases of viscous flows, numerical damping may still play a dominant role, as suggested in the flow past a block in a narrow channel (Fig. 6), where steady flow was eventually achieved when using Euler integration, whereas a periodic vortex shedding response was produced with the generalized α-method.
The comparison of FEBio to SimVascular and Fluent in the analysis of the carotid bifurcation also provided useful insights regarding the characteristics of our formulation. We noted that Fluent, which uses the finite volume method, exhibited less sensitivity to mesh refinements than FEBio and SimVascular. In particular, wall shear stresses did not change as much with increasing mesh refinement as with FEBio and SimVascular (Fig. 10). Nevertheless, overall, the agreement between the three programs was remarkably good for this carotid bifurcation, despite the fact that each of them uses a significantly different formulation. The solution times for SimVascular and Fluent were very similar (Table 1), whereas FEBio exhibited shorter solution times for this problem. The similarity between SimVascular and Fluent is consistent with the fact that they both use iterative linear solvers at each time-step. Their solution times could be reduced by lowering the maximum number of iterations, at the expense of not meeting the convergence tolerance over a larger number of time-steps. The significantly faster performance of FEBio in this series of carotid bifurcation analyses can be explained by the use of Broyden's method. Although quasi-Newton methods have been used in CFD codes [54], they have not been widely adopted. For fluid mechanics problems, we perform one direct linear solve at the beginning of the first time-step, followed by Broyden nonlinear iterations until convergence. For all subsequent steps, the approximation to the stiffness matrix inverse from the last (converged) Broyden iteration of the previous step is used to initialize the new Broyden iterations. It is rare for Broyden's method to require more than five nonlinear iterations. If the number of Broyden iterations exceeds a user-defined threshold, another direct linear solve is executed. Thus, only a handful of direct linear solves are needed for almost all fluid mechanics problems. Using this approach, we have solved problems with 3 million DOFs without difficulty. This is not a hard limit—it simply represents the largest problem that we have tried. Importantly, the comparison performed in this study was intended primarily to verify the FEBio solution against other standard fluid solvers available to the user community, not as a benchmark for speed of computation, which can vary significantly based on the choices of time increments and convergence tolerances, and differ based on the choice of direct versus iterative solvers. Furthermore, for users focused on vascular flows, alternative solvers such as SimVascular offer a far greater variety of options relevant to the vascular system than the FEBio implementation presented here, including reduced-order models of the circulation, such as lumped parameter models and impedance boundary conditions [1,52,53].
Nevertheless, as model size increases to the millions of DOFs, direct linear solvers, even when used sparingly, become a significant bottleneck due to memory and computation requirements. Furthermore, a closer examination of the trends in solution times (Table 1) shows that the relative performance boost of FEBio decreased with increasing mesh sizes, consistent with faster growth of the number of computations with the number of DOFs for direct solvers. This observation was further supported by the analysis of a larger model of an ascending and descending aorta, described in Sec. S4 of the Supplementary Materials, which is available under “Supplemental Data” tab for this paper on the ASME Digital Collection, where the SimVascular run completed faster than FEBio.
Although this observation provides a strong motivation to make use of iterative solvers and to develop customized preconditioners for use with our fluid mechanics formulation, iterative linear solvers are generally unreliable for problems in computational solid mechanics. Moderate levels of nearly incompressible behavior, contact, shell elements, etc., all provide stiffness matrices that are challenging to handle with even the most carefully constructed preconditioners. Because of the variety of ways that the global stiffness matrix may be rendered stiff by the physics of solid mechanics problems, it is impossible to develop a “one size fits all” approach to preconditioning. As we implement FSI capabilities in FEBio, we will work to develop an effective preconditioning strategy to allow the use of iterative solvers with our fluid mechanics formulation, but we will not rely on iterative solvers exclusively. We plan to develop a nonlinear solution strategy that combines the use of the Jacobian-free Newton–Krlyov method with the Broyden quasi-Newton method. For problems that are large enough to benefit from iterative linear methods, the nonlinear solution process will begin with Newton–Krylov methods and then automatically switch to quasi-Newton methods when the iterative linear solvers fail to converge. We are confident that this approach will serve the vast majority of our current and future users.
In summary, a novel CFD solver has been implemented in the open-source FEBio software suite which is suitable for the analysis of nearly incompressible flows of the type typically encountered in biomechanics and biophysics. This implementation has been verified and validated using a variety of benchmark and test problems and it appears to perform equally well as other, more standard, formulations. An important characteristic of this formulation is its simplicity, requiring a straightforward application of the Galerkin residual method. This simplicity makes it suitable for future extension to fluid–structure interactions and the incorporation of reactive mechanisms in the fluid and structural domains, as well as at their interfaces, for modeling mechanobiology, growth, and remodeling.
Disclaimer
The content is solely the responsibility of the authors and does not necessarily represent the official views of the National Institutes of Health or the National Science Foundation.
Funding Data
Division of Graduate Education, U.S. National Science Foundation (Grant No. NSF GRFP DGE-16-44869).
National Institute of General Medical Sciences, U.S. National Institutes of Health (Award No. R01GM083925).
Appendix
Energy Balance
This statement must be valid for arbitrary control volumes and arbitrary processes, from which we conventionally derive the differential form of the axioms of mass, momentum and energy balance.
For the specialized conditions of a viscous fluid at constant temperature assumed in our treatment, the only state variables for the functions of state are (i.e., the temperature is not a state variable since it is assumed constant). Under these conditions, the entropy inequality shows that the specific entropy and the heat flux must be zero, and the Cauchy stress must have the form of Eq. (2.8) where p is given by Eq. (2.9) as a function of J only, leaving the residual dissipation statement as a constraint that must be satisfied by constitutive relations for . (For a Newtonian fluid, this constraint is satisfied when the viscosities and are positive.) From these thermodynamic restrictions, we conclude that , where is the specific (Helmholtz) free energy, with .
A comparison of this statement with the statement of virtual work in Eq. (2.13) establishes a clear correspondence between , and between and , with the latter representing the sum of the internal (free) and kinetic energy densities. We now have a clearer understanding of the significance of virtual energy density in the context of this formulation.
Generalized α-Method
where . This parameter is the spectral radius for an infinite time-step, which controls the amount of damping of high frequencies; a value of zero produces the greatest amount of damping, annihilating the highest frequency in one step, whereas a value of one preserves the highest frequency.
Four different options are presented in Ref. [44] for initializing at the beginning of time-step ; the first three of these have been implemented in FEBio. For steady flows, these authors recommend disregarding and setting to recover the backward Euler scheme.