Next Article in Journal
A Deep Learning Framework of Super Resolution for License Plate Recognition in Surveillance System
Previous Article in Journal
Quantifying Temporal Dynamics in Global Cyber Threats: A GPT-Driven Framework for Risk Forecasting and Strategic Intelligence
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Finite Volume Incompressible Lattice Boltzmann Framework for Non-Newtonian Flow Simulations in Complex Geometries

Department of Mechanical Engineering-Engineering Mechanics, Michigan Technological University, 1400 Townsend Drive, Houghton, MI 49931, USA
*
Author to whom correspondence should be addressed.
Mathematics 2025, 13(10), 1671; https://doi.org/10.3390/math13101671
Submission received: 31 March 2025 / Revised: 27 April 2025 / Accepted: 13 May 2025 / Published: 20 May 2025
(This article belongs to the Section E2: Control Theory and Mechanics)

Abstract

:
Arterial diseases are a leading cause of morbidity worldwide, necessitating the development of robust simulation tools to understand their progression mechanisms. In this study, we present a finite volume solver based on the incompressible lattice Boltzmann method (iLBM) to model complex cardiovascular flows. Standard LBM suffers from compressibility errors and is constrained to uniform Cartesian meshes, limiting its applicability to realistic vascular geometries. To address these issues, we developed an incompressible LBM scheme that recovers the incompressible Navier–Stokes equations (NSEs) and integrated it into a finite volume (FV) framework to handle unstructured meshes while retaining the simplicity of the LBM algorithm. The FV-iLBM model with linear reconstruction (LR) scheme was then validated against benchmark cases, including Taylor–Green vortex flow, shear wave attenuation, Womersley flow, and lid-driven cavity flow, demonstrating improved accuracy in reducing compressibility errors. In simulating flow over National Advisory Committee for Aeronautics (NACA) 0012 airfoil, the FV-iLBM model accurately captured vortex shedding and aerodynamic forces. After validating the FV-iLBM solver for simulating non-Newtonian flows, pulsatile blood flow through an artery afflicted with multiple stenoses was simulated, accurately predicting wall shear stress and flow separation. The results establish FV-iLBM as an efficient and accurate method for modeling cardiovascular flows.

1. Introduction

Cardiovascular diseases (CVDs) remain the leading cause of mortality globally, accounting for approximately 32% of all deaths [1]. Within CVD, arterial diseases such as stenosis (narrowing of arteries) and aneurysms (bulges in arterial walls) are often associated with disturbed hemodynamic patterns, particularly alterations in wall shear stress (WSS) [2,3]. Elevated WSS, oscillatory WSS, and low WSS have all been implicated in different stages of atherogenesis and aneurysm rupture [2,4,5]. Current clinical diagnostic tools, including angiography and Doppler ultrasound, provide anatomical and qualitative flow information but lack the predictive capability to assess the risk of disease progression or rupture [6,7]. Angiography, while providing detailed images of the vessel lumen, offers limited information about flow patterns. Doppler ultrasound, although capable of measuring flow velocities, lacks the spatial resolution needed to capture complex hemodynamic details in stenotic or aneurysmal regions.
These limitations highlight the critical need for advanced computational models that can accurately resolve geometric complexity and incompressibility in arterial flow simulations. Patient-specific arterial vasculature, derived from computed tomography (CT) and magnetic resonance imaging (MRI), exhibit intricate features such as stenoses, bifurcations, and aneurysms, necessitating numerical methods that handle unstructured meshes effectively [6,8,9,10]. Additionally, arterial blood flow operates at low Mach numbers (<0.01), making it nearly incompressible [3,11]. Small density variations can induce substantial errors, requiring numerical schemes that ensure incompressibility without excessive computational cost [12,13].
Traditional numerical methods such as the finite element method (FEM) and finite volume method (FVM) often use the immersed boundary method (IBM) for handling complex geometries and moving structures, but IBM compromises mass conservation, particularly in high-gradient or narrow flows such as stenosed arteries. Additionally, solving the Poisson equation for pressure is computationally expensive due to its elliptic nature, requiring the solution of a large sparse linear system at each time step. This cost increases with mesh complexity and accuracy demands, limiting scalability for large-scale cardiovascular simulations. The global nature of the Poisson equation further imposes communication overhead on HPC systems, creating performance bottlenecks.
In contrast, the lattice Boltzmann method (LBM) offers a more efficient approach for simulating fluid flows, leveraging its simplicity, computational efficiency, and ability to capture complex dynamics. Unlike traditional methods, LBM is inherently mass-conserving, using particle distribution functions that locally conserve mass and momentum [13]. This eliminates the need to solve the costly Poisson equation for pressure, reducing overhead and speeding up simulations, especially for large-scale hemodynamic studies. Furthermore, LBM allows for the local computation of the strain rate tensor, facilitating accurate wall shear stress calculations, providing a distinct advantage over conventional methods.
In conventional LBM, advective transport is linear, enabling exact treatment of the advection term with minimal numerical diffusion, while molecular transport appears as a nonlinear source term. However, LBM’s intrinsic coupling of velocity and spatial discretization restricts it to uniform Cartesian grids, limiting its adaptability to complex geometries and imposing stability constraints. By coupling LBM with the finite volume approach, this coupling is decoupled, improving flexibility for irregular geometries [14,15]. Another limitation is the compressibility error in simulating incompressible flows due to the polynomial approximation of the Maxwellian equilibrium distribution function (EDF) in lattice Boltzmann equation (LBE), which introduces errors scaling with the Mach number [16]. Since traditional LBM recovers the compressible NSEs in the low Mach limit, mitigating this error to recover incompressible behavior remains an active research area.
The present study addresses the two challenges mentioned above. Firstly, it incorporates LBE into the finite volume framework, enabling the implementation of LBM on irregular geometries and overcoming the constraint of LBM implementation solely on uniform Cartesian grids. Secondly, we utilize the incompressible LBM scheme developed by Murdock and Yang [17] to mitigate compressibility errors and recover incompressible NSEs. To the best of the authors’ knowledge, no prior study has systematically investigated the implementation, distinct characteristics, and advantages of integrating the finite volume approach with the iLBM model, particularly in addressing geometric complexity and incompressibility in hemodynamic simulations.

1.1. Finite Volume Lattice Boltzmann Method (FVLBM)

In the FVLBM approach, starting with the differential form of LBE, Gauss’ theorem is applied to finite elements that span the spatial domain. A volume-averaged particle distribution is defined for each macro-cell, and using either piecewise constant or piecewise linear interpolation scheme, equations for distribution functions are obtained. Succi et al. [18] were the first to propose the idea of adapting LBE for the finite volume approach. He et al. [19] and Chen et al. [20] pioneered FVLBM approaches for non-uniform rectangular elements, employing quadratic interpolation and volumetric representation, respectively. However, these methods were limited by their mesh topology. Peng et al. [14,21] pioneered an FVLBM scheme for triangular elements, decoupling velocity and spatial discretizations. Using the D2Q9 lattice, they established that kinematic viscosity scales as τ / 3 , crucial for numerical diffusion in advection. Xi et al. [22,23] extended FVLBM to quadrilateral and hexahedral elements, proving its adaptability to unsteady incompressible flows. Ubertini et al. [24,25] refined boundary treatments and analyzed compressibility effects, noting FVLBM’s higher computational cost versus standard LBM, highlighting efficiency challenges in complex geometries.
Cell-centered finite volume discretization of LBE has gained traction in recent years, offering alternative approaches to FVLBM. Patil et al. [15] pioneered a cell-centered approach for arbitrarily shaped triangular tessellations, employing a second-order accurate total variation diminishing (TVD) scheme for advective flux computation and the linear least squares (LLS) method [26] for gradient reconstruction. Recognizing the limitations of LLS in spatial accuracy, Patil [27] later enhanced the TVD-FVLBM scheme by implementing the second-order accurate quadratic least squares (QLS) method [28]. Zarghami et al. [29,30] further advanced FVLBM by introducing pressure-based upwind biasing factors as flux correctors, demonstrating its efficacy in simulating complex flows such as bifurcation phenomena and free shear flows. More recently, Wang et al. [31] showcased the computational efficiency of the LR scheme in cell-centered FVLBM, presenting a simplified method for implementing LBM boundary conditions within the finite volume framework.
The cell-vertex finite volume approach offers robustness on mixed and non-orthogonal grids but pose challenges in boundary condition handling and interpolation. In contrast, the cell-centered approach simplify implementation by naturally defining control volumes around cell centers, facilitating direct flux interpretation and ensuring consistent performance across mesh refinements. Given these advantages, the present study adopts a cell-centered finite volume approach to balance computational efficiency with accurate flow representation in irregular domains. While traditional LBM benefits from localized computation and linear advective transport, FVLBM introduces complexities by requiring reconstruction schemes from conventional CFD methods to compute advective terms, compromising locality and potentially introducing numerical diffusion. However, traditional LBM faces mass conservation challenges at curved boundaries due to lattice misalignment, interpolation errors, and inaccuracies in bounce-back conditions [13,20]. High curvature effects further complicate boundary treatments. By adapting LBE to a finite volume framework, FVLBM mitigates these issues, enhancing its applicability to complex geometries, making FVLBM a worthwhile endeavor.

1.2. Incompressible LBM Schemes

LBM suffers from compressibility error in its standard form, which affects its accuracy for simulating incompressible flows. This stems from the requirement, imposed by the Chapman–Enskog expansion, that the equilibrium distribution function (EDF) take a polynomial form of particle velocity—unlike the exponential Maxwellian in the Boltzmann equation [16]. As a result, the EDF in LBM is derived via a truncated Mach-number-based Taylor expansion, which restricts the method to low Mach number flows and introduces an error that scales with the Mach number.
Recovering the behavior of the incompressible NSEs by limiting the density variation has received much attention in the past three decades. Techniques applied to achieve incompressibility in conventional NSEs such as the pseudo-compressible formulation and predictor-corrector approach have been employed by researchers to achieve incompressibility in LBM as well. Modifying the EDF in LBM formulation has been the primary method of achieving incompressibility. By decoupling mass and momentum, researchers have recovered incompressible NSEs for both steady as well as unsteady flows.
Zou et al. [32] introduced a method substituting mass flux for velocity, which, while reducing errors in steady-state lid-driven cavity simulations, still exhibited pressure fluctuations dependent on local density and the speed of sound, limiting its applicability to transient flows. Lin et al. [33] attempted to address this by setting density to a constant and introducing adjustable parameters, but pressure remained a function of density and the speed of sound, hindering truly incompressible behavior. Alternatively, Chen and Ohashi [34] employed a predictor-corrector approach with a pressure-based LBM model, modifying velocity definition for unsteady flows. This introduced a body force term and necessitated solving a Poisson equation for pressure correction, increasing computational costs. A significant simplification was achieved by Guo et al. [35], who proposed an EDF independent of local density and the speed of sound, treating pressure as a primitive variable. While recovering unsteady incompressible NSEs without solving additional equations, the choice of parameters in Guo’s model lacked a clear rationale. Other studies [36,37] using Guo’s incompressible LBM model did not provide a rationale for the selection of specific values, thus leaving open the possibility of alternative values for those parameters.
Murdock and Yang [17] rigorously derived Guo’s [35] incompressible LBM model, establishing a mathematical foundation for its parameters and extending it to arbitrary lattice structures. Their Chapman–Enskog expansion validated the model against canonical steady and transient pulsating flows, especially the Womersley flow, showing excellent agreement. They demonstrated that only their proposed parameters yielded correct solutions, confirming the uniqueness of their EDF for incompressible flow. Later, they applied their iLBM model to direct numerical simulations (DNS) of laminar-to-turbulent transition, accurately capturing transition dynamics [38]. However, these studies were restricted to Cartesian meshes and regular domains. The applicability of iLBM within a finite volume framework for irregular geometries remains unexplored. This study aims to demonstrate the accuracy and versatility of the iLBM model [17] within the finite volume LBM (FVLBM) solver, developed in-house, for cardiovascular applications, particularly blood flow simulations in arterial stenosis and aneurysms.

1.3. Advancing Non-Newtonian Hemodynamic Modeling with FV-iLBM

Blood exhibits shear-thinning non-Newtonian behavior, with viscosity decreasing at higher shear rates, significantly influencing hemodynamics, particularly near arterial walls [39]. In stenotic regions, these effects modify wall shear stress (WSS), impacting disease progression [40]. To address these challenges, we present a finite volume LBM framework optimized for hemodynamic simulations in complex vascular geometries. Using unstructured meshes, it accurately represents arterial vasculature while incorporating the iLBM scheme [17] to enforce incompressibility. The Carreau model [41] is integrated to capture non-Newtonian blood rheology, especially in low-shear region, enhancing clinical relevance. Key advancements include boundary-conforming discretization, and the ability to compute the strain rate tensor locally, which facilitates direct WSS computation without requiring global velocity gradients. This local computation enhances numerical efficiency over conventional methods, further improving the accuracy and computational performance of the FV-iLBM solver in complex vascular geometries. Furthermore, the pressure-based iLBM scheme eliminates the need for solving the Poisson equation, thereby avoiding the O ( N 1.5 ) computational cost typically associated with elliptic solvers in conventional finite volume methods [42]. Although the current implementation is serial, the algorithm’s explicit and local structure positions it well for future parallelization.
Beyond its immediate applications in hemodynamic analysis, the FV-iLBM solver provides a flexible platform for further customization and optimization. It can integrate advanced blood rheology models and multiphysics capabilities to enable more comprehensive vascular flow simulations. While traditional LBM is typically restricted to second-order accuracy, the finite volume approach allows for the implementation of higher-order spatial and temporal discretization schemes, improving accuracy in complex flow regions. This adaptability positions the FV-iLBM framework as a robust computational tool for investigating intricate hemodynamic phenomena and refining vascular modeling techniques.
The study is structured as follows: Section 2 outlines the mathematical framework for finite volume LBM, covering collision and advective term calculations, time integration schemes, and the iLBM model by Murdock and Yang [17], with a focus on boundary condition treatment. Section 3 presents simulations validating the FV-iLBM approach using canonical test cases, including Taylor–Green vortex, shear wave decay, channel flow, Womersley flow, and lid-driven cavity flow. Additionally, we simulate flow over the NACA0012 airfoil at four different angles of attack to showcase proficiency of the FV-iLBM solver for simulating external flows. After validating the FV-iLBM solver for simulating non-Newtonian flows, we simulate pulsatile blood flow through an artery afflicted with multiple stenoses to demonstrate FV-iLBM’s applicability in cardiovascular dynamics. Section 4 summarizes key findings and their implications.

2. Mathematical Framework

The Boltzmann equation representing the transport of a particle distribution function f ( x , e , t ) in the mesoscopic scale is given by
f t + e · f = Ω
f ( x , e , t ) represents the probability of finding a particular molecule with a given position ( x ) and momentum ( e ) at a given time (t). The boldface characters represent vector quantities. The above Boltzmann equation is an integro-differential equation, where Ω represents the collision integral which is nonlinear in nature and, historically, has been a major challenge while dealing with the Boltzmann equation. To simplify numerical simulations using the Boltzmann equation, the collision integral was replaced by the Bhatnagar–Gross–Krook [43] (BGK) approximation, which is given by
Ω = 1 τ f f e q
Here, τ represents the single-relaxation-time (SRT) that controls the relaxation of the particle distribution function to equilibrium after collision. The equilibrium distribution function f e q follows a Maxwellian distribution function dependent on the Mach number. τ is related to viscosity as
ν = c s 2 τ 1 2 δ t
where c s represents the speed of sound in LBM units and δ t represents the time step.
By discretizing the Boltzmann equation in the velocity space, we are restricting the movement of the particles along the fixed directions of a lattice. The discretized Boltzmann equation is given by
f α t + e α · f α = 1 τ f α x , t f α e q x , t
where x represents the position vector and e α represents the particle velocity vector along the direction α with α = 1 , 2 , 3 , , N , depending on the lattice discretization considered. The lattice structure is denoted by the convention D n Q n , where D represents the dimension and Q represents the number of directions of the velocity vectors. For D 2 Q 9 (two-dimensional, nine-velocity) lattice, each node is connected to neighbors through eight links with a rest velocity (represented by 0) at the center of the lattice, as illustrated in Figure 1.

2.1. Standard Lattice Boltzmann Model

In the standard LBM model, the EDF has the following form for the D 2 Q 9 lattice:
f α , s t d e q = ρ w α 1 + 3 e α · u c 2 + 9 2 e α · u 2 c 4 3 2 u · u c 2
Here, c represents the lattice speed and w α represents the weight given to each lattice vector. In the case of D 2 Q 9 , the lattice weights are
w 0 = 4 9 , w 1 4 = 1 9 , w 5 8 = 1 36
and the macroscopic properties are recovered through moments of the particle distribution function as
α = 0 8 f α = ρ
α = 0 8 e α f α = ρ u
α = 0 8 e α e α f α = c s 2 ρ I ¯ ¯ + ρ u u
and the pressure is recovered as
P = ρ c s 2
For D 2 Q 9 , c s = 1 / 3 .

2.2. Incompressible Lattice Boltzmann Model

In the standard LBM model, the EDF for the D 2 Q 9 lattice is given by Equation (5). As mentioned in Section 1, LBM in its standard form suffers from compressibility error, and modifying the EDF in LBM formulation has been the primary method of achieving incompressibility. The EDF for the iLBM model proposed by Murdock and Yang [17] is given by
f α , i L B M e q = 1 5 P 3 c 2 + S α u i = 0 P 3 c 2 + S α u i = 1 , 2 , 3 , 4 P 12 c 2 + S α u i = 5 , 6 , 7 , 8
where
S α u = w α 3 e α · u c 2 + 9 2 e α · u 2 c 4 3 2 u · u c 2
and the weights are those of the standard LBE given by Equation (6). The pressure is defined as
P = c 2 5 2 c 2 u · u + 3 f 0 e q 3
The form of the EDF proposed above is a function of velocity and does not depend on local density or the speed of sound and treats pressure like a primitive variable similar to that in incompressible NSEs. In the traditional iLBM model [17] on a square lattice, the relaxation parameter and the kinematic viscosity are related as ν = 1 3 ( τ 1 2 ) . 1 2 represents the numerical viscosity arising from the special finite difference discretization scheme applied to the discrete Boltzmann–BGK equation [25,31]. However, in the case of finite volume LBM, the relaxation parameter and the kinematic viscosity ( ν ) are related as [14]
ν = 1 3 τ

2.3. Finite Volume Lattice Boltzmann Method (FVLBM)

In order to incorporate the LBE into a cell-centered finite volume framework, the 2D flow domain is discretized into non-overlapping triangles/quadrilaterals of arbitrary shape, which represent finite areas over which the conservation of f α is satisfied. The lattice center and the macroscopic flow variables are located at the geometric centroid of each cell. Referring to Figure 2, we can represent a standard triangular cell A B C by Ω i with boundary Ω i and area A i = Ω i Ω i . Then, the integral form of Equation (4) is given by
t Ω i f α d Ω = Ω i 1 τ f α x , t f α e q x , t d Ω Ω i e α · n f α d l
where the first term on the right-hand side represents the intra-cell particle collision and the second term represents the inter-cell particle advection with n as the unit normal vector pointing outwards of Ω i . The subscripts α and i represent the discrete lattice velocity vector and cell index, respectively.
Let us represent the terms on the right-hand side of Equation (15) by RHS as
R H S = Ω i 1 τ f α x , t f α e q x , t d Ω Ω i e α · n f α d l
The particle distribution function is assumed to represent a cell-averaged value as
f α t = 1 A i Ω i f α x , t d Ω
where A i represents the area of the i t h cell.

2.4. Collision Terms

The collision term in Equation (16) can be approximated assuming the particle distribution function is uniform over the control volume; thus,
1 A i τ Ω i f α x , t f α e q x , t d Ω = 1 τ f α f α e q
In the FVLBM approach, the collision term represents the microscopic form of the viscous transport in macroscopic scale. The relation between the relaxation time and viscosity [15] is ν = τ c s 2 , and the relaxation time relates to the Reynolds number of the flow as
τ = ν c s 2 = u r e f L r e f R e 1 c s 2
where u r e f is the characteristic flow velocity and L r e f is the characteristic flow dimension.

2.5. Advective Flux Terms

Microscopic streaming of particles across the cell boundary Ω i contributes to the particle distribution function f α , i within the cell Ω i , which is represented by the second term on the RHS. To account for that, the second term on the RHS can be numerically integrated along the path Ω i bounding the cell which, in this case, is triangular in shape. Therefore, the advective flux term is integrated as follows:
Ω i e α · n f α d l = 1 A i j e α · n f α , i j f l u x Δ l i j
Here, j represents the total number of interfaces of i t h cell and Δ l i j ( j = k , l , m ) is the corresponding length of the interface. Referring to Figure 2, the integration path is a collection of three edges Δ l i j ( j = k , l , m ) in the counter-clockwise direction.
We need to consider the evaluation of advective fluxes on an edge-by-edge basis for each cell as f α , i j f l u x represents the value of particle distribution function at the edge Δ l i j . There are two types of edges: first, the internal edges and second, the edges on the boundary of the flow domain. Therefore, in order to advance the solution to the next time step, one needs to carry out two steps in regard to computing advective flux terms: first, reconstructing f α , i j f l u x within Ω i and secondly, computing the flux density F across the edge. The flux density across the edge is given as
F f α f l u x = e α · n f α f l u x
Applying higher-order Godunov’s schemes to arbitrarily shaped cells involves piecewise polynomial approximations within each cell. These approximations could be discontinuous between neighboring cells along a specific edge, resulting in two distinct values of the solution ( f i L , f i R ) as shown in Figure 3. As a consequence, two values of F can be constructed using Equation (21) from the left- and right-neighboring cell centroids across the edge. As detailed by Patil et al. [15], this results in a sequence of Riemann problem; however, F is linear in this case and can be reconstructed using proper reconstruction procedures which satisfy certain criteria [44]. One way to resolve this issue is replacing the real flux F ( f α , i j f l u x ) along the edge with a distinct flux F ¯ f α L , f α R , n ij , which is uniquely defined [15]. n ij represents the outward unit normal to the edge shared by cells i and j. To achieve this, the Roe’s flux-difference splitting scheme [45] is used by applying it to the solution of the approximate Riemann problem in the following manner:
F ¯ f α , i j f l u x = 1 2 F f α R + F f α L a i j f α R f α L
Here, | α i j | is the scaled characteristic speed, which is taken to be equal to the scaled microscopic velocity normal to the edge, e α · n .
In the present study, we have used a linear reconstruction [26] scheme to reconstruct f α , i j f l u x at the edge, which is briefly explained below.

Linear Reconstruction Scheme

Second-order accuracy can be achieved by using the linear reconstruction (LR) proposed by Stiebler [26]. Using the LR scheme, the distribution function at the cell interface can be reconstructed as
f α , i j f l u x = f α , i + f α , i · x i j x i e α · n ij > 0.0 f α , j + f α , j · x i j x j e α · n ij 0.0
where f α , i and f α , j are the gradients computed at the i t h and j t h cell centroid, respectively, using the method of least squares [26] as follows:
m i n f α , i j w i , j f α , j f α , i f α , i · x j x i 2
where j = k , l , m , referring to Figure 2, represent the three neighboring centroids of the i t h cell and w i , j = 1 / ( x j x i ) 2 is the geometrical weighting factor.

2.6. Time Integration

The time levels t and t + Δ t that the discrete f α , i travels during a time step Δ t can be represented by superscripts n and n + 1 , respectively. Since we know the solution f α , i n at time t n , we can compute the cell-averaged solution at the next time step t n + 1 by numerically integrating Equation (15) using the explicit second-order Adams–Bashforth [46] (AB2) scheme as
f α , i n + 1 = f α , i n + Δ t 2 3 R H S n R H S n 1
This approach involves storing data from the previous time step, with the time step restricted by the Courant–Friedrichs–Lewy [47] (CFL) condition. In the above equations, the RHS is obtained using Equation (16). Here, Δ t = t n + 1 t n is the discrete time step. In the present study, we have used the second-order Adams–Bashforth scheme [46] to perform time integration for all the test cases shown in Section 3.
In standard LBM, τ is often the smallest timescale of the system, much smaller than the viscous timescale ( t v i s c = L 2 / ν ) or the convective timescale ( t c o n v = L / U ), where L is the characteristic length scale and U is the characteristic velocity. Therefore, using an explicit time integration scheme significantly reduces the stable time step Δ t , thereby increasing the computational cost of the simulation. For flows in which τ is much smaller than t v i s c and t c o n v , smaller time steps, such as Δ t = τ / 10 or Δ t = 10 4 , have been used in the present study.

2.7. Modeling Non-Newtonian Flows

For Newtonian fluids, the shear stress ( σ ) is directly proportional to strain rate ( γ ˙ ) with a constant proportionality, i.e., the dynamic viscosity ( μ ), that is independent of strain rate. Mathematically, this relationship can be expressed as
σ = μ γ ˙
However, in the case of generalized Newtonian fluids, the relation between the shear stress and strain rate is not linear and viscosity is a function of the local strain rate. For generalized Newtonian fluid, the above relation is modified as follows:
σ = μ | γ ˙ | γ ˙
where μ | γ ˙ | is called ‘effective viscosity’ and the local strain rate can be computed as [48]
γ ˙ x y = 2 D I I
where D I I represents the second invariant of the strain rate tensor, which is computed as
D I I = x , y = 1 2 ε x y ε x y
where ( x , y ) represent the Cartesian coordinate directions and ε x y represents the strain rate tensor. A notable advantage of LBM is that the strain rate tensor can be locally computed using the non-equilibrium part of the particle distribution functions [38,49] as follows:
ε x y = 3 2 ρ c 2 τ Δ t α c α x c α y f α x , t f α e q x , t
where α represents the lattice velocity vector directions.
The non-Newtonian blood viscosity μ ( | γ ˙ | ) can be coupled with the iLBM model using Equation (14) as follows:
τ t = 3 μ γ ˙ t , t ρ
where ρ is considered constant as the iLBM model was derived by considering ρ = 1.0 .
To compute the shear-thinning viscosity of blood, we have used the Carreau model [41] which computes the blood viscosity as
μ γ ˙ = μ + μ 0 μ 1 + λ γ ˙ 2 n 2 / 2
where μ 0 and μ represent the asymptotic viscosities at zero and infinite shear rates, respectively. The parameter λ , which has the dimensions of time, governs the transition of fluid from Newtonian behavior to non-Newtonian behavior with λ = 0 representing Newtonian behavior and λ > 0 representing non-Newtonian behavior. The Reynolds number, in this case, is defined as
R e = ρ U L μ
and the Carreau number is defined as
C a = λ U L
where L represents the characteristic length, which is usually the channel width, and U represents the flow velocity.
The flow parameters must be appropriately scaled from the physical domain to the lattice Boltzmann (LB) domain. For this, the scaling method introduced by Janela et al. [50] in their FVLBM study has been used. LB quantities are denoted with an overbar. The limiting viscosities ( μ 0 and μ ) are scaled using the scaling parameter β as
β = μ ¯ 0 μ 0 = μ ¯ μ
The physical variables are scaled as
u = ρ ¯ H ¯ β ρ H u ¯
λ = β ρ H 2 ρ ¯ H ¯ 2 λ ¯
σ = ρ ¯ H ¯ 2 β 2 ρ H 2 σ ¯
where H represents the width of the channel. Other variables can be scaled similarly.

2.8. Boundary Conditions

One of the most important aspects in any LBM simulation is the handling of boundary conditions. This is a crucial aspect that requires careful consideration. Unlike traditional CFD approaches, where boundary conditions are directly specified in terms of primitive variables like density, velocity, and pressure, LBM takes a different route. In the LBM framework, the boundary conditions manifest through the particle distribution function. This function serves as a representation of those primitive variables along the boundaries of the simulation domain. It is a unique approach that diverges from the more conventional CFD methodologies dedicated to solving the NSEs. Navigating these boundary condition considerations is pivotal to the success of LBM simulations.
As mentioned in Section 2.5, we need to consider the evolution of advective fluxes on an edge-by-edge basis for each cell and that there are two types of edges we have to take care of: internal edges and boundary edges. Now, to reconstruct f α , i j f l u x at the boundary edges, we have used the Non-Equilibrium Extrapolation (NEE) method proposed by Guo et al. [35] and implemented the treatment of boundary edges as proposed by Wang et al. [31].
Referring to Figure 4, we can implement the boundary conditions using the notional ghost cell (GC) and the boundary cell, which is located on the boundary edge but in the interior of the flow domain. This internal boundary cell is termed as the ‘fluid cell’. The boundary edge is shared by the fluid cell and the ghost cell, where n b is the unit normal vector at the boundary edge pointing outwards of the fluid cell. The following section describes how f α , B f l u x is reconstructed at the boundary edge using the fluid and ghost cells. Here, B represents the boundary edge.
To correctly implement the boundary conditions, two steps have to be followed; first, we have to compute the f α , G C at the ghost cell, and secondly, f α , B f l u x has to be reconstructed at the boundary edge using f α , G C .
For wall boundary treatment, we do not need the ghost cell and the f α , B f l u x is directly computed using the boundary cell k as
f α , B f l u x = f α e q P k , u w + f α , k f α , k e q
where u w represents the wall velocity. To implement the no-slip boundary condition, u w = 0 and the normal gradient of pressure is taken as zero. A moving wall can be implemented by setting u w to a non-zero value and linearly extrapolating pressure from the interior domain.
Referring to Figure 4, for the inlet boundary condition, the f α , G C at the ghost cell is computed as
f α , G C = f α e q P , u i n + f α , k f α , k e q
where u i n is the inlet velocity and pressure is extrapolated from the fluid cell as P = P k . If we are dealing with an external flow such as flow over an airfoil or a cylinder, then Equation (40) can be used to implement the boundary condition on the far field of the computational domain by replacing P = P and u i n = u , where P and u represent the free-stream pressure and free-stream velocity, respectively.
Once the distribution functions ( f α , G C ) in the ghost cells are computed, the distribution functions at the boundary cell interface ( f α , B f l u x ) can be computed. For the inlet boundary, the distribution function ( f α , B f l u x ) at the inlet boundary cell interface can be computed as
f α , B f l u x = f α , k + f α , k · x B x k e α · n B > 0.0 f α , G C e α · n B 0.0
For the outlet boundary, we can use simple first-order extrapolation to compute f α , G C in the ghost cell at the outlet as
f α , G C = f α , k
Second-order accuracy can be achieved by using the NEE method [35]. Referring to Figure 4, the f α , G C in the ghost cell can be computed as
f α , G C = f α e q P o u t , u k + f α , k f α , k e q
Once the distribution functions are computed in the ghost cell, the distribution function ( f α , B f l u x ) at the outlet cell interface can be computed as
f α , B f l u x = f α , k + f α , k · x B x k e α · n B > 0.0 f α , G C e α · n B 0.0
For symmetric boundary, we can compute the f α , G C as
f α , G C = f α e q P k , u , v
where u and v are the components of the velocity in x- and y-direction, respectively, which can be extrapolated from the interior domain. Depending on the orientation of the symmetric interface, u and v can be computed as u = u k and v = v k for a horizontal interface, and other directions can be dealt with in a similar manner. For the symmetric boundary, the distribution function at the boundary cell interface can be computed as
f α , B f l u x = 1 2 ( f α , k + f α , G C )

2.9. Implementation Algorithm

Based on the above discussion on finite volume LBM formulation and boundary condition implementation, the general algorithm [31] for implementation of FV-iLBM approach is as follows:
1.
Initialize P, u x , and u y in the simulation domain. Use these values to initialize f α , i L B M e q using Equation (11). Set f α = f α , i L B M e q .
2.
Compute the gradient of f α in each cell using Equation (24).
3.
Compute wall, inlet, outlet, and symmetric boundary conditions.
4.
In case of non-Newtonian flow, perform the following:
(a)
Compute the strain rate tensor using Equation (30).
(b)
Compute the second invariant of strain rate tensor D I I using Equation (29).
(c)
Compute local strain rate γ ˙ x y using Equation (28).
(d)
Compute the effective viscosity μ γ ˙ using Equation (32).
(e)
Compute the relaxation time τ using Equation (31) to couple the Carreau model with the iLBM model.
(f)
Compute the shear stress using Equation (27).
5.
Compute advective and collision terms using Equation (16).
6.
Using the time integration scheme (Section 2.6), update f α from time level n to n + 1 .
7.
Compute the macroscopic quantities P and u in each cell.
8.
Return to Step 2 to start the next iteration.

3. Results and Discussion

This section presents the results of validation test cases to assess the accuracy and applicability of the FV-iLBM solver developed in-house. Simulations include Taylor–Green vortex flow, shear wave decay, developing flow through a 2D channel, Womersley flow, lid-driven cavity flow, and flow over the NACA0012 airfoil. Additionally, validation results for non-Newtonian flows through both straight and stenosed channels are discussed. Finally, the FV-iLBM solver is applied to simulate non-Newtonian blood flow through an artery with multiple stenoses.

3.1. Taylor–Green Vortex Flow

The Taylor–Green vortex (TGV) is a canonical benchmark in fluid dynamics that captures essential mechanisms of vortex dynamics, turbulent transition, and energy cascade. Its three-dimensional vortex stretching and reconnection processes are representative of phenomena observed in real-world turbulent flows, such as those in ocean currents, atmospheric systems, and industrial mixing [51]. In engineering, the TGV problem provides a rigorous validation test for numerical schemes targeting large-eddy simulation (LES) and direct numerical simulation (DNS) of turbulent flows, with applications in aerospace (e.g., flow over wings, turbomachinery), combustion chambers, and biomedical devices. Thus, the results from the TGV case are instrumental in evaluating the solver’s ability to accurately resolve complex, unsteady flow features relevant to practical scenarios.
The evolution of the Taylor–Green vortex flow in a 2D square domain has a time-dependent analytical solution that can be used to perform error estimation using L 1 , L 2 and L error norms [52] to evaluate the order-of-accuracy of the reconstruction methods used. Here, the Taylor–Green vortex flow in a square domain ( L = W = 1.0 ) has been studied for different control volume sizes. Periodic boundary conditions are applied on both x- and y-direction boundaries. The analytical solution [53,54] for this case is given by
u x , y , t = U e x p 2 ν t ζ 2 c o s ζ x s i n ζ y
v x , y , t = U e x p 2 ν t ζ 2 s i n ζ x c o s ζ y
P t = 1.0 3 U 2 4 c o s 2 ζ x + c o s 2 ζ y e x p 4 ν t ζ 2
where U is set to 0.01 and ζ represents the wave number, which is set to 2 π / L . The initial conditions are obtained by substituting t = 0 in the above equations. As time progresses, at any instant ( t > 0 ) , viscosity will cause the initial magnitude of velocity to decay. The decay of velocity in x- and y-direction can be obtained using Equation (47) and Equation (48), respectively.
Figure 5 shows the x-direction velocity profiles along the location y / W = 0.75 against the non-dimensional time t obtained using the FV-iLBM model in conjunction with the LR scheme. The non-dimensional time t is computed as t = N t × Δ t , where N t is the number of time steps. The time step Δ t is taken as 10 4 , whereas the relaxation parameter has been kept fixed at 0.01. The analytical solution at four different time instances— t = 0.0 , 1.0 , 2.0 , and 3.0 —has been plotted. The iLBM model in conjunction with the LR scheme has produced excellent agreement with the analytical solution at different time instances. The excellent agreement between our numerical results and the analytical solution demonstrates that the FV-iLBM model with the LR scheme can accurately capture complex flow physics.
In order to perform error estimation to evaluate the order-of-accuracy, simulations have been performed using four different grids with increasing mesh refinement. Four grids with a total cell count of 37,986, 67,836, 139,792, and 253,942 cells have been used for this purpose. As the mesh is refined, the characteristic length δ l , representing the smallest length of an edge in mesh, as well as the error obtained using L 1 , L 2 and L norms should decrease, giving us an estimate of the order-of-accuracy. In Figure 6, the error assessment, determined through the L 2 norm, is presented for the four grids mentioned above. It is evident that as the mesh undergoes refinement, the L 2 error diminishes in a consistent second-order manner. This observation validates the second-order precision of the LR scheme integrated into the existing finite volume implementation of the iLBM model. Table 1 quantifies the convergence behavior of the numerical scheme for the Taylor–Green vortex flow by reporting L 1 , L 2 and L error norms across the progressively refined grids mentioned above. A systematic reduction in all error norms with decreasing characteristic length δ l indicates a consistent convergence of the solution. This trend validates the spatial accuracy of the method and its ability to resolve the flow field with increasing fidelity under grid refinement.

3.2. Decay of a Shear Wave

The attenuation of a shear wave with a wavelength equal to the domain size ( L = 1 ) is discussed next. A square domain with both x- and y-direction boundaries set to periodic boundary conditions has been used for simulating the decay of a shear wave. The x- and y-direction velocities at the initial time instant ( t = 0 ) have been taken as per those specified by Sofonea and Sekerka [55] and are given by
u x , y , 0 = U s i n 2 π y
v x , y , 0 = 0
where U has been set to 0.01 . At any time instant t, the analytical solution along the y-direction is given by
u y , t = U e 4 π ν t s i n ( 2 π y )
The relaxation parameter has been taken as 0.01, while the time step Δ t is taken as 10 4 . As the solution marches in time, the initial shear wave at time instant t = 0 decays, and the x-direction velocity profiles corresponding to different time instants obtained using the iLBM model in conjunction with the LR scheme and AB2 time integration method have been compared with the analytical solution in Figure 7. The results shown in Figure 7 have been obtained using an unstructured triangular mesh where a majority of the elements were equilateral triangles with a total cell count of 238,244 cells. As observed, the velocity profiles obtained using the iLBM model in conjunction with the LR scheme agree well with the analytical solution with minor disagreement for t > 8 .
In the finite volume framework, the discretization of the advection term in LBE induces certain numerical viscosity [15], which affects the accuracy of the scheme used to solve the advection term. Ideally, the apparent kinematic viscosity should be equal to the physical value of the viscosity. Sofonea and Sekerka [55] extracted the kinematic viscosity from the numerical results using
ν = 1 4 π 2 t l o g A 0 A t
where the Fourier coefficient, A ( t ) , can be obtained as
A t = 0 L u y , t s i n 2 π y d y
In the above simulation, we have kept the relaxation parameter τ fixed at 0.01 and as per Equation (14), and the resultant kinematic viscosity value is 3.33 × 10 3 in LBM units. Figure 8 shows the time evolution of kinematic viscosity. The kinematic viscosity obtained using the LR scheme is approximately 3.31 × 10 3 , which is within 1 % of the target value. This shows that very minimal non-physical numerical diffusion is present in the current numerical predictions obtained by the LR scheme and that it always maintains second-order accuracy.

3.3. Developing Flow in a 2D Channel

Developing flow in a 2D channel has been simulated using a rectangular domain ( L = 5.0 , W = 1.0 ) . Providing a uniform velocity at the inlet, the flow is allowed to develop in the channel, and the velocity profile obtained at the outlet is compared with the analytical solution. At the inlet, a uniform velocity profile using U = 0.1 is provided and the pressure is linearly extrapolated from the interior domain, whereas at the outlet, the pressure is fixed ( P o u t = 1.0 ) and the velocity is linearly extrapolated from the interior domain. At the top and bottom walls, no-slip condition is applied using the NEE scheme [35] and the normal gradient of pressure is taken as zero.
A Reynolds number of 100 based on the inlet velocity and channel width has been simulated and time step taken as τ / 10 . Figure 9a shows the outlet velocity profile (mesh with 120 elements in the y-direction and 500 elements in the x-direction with a total cell count of 120,000 cells) obtained using the FV-iLBM model in conjunction with the LR scheme, which accurately captures the velocity profile.
Figure 9b shows the distribution of pressure along the length of the channel at the centerline. In the entrance region of the pipe, there is an acceleration of flow, leading to a transition from a uniform velocity profile at the entrance to a fully developed profile by the end of this entrance region. Consequently, the pressure gradient magnitude is higher in the entrance region compared to that in the fully developed region. Once the flow is fully developed, the pressure gradient remains constant. A non-zero pressure gradient arises due to viscous forces, resulting in a pressure drop from the channel entrance to the fully developed region as pressure force is required to overcome the resistance produced by viscous forces.

3.4. Womersley Flow

The capabilities of the FV-iLBM model to simulate the transient flow has been tested using the Womersley flow [56] in a 2D channel. NEE no-slip conditions are applied on the top and bottom walls of the channel. A time-dependent pressure difference d P is applied on the inlet and the flow is driven by the fluctuation of pressure gradient d P given by
P x = R e A e i ω t
where A = d P / L x and the analytical solution is given by [56]
u x y , t = R e i A e i ω t ω 1 c o s λ 2 y / L y 1 c o s λ
where λ = i α 2 , ω is the frequency of the pressure pulse, and α is the Womersley number representing the relationship of transient inertial forces to viscous forces, given by
α = L y ω ν
The Womersley number ( α ) considered here is 4.045 and the pressure gradient d P applied is 0.0032 in LBM units. The Reynolds number simulated is 25. L x and L y represent the domain length in x- and y-direction, respectively, where L x = L y = 1.0 . An unstructured mesh with a total cell count of 85602 elements has been used to perform simulations. The maximum centerline velocity u m a x is calculated using the Hagen–Poiseuille equation. Once the Womersley number is chosen, the frequency of the pressure pulse is determined, which in turn determines the time period (T) as 2 π / ω . Figure 10 shows the non-dimensional velocity profiles at different time periods (in factors of 1 / 8 ) obtained using the iLBM model, in conjunction with the LR scheme, compared against the analytical solution of Equation (56). The velocity profiles have been extracted along the y-direction at x = L x / 2 . The velocity profiles obtained using the standard LBM model have also been plotted to show a comparison with the iLBM model. As can be seen from Figure 10, velocity profiles obtained using the iLBM model are more accurate than those obtained using the standard LBM model.
Table 2 shows the comparison of the maximum centerline velocity ( u m a x ) obtained using the iLBM and standard LBM models with the analytical centerline velocity, where the proficiency of the iLBM model over the standard LBM model is evident. The analytical value for centerline velocity at time period T / 4 is very close to zero, where the numerical models will struggle to capture the velocity profiles. Thus, the centerline velocity values obtained using the iLBM and standard LBM models deviate from the expected results [17].
To further evaluate the performance of the iLBM model, a quantitative comparison was conducted against the standard LBM model (both models implemented in the finite volume framework) for the Womersley flow case. As summarized in Table 3, for a serial implementation, the iLBM model incurs a modest increase in memory usage per cell (∼104 bytes vs. ∼96 bytes) due to the inclusion of pressure terms. However, it achieves a significant improvement in both computational efficiency and accuracy, with a ∼15.2% reduction in runtime per iteration and a ∼38.9% lower L2 error. These results demonstrate that the FV-iLBM model offers a favorable trade-off between memory footprint and overall simulation performance, highlighting its potential for accurate and efficient incompressible flow simulations.
The proficiency of the iLBM model to limit the compressibility error while simulating pulsating flows is a significant finding of this study. Pulsating flows play a pivotal role in a wide array of fluid dynamics scenarios with applications ranging from cardiovascular health assessment to thermal energy engineering, electronic engineering, machinery manufacturing, chemical engineering, etc. Reciprocating compressors, pulse combustion chamber, microdiffusers, micropumps, and microchannels all feature pulsating flows. In electronic engineering, the rate of heat transfer is enhanced using pulsating flows. The iLBM model can be effectively used to simulate flows across these applications and explore the flow physics involved.

3.5. Lid-Driven Flow in a 2D Square Cavity

The steady state solution of a lid-driven flow in a 2D square cavity ( L = W = 1 ) at different Reynolds numbers has been studied to assess the capabilities of the FV-iLBM solver. The Reynolds number, in this case, is based on the width of the cavity as R e = U L / ν , where L is the cavity width and U is the velocity of the top plate. Four different Reynolds numbers have been simulated: 100, 400, 1000, and 3200. The wall velocity boundary condition given by Equation (39) has been applied to all the four walls of the cavity with a velocity of the top wall U set to 0.1. For the remaining three walls, the no-slip boundary condition has been imposed for velocity and the normal gradient of pressure has been taken as zero. The time step has been taken as τ / 10 . The NSE results of Ghia et al. [57] have been considered as the benchmark solution here. The results obtained using the FV-iLBM model in conjunction with the LR scheme and AB2 time integration method are presented here.
To simulate lid-driven flow for R e = 100 , an unstructured grid with 200 triangular cells on each wall and a total cell count of 105,692 cells has been used. Figure 11 shows the normalized axial and radial velocity profiles for R e = 100 . As can be observed from the figure, the FV-iLBM predictions agree well with the benchmark solution [57]. Table 4 lists the x- and y-coordinates of the centers of primary vortex, bottom right vortex, and bottom left vortex obtained for R e = 100 . The results obtained using the FV-iLBM approach are compared with the benchmark solution and those obtained by Patil et al. [15]. As observed, the FV-iLBM approach accurately captures the location of all the vortices.
As the Reynolds number increases, the numerical predictions for the lid-driven flow depend on how well the boundary layer is resolved. Therefore, for simulating lid-driven flow with R e = 400 ,   1000 , and 3200, an unstructured grid with 250 triangular cells on each wall and a total cell count of 164,756 cells has been used. Figure 12 shows the streamlines obtained for the lid-driven flow with R e = 1000 and 3200, and as observed, important flow features such as corner vortices including the top left corner vortex for R e = 3200 has been captured by the FV-iLBM model, implying that the boundary layer has been adequately resolved.
Figure 13 shows the normalized axial and radial velocity profiles for lid-driven flow with R e = 400 and R e = 1000 , respectively. The FV-iLBM model in conjunction with the LR scheme captures the velocity profiles accurately. Table 4 lists the x- and y-coordinates of primary, bottom right, and bottom left vortices for lid-driven flow with R e = 400 and R e = 1000 . As the Reynolds number increases, the locations of the vortices produced by the FV-iLBM model agree well with the benchmark solution. Comparing the vortex locations produced by the FV-iLBM model with those obtained by Patil et al. [15] and Wang et al. [31], FV-iLBM predictions are competitive with both of these studies for R e = 400 . For R e = 1000 , the FV-iLBM predictions are better than those obtained by Patil et al. [15] and are competitive with those obtained by Wang et al. [31].
For R e = 1000 , we have also compared the width and height of the corner vortices obtained using the FV-iLBM model with benchmark [57] and those obtained by Patil et al. [15] and Wang et al. [31]. As shown in Table 5, the size of the bottom left vortex obtained using the FV-iLBM model agrees adequately with the benchmark solution and is competitive with those obtained by Patil et al. [15] and Wang et al. [31]. For the bottom right vortex, the FV-iLBM model produces superior results than both of these studies and agrees well with the benchmark solution.
Figure 14 shows the normalized axial and radial velocity profiles obtained for R e = 3200 using the FV-iLBM model in conjunction with the LR model. The FV-iLBM predictions are compared with those obtained by Patil et al. [15] to make a qualitative comparison. The FV-iLBM predictions agree well with the benchmark solution and are superior to those obtained by Patil et al. [15]. As pointed out by Wang et al. [31], the numerical predictions obtained by Patil et al. [15] suffer from non-physical numerical diffusion, resulting in disagreement between their numerical predictions and the benchmark solution.
Table 6 lists the x- and y-coordinates of the centers of primary, bottom right, bottom left, and top left vortices, whereas Table 7 details the width and height of the corner vortices obtained for the lid-driven flow with R e = 3200 . The locations of corner vortices obtained using the FV-iLBM model in conjunction with the LR scheme agree well with the benchmark solution and are superior to those obtained by Patil et al. [15]. Barring the size of the top left vortex, the width and height of the bottom left and bottom right vortices produced by the FV-iLBM model are very close to the benchmark solution, are superior to those obtained by Patil et al. [15], and are close to those obtained by Wang et al. [31].

3.6. Flow over NACA0012 Airfoil

External flow over the NACA0012 airfoil with a Reynolds number of 1000 has been simulated using the FV-iLBM model. Reynolds number, in this case, is defined as R e = U L / ν . Here, U = 0.1 is the free-stream velocity, L = 1.0 is the chord length, and ν is the kinematic viscosity. Figure 15a shows the schematic of the domain used for simulating flow over the NACA0012 airfoil. The far-field boundary is located at 10L in all directions from the stagnation point, which is large enough to eliminate the influence of far-field boundary on the flow.
The far-field boundary condition is applied using ghost cells in conjunction with Equations (40), (59), and (60) as
f α , G C = f α e q P , u x , u y + f α , k f α , k e q
where P = 1.0 is the free-stream pressure in LBM units. On the airfoil surface, the no-slip boundary condition has been imposed for velocity and the normal gradient of pressure has been taken as zero. The time step has been taken as τ / 10 .
We have studied four different angles of attack: 7 , 8 , 9 , and 11 . The velocity components corresponding to different angles of attack are set as
u x = U c o s θ π 180
u y = U s i n θ π 180
where θ represents the angle of attack in degrees.
We have used three different unstructured grids with cell counts of 38,710 (grid 1), 75,868 (grid 2), and 120,520 cells (grid 3) having 198, 398, and 798 cells on the airfoil surface, respectively. The grid is refined by refining the cell count surrounding the airfoil as shown in Figure 15b.
To understand the effect of grid refinement on numerical predictions, we have simulated the flow over the NACA0012 airfoil at an angle of attack of 8 and plotted the distribution of pressure coefficient ( c p ) on the airfoil surface. The NSE solution of Kurtulus [58] has been used as the benchmark solution in the present study. The distribution of c p on the airfoil surface is computed as
c p = P P 1 2 ρ U 2
Figure 16a shows the distribution of mean pressure coefficient for angle of attack 8 obtained using the FV-iLBM model using the three grids mentioned above. The c p profile obtained using grid 1 captures the distribution adequately on the bottom surface; however, it also shows disagreement with the benchmark solution on the top surface. Grid 2 and grid 3 accurately capture the c p distribution on both the top and bottom surfaces of the airfoil. Based on this analysis, we have used grid 2 for the remaining analysis. Furthermore, to evaluate the trade-off between accuracy and computational efficiency, we examined the L2 error as a function of total runtime for three successively refined grids (38 k, 75 k, and 120 k cells). As shown in Figure 16b, the error decreases significantly when increasing resolution from 38 k to 75 k cells, reducing from 0.171 to 0.151. However, further refinement to 120 k cells yields minimal improvement (L2 error = 0.1529) while increasing runtime from 335 to 473.8 h—an increase of ∼41%. This trend illustrates a classic diminishing return with respect to grid refinement and motivates the choice of the 75 k cell grid for the bulk of our simulations as the optimal compromise between accuracy and computational cost.
The Karman vortex street theory, studying the flow around bluff bodies, describes the occurrence of periodic vortex shedding, which in the case of a flow over an airfoil depends on the angle of attack. Figure 17 depicts the instantaneous streamlines for flow over the NACA0012 airfoil for R e = 1000 and angles of attack, θ = 7 , 8 , 9 and 11 . The initiation of unsteady vortex shedding has been observed at angle of attack 8 , and as the angle of attack is increased further, an enlargement of flow instabilities at the rear of the airfoil has been observed. These observations are in line with those pointed out in the literature [58,59].
The distribution of mean pressure coefficient along the non-dimensional chord C ¯ for angles of attack θ = 7 , 8 , 9 and 11 is shown in Figure 18. The c p profiles obtained using the FV-iLBM model are compared with those available in ref. [58]. The c p distribution over both lower and upper airfoil surfaces obtained using the FV-iLBM model agrees well with those from the literature. As stated above, as θ increases, the flow instabilities at the rear of the airfoil grow in size along the trailing edge, where a very minor disagreement between FV-iLBM predictions and the benchmark [58] has been observed for θ = 11 .
Figure 19 shows the instantaneous pressure field. Figure 20 shows the instantaneous vorticity contours. As the angle of attack is increased, we observe the onset of lift generation and an observation of onset of unsteady vortex shedding at 8 . Vortex shedding becomes apparent at 9 , giving rise to the formation of two counter-rotating vortices. As the angle of attack increases further, there is an augmentation in the strength of vortices, which is in line with the observation in Figure 17.
Overall, a good agreement is observed between the FV-iLBM predictions and those from the ref. [58] with the FV-iLBM model producing consistent and encouraging results. As the FV-iLBM predictions transition from the symmetric flow at lower angles of attack to the onset of lift generation, flow separation, and increased pressure drag at higher angles, these findings highlight the airfoil’s sensitivity to the changes in angle of attack and the capability of the present FV-iLBM solver to accurately capture the flow physics of the unsteady aerodynamic applications.

3.7. Validation of FV-iLBM Solver for Non-Newtonian Fluid Flow

The FV-iLBM model has been validated for non-Newtonian fluid flow by simulating the flow through a straight as well as a stenosed channel and comparing the results with those provided by Janela et al. [50]. The Carreau model [41] has been used to simulate the non-Newtonian blood viscosity.
As explained in Section 2.7, the Carreau model [41] simulates the effective viscosity using Equation (32). In the Carreau model, the parameter λ governs the transition region where the viscosity drop occurs and has the unit of time (s). The Carreau model is most sensitive to μ 0 and λ , which can have substantial impact on numerical predictions. They are essentially derived from extrapolated data due to technical challenges associated with measuring viscosity at low shear rates [50]. The FV-iLBM model has been validated by modeling the non-Newtonian flow through a 2D straight channel with different values of λ . The schematic of the 2D straight channel is shown in Figure 21.
The selected geometry and flow conditions are suitable for simulating blood flow in an arteriole. The flow conditions [50] are as follows:
ρ = 1 g / cm 3 U m a x = 2.2 cm / s H = 0.02 cm μ 0 = 0.56 P o i s e μ = 0.0345 P o i s e
Using Equation (33), the Reynolds number is found to be 0.157. Considering the physiological range [50], two different λ values, namely 0.01 and 0.1 s, have been simulated using the FV-iLBM model in conjunction with the LR scheme.
The flow domain shown in Figure 21 has been normalized to a rectangle of dimension [−3, 3] × [−1, 1] and the flow conditions mentioned in Equation (62) are scaled from physical units to LB units using Equation (35), Equation (36), and Equation (37). Following Janela et al. [50], the scaling parameter, β , from Equation (35) has been taken as 0.05 . After scaling into the LB units, we have the following flow conditions:
ρ ¯ = 1.0 U ¯ m a x = 0.0022 H ¯ = 1.0 μ ¯ 0 = 0.0280 μ ¯ = 0.001725
The power-law index (n) in the Carreau model (Equation (32)) has been taken as 0.3568 and λ has been carefully scaled in LB units using Equation (37). The iLBM model [17] is a pressure-based LBM scheme derived from a constant density ( ρ ¯ = 1.0 ), and density plays no further part in the iLBM’s formulation.
A parabolic velocity profile with a maximum velocity U m a x is enforced at inlet, whereas at the outlet, the pressure is fixed ( P ¯ = 1.0 ) and the velocity is linearly extrapolated from the interior domain. No-slip condition is applied at the top and bottom walls using the NEE scheme [35] and the normal gradient of pressure is taken as zero. Figure 22a shows the velocity profiles obtained using the FV-iLBM model for different λ values. A Newtonian case with λ = 0.0 s has also been simulated for comparison. As the λ value increases, the velocity profile flattens at the core of the channel due to a larger value of viscosity at low shear rates, and the FV-iLBM model has accurately captured this trend.
Figure 22b shows the viscosity profiles for λ = 0.01 , and 0.1 s. As the λ value increases, the viscosity also increases along the core of the channel changing from almost a parabolic profile at a lower λ value to a more refined profile at a higher λ value, which is in line with the flattening of the velocity profile at the core of the channel observed in Figure 22a. As observed from Figure 22b, the FV-iLBM model accurately captures the effect of different λ values on viscosity.
The FV-iLBM model has also been validated for modeling non-Newtonian flow through a stenosed channel. For this purpose, a 2D channel with a longitudinal span of [ L , L ] and a stenosis centered at x = 0 as shown in Figure 23 has been considered.
Figure 23 shows the schematic of the 2D channel used to simulate the flow of blood through arterial stenosis. The stenosis or constriction is obtained using the following equation [50]:
H x H 0 = 1 δ e ϕ x / H 0
where H ( x ) is the height of the channel, δ is the degree of stenosis, and ϕ is the length of the stenosis. To maintain a slowly varying profile of stenosis, a sufficiently small ϕ should be chosen. Different degrees of stenosis ( δ ), in a circular cross-section, can be calculated as follows [60]:
% s t e n o s i s = 100 1 1 δ 2
A flow obstruction of 50%, as shown in Figure 23, has been obtained using the following parameters [50]:
δ = 0.3 ϕ = 0.8
In the present study, following Janela et al. [50] and Cho and Kinsey [61], the following parameters are used for the Carreau model:
λ = 0.15 s n = 0.3568 μ 0 = 0.56 P o i s e μ = 0.0345 P o i s e
The flow is driven by a pressure gradient. Following Janela et al. [50], this gradient matches that of flow in a straight channel with λ = 0.15 s and n = 0.3568 . A no-slip condition is applied at the top and bottom walls using the NEE scheme [35], with a zero normal gradient of pressure. At the outlet, the pressure is fixed at P ¯ = 1.0 , and the velocity is linearly extrapolated from the interior domain. With H 0 = 0.02 cm, L = 0.1 cm, and ρ = 1   g / cm 3 , the selected geometry and flow conditions are consistent with blood flow in an arteriole or small artery.
Figure 24 shows the velocity profiles obtained at the throat of the stenosis and at the centerline along the length of the channel. Figure 25 shows the viscosity profile at the throat of the channel. For the Carreau model, when λ > 0.1 s, the viscosity shows a prominent peak along the centerline due to low shear stress [50]. The FV-iLBM model accurately captures this effect and predicts both velocity and viscosity profiles accurately.

3.8. Blood Flow Through an Artery Afflicted with Multiple Stenoses

Based on the results above, the finite volume iLBM approach can be used to simulate cardiovascular fluid dynamics effectively. The effects of different cardiovascular flow conditions on the well-being of arterial health can be quantified using parameters such as time-averaged wall pressure (TAWP), time-averaged wall shear stress (TAWSS), and oscillatory shear index (OSI). These indices are computed by time-averaged wall shear stress over one cardiac cycle. TAWSS, which is a measure of wall shear stress for one cardiac cycle, is computed as
T A W S S = 1 T 0 T σ w d t
OSI—which is used to identify regions where the flow deviates most from its average direction and wall shear stress fluctuates the most—is computed as
O S I = 1 2 1 0 T σ w d t 0 T σ w d t
Time-averaged wall pressure (TAWP) is computed as
P ¯ w = 1 T 0 T P w d t
Using these indices, regions of low and oscillatory wall shear stress can be identified, which can be used to understand the factors that contribute to the progression of cardiovascular diseases such as atherosclerosis.
The coronary artery, a vital vessel supplying oxygen-rich blood to the myocardium, has a complex geometry often affected by multiple stenoses [62]. Simplifying its structure while preserving key characteristics is essential for studying arterial hemodynamics. Figure 26 illustrates the schematic of an artery with triple stenoses, each of varying severity. In the figure, S i denotes the stenosis location, i is the stenosis index, X represents the half-length, δ the severity, and H 0 the channel half-width.
The triple stenoses shown in Figure 26 has been obtained using Equation (69) as
H ( x ) = H 0 δ i 2 1 + c o s π x S i x i S i X i < x < S i + X i i = 1 , 2 , 3 H 0 o t h e r w i s e
Table 8 shows different degrees of stenosis for corresponding δ values that have been considered in the present study. The third column in Table 8, titled designation, facilitates reference for terminology in the discussion. Here, S, M, and L denote ‘small’, ‘medium’, and ‘large’ stenosis severity, respectively. The configuration shown in Figure 26 is termed ‘S-M-L’ configuration.
The human coronary artery diameter typically ranges from 3 to 5 mm. In this study, for a 2D planar domain (Figure 26), an artery height ( 2 H 0 ) of 5 mm is considered. The model parameters representing blood flow in human arteries have been considered as per Abbasian et al. [63]. They are as follows:
λ = 3.313 s n = 0.3568 μ 0 = 0.56 P o i s e μ = 0.0345 P o i s e
The problem is scaled to LB units by setting the scaling parameter to β = 0.03 . In Figure 26, the locations of stenoses are as follows:
S 1 = 4.0 S 2 = 7.0 S 3 = 10.0
Considering the pulsatile nature of blood flow through the arteries, a pulsatile velocity has been set at the inlet of the artery using
u i n t = Q t A
where A is the cross-sectional area of the inlet surface and Q ( t ) is the pulsatile flow rate. Considering a 2D planar domain, the cross-sectional area is calculated considering unit width. Referring to Figure 26, if 2 H 0 is the artery height and W is the width of the artery, then the cross-sectional area is calculated as A = 2 H 0 × 1.0 .
The inlet pulsatile velocity is derived from the pulsatile flow rate waveform [64] shown in Figure 27, which is expressed using the Fourier series as
Q t = Q ¯ + n = 1 4 A n Q c o s n ω t + B n Q s i n n ω t
The coefficients A n Q and B n Q are obtained using the MATLAB 2021b curve fitting tool. The coefficients are obtained using the [65] curve fitting tool and are listed in Table 9.
The time-averaged volumetric flow rate obtained using the MATLAB curve fitting tool is Q ¯ = 0.158 L/min. The pulsatile inlet velocity is scaled to LB units using Equation (36). In Equation (71), the angular velocity ω relates to the cardiac cycle as T = 2 π / ω . The waveform [64] shown in Figure 27 has a time period of T = 0.8 s, corresponding to an average pulse rate of 75 beats/min. Given the coronary artery diameter, the Womersley number is α = 3.88 and the Reynolds number is R e = 80 . Three cardiac cycles are simulated with a time step of 0.03 μ 0 , as shown in Figure 27.
Figure 28 illustrates the unstructured triangular mesh used for the S-L-M configuration, with a highly refined grid near the artery walls to accurately capture flow physics and a progressively coarser mesh toward the core to optimize cell count. A grid independence study was conducted using three meshes: grid 1 (coarse) with 519 wall cells and 41,772 elements, grid 2 (medium) with 802 wall cells and 72,600 elements, and grid 3 (fine) with 1209 wall cells and 99,892 elements. As shown in Figure 29, the wall shear stress profiles from grid 2 and grid 3 closely match, and therefore, grid 2 has been selected for the blood flow analysis through multiple stenoses.
The pressure along the arterial wall plays a critical role in the development of arterial diseases. Figure 30 shows the time-averaged wall pressure along the top wall of the stenosed artery obtained using the FV-iLBM model. S L M refers to the wall pressure obtained along the top wall of the stenosed artery with the S-L-M stenosis configuration, whereas ‘ n o r m a l ’ refers to the wall pressure obtained for the normal artery without any stenosis.
As the flow encounters the small stenosis, we observe a drop in pressure and attempts to recover post the stenosis. However, the flow encounters the large stenosis and we observe the largest pressure drop, after which we observe pressure recovery. A final dip in pressure distribution is observed after the the medium stenosis; however, it does not affect the wall pressure substantially. On the other hand, a linearly decreasing pressure profile is observed for the normal artery, which is the normal tendency of the fluid pressure due to friction along the length of the artery wall.
As fluid flow approaches the narrowing (stenosis) in the artery, there is a sudden drop in pressure with the lowest wall pressure corresponding to the highest average velocity of fluid flow. The cross-sectional area for flow decreases as it approaches the stenosis, reaching its minimum at the narrowest point (throat), then increases again as it moves toward the exit of the stenosis. According to the principle of continuity for incompressible fluids, the average velocity of flow is inversely proportional to the cross-sectional area. Therefore, the maximum average velocity at the stenosis throat corresponds to the minimum pressure at that point. Following a sharp pressure drop at the stenosis, there is a partial recovery in wall pressure downstream due to the conversion of kinetic energy into pressure energy in the diverging section of the stenosis. However, the pressure does not return to its original value due to irreversible losses caused by viscous effects.
As mentioned above, the average flow velocity is inversely proportional to the cross-sectional area and as the flow approaches the stenosis, the cross-sectional area for the flow decreases, resulting in a rise in flow velocity. Figure 31 shows the velocity and viscosity profiles obtained at the peak of the cardiac cycle corresponding to systolic pressure. Figure 31a shows the velocity profiles, whereas Figure 31b shows the viscosity profiles obtained along the throat at three stenoses.
As observed from Figure 31a, as the percentage of stenosis increases, the peak velocity at the stenosis throat increases. At the peak of the cardiac cycle, blood flow velocity reaches 14 cm/s at the small stenosis, 19 cm/s at the medium stenosis, and almost 30 cm/s at the large stenosis, which is more than twice of that obtained for the normal artery without any stenosis. From Figure 31b, we obtain viscosity profiles that correspond to velocity profiles observed in Figure 31a. Viscosity is a measure of a fluid’s resistance to flow. It determines how easily a fluid deforms under shear stress. In the context of fluid flow, viscosity affects the velocity gradient within the fluid. This means that in regions where there is a high velocity gradient (such as near walls of the artery), viscosity resists the flow, resulting in viscous drag. Therefore, as the blood accelerates after encountering small, large, and medium stenoses, we observe a corresponding reduction in magnitude of viscosity. The viscosity, which depends on shear, decreases notably in the central region where shear is minimal. Consequently, the typically parabolic shape of the velocity profile becomes flattened at the center of the channel, which is what we have observed for velocity profiles at the throat of small and large stenoses.
The shear stress experienced by the arterial wall near a stenosis is significant, as it can provide insights into the mechanisms behind post-stenotic dilatation and contribute to understanding the development and progression of arterial stenosis. Figure 32a shows the time-averaged wall shear stress at the top wall. Changes in blood flow velocity occur within both the stenotic and post-stenotic zones due to alterations in the flow pressure gradient. Since wall shear stress is a function of velocity gradient and the highest velocity gradient occurs at the stenosis throat, we observe shear stress peaks as the flow accelerates across the stenosis. Referring to Figure 32a, as the flow encounters the small stenosis, we observe the first rise in wall shear stress that is proportional to the degree of small stenosis, following which shear stress reduces in the post-stenotic region. The largest peak in wall shear stress is observed for the large stenosis, where the velocity gradient is at its peak. Downstream of the large stenosis, the wall shear stress reduces to the normal value, and upon encountering the medium stenosis does in fact result in its rise again; however, this rise is not commensurate with the degree of medium stenosis, which was observed for small stenosis. From this observation, it is evident that large stenosis has affected the downstream flow dynamics. From Figure 32b, we can observe the rise in instantaneous centerline velocity at the peak of the cardiac cycle as the flow encounters multiple stenoses. Following the large stenosis, we observe a fall in centerline velocity, and after the medium stenosis, the velocity behavior is not altered.substantially.
Endothelial cells are the cells that form the inner lining of blood vessels, including arteries. They play a crucial role in maintaining the health and function of blood vessels. One of the factors that influence endothelial cell function is shear stress [66]. When blood flows smoothly and evenly along the vessel wall, shear stress is relatively constant. However, in case of a stenosed artery, high peak wall shear stress can lead to damage in the vessel wall, resulting in the thickening of the intima (the innermost layer of an artery), aggregation of platelets, and ultimately leading to thrombus (a blood clot) formation. Conversely, low shear stress in the region of flow separation is linked to mass transportation across the arterial wall and prolonged interaction time between platelets and endothelium. This increases the likelihood of atherosclerosis formation as the percentage of restriction in the artery increases.
In areas where blood flow is disturbed or chaotic, such as bends or downstream of stenosis, shear stress becomes oscillatory, meaning that it fluctuates in magnitude and direction rapidly over time. Endothelial cells respond differently to oscillatory shear stress compared to steady shear stress [67]. This behavior can be quantified with the help of the oscillatory shear index. OSI varies from 0 to 0.5 with 0 representing no oscillations or flow reversal, whereas 0.5 represents highly oscillatory flow behavior. A high OSI value is associated with areas of disturbed flow, which can result in endothelial cell dysfunction, leading to a higher risk of atherosclerotic plaque formation [67]. This is because the oscillatory nature of the shear stress can cause endothelial cells to promote inflammation within the artery walls and, subsequently, plaque formation. This plaque is made up of cholesterol, fatty substances, cellular waste products, calcium, and fibrin, and it can restrict blood flow through the arteries, leading to various cardiovascular problems like heart attacks and strokes.
Figure 33 shows the oscillatory shear index obtained along the top wall at small, large, and medium stenoses for the S-L-M configuration. As the blood flow follows the cardiac cycle depicted in Figure 27 and reaches the bottom of the cycle, corresponding to diastolic pressure, we observe a flow reversal. On top of that, the presence of multiple stenoses also induces recirculation regions in the immediate downstream of stenoses. This affects the instantaneous wall shear stress, which can be quantified using OSI. As shown in the figure above, before encountering the small stenosis, a normal flow is observed; however, as the small stenosis is encountered, OSI reduces in the converging section of the stenosis, whereas it rises sharply in the diverging section of the stenosis and in the downstream region of the stenosis. It is in the downstream of stenosis that a peak in OSI is observed where major flow reversal and recirculation is observed for large and medium stenoses. Major oscillations in wall shear stress are observed pre- and post-medium stenosis, indicating key regions of atherosclerosis progression.
Based on the above results, it is evident that downstream of stenoses, blood flow experiences flow recirculation and oscillatory wall shear stress, which prompts further plaque deposition aggravating the degree of blockage further. Another aspect that affects the flow dynamics is the presence of multiple stenoses such that one or more stenoses are present downstream of each other. This arrangement can affect blood flow behavior across each stenosis, either aggravating or suppressing plaque formation. Figure 33 indicates that the peak OSI value following the large stenosis is smaller than those obtained for medium stenosis. This phenomenon is likely due to the fact that, after a small stenosis, as the flow encounters a large stenosis, the velocity gradient changes abruptly, while the oscillations in wall shear stress do not change proportionally. On the other hand, high OSI coupled with low wall shear stress, at medium stenosis, is a crucial factor in the development, formation, and localization of atherosclerosis.
Figure 34a shows the streamlines obtained for blood flow through stenosed artery with S-L-M configuration at different time instances of the cardiac cycle, whereas Figure 34b shows the vorticity contours at the same time instances. At T = 0.804 s, which represents the peak of the cardiac cycle, we observe major flow recirculation zones downstream of large and medium stenoses. At T = 1.26 s, which represents the trough of the cardiac cycle, we observe a reversal in flow direction. Once the flow exceeds the trough of the cardiac cycle, it regains its normal flow direction and vortex strength, and vorticity magnitude increases as the cycle marches toward the peak of the cardiac cycle again. Major vortices are observed on both sides of the throat of the medium stenosis during the cardiac cycle. This signifies that this is the region of high intensity and fluctuations in wall shear stress and, thus, we observe two OSI peaks on both sides of the throat of the medium stenosis in Figure 33c.
The FV-iLBM solver presented in this study demonstrates significant potential for accurately simulating blood flow rheology in complex arterial vasculature. By combining the advantages of finite volume discretization with the incompressible lattice Boltzmann method, our approach effectively captures the non-Newtonian behavior of blood, particularly in regions of low shear rates and complex geometries. The solver’s ability to handle unstructured meshes and curved boundaries makes it particularly suitable for patient-specific simulations of arterial stenoses and aneurysms. Future studies will explore the impact of varying parameters in the Carreau model, specifically the relaxation time λ , on blood flow dynamics. Additionally, investigations into the effects of different Reynolds and Womersley numbers on blood flow in arteries afflicted with multiple stenoses and aneurysms will provide valuable insights into disease progression. These studies will also examine how various stenosis configurations and aneurysm sizes influence blood flow dynamics, contributing to a broader understanding of arterial disease development and progression.

4. Conclusions

This study presents a finite volume incompressible lattice Boltzmann method framework tailored to accurately capture hemodynamic behavior in complex vascular geometries. In the present study, we have addressed the inherent compressibility error associated with the standard lattice Boltzmann method while simulating incompressible flows. To mitigate this issue and enhance accuracy, an incompressible LBM model, proposed by Murdock and Yang [17], has been incorporated into the finite volume framework using the cell-centered finite volume approach. This approach leverages the simplicity of the LBM algorithm to simulate irregularly shaped flow domains using unstructured meshes. By leveraging unstructured meshes, the proposed framework effectively represents patient-specific arterial vasculature, ensuring an accurate reconstruction of arterial flow patterns. To ensure the accuracy and the robustness of our implementation, we have employed the linear reconstruction scheme for the reconstruction of distribution functions at cell interfaces. Boundary conditions have been implemented using the second-order accurate Non-Equilibrium Extrapolation method [35].
The FV-iLBM solver’s accuracy and versatility have been demonstrated through a range of benchmark simulations: it accurately captures velocity profiles in Taylor–Green vortex flow, shear wave attenuation, and developing flow through a 2D channel. Using the LR scheme, the method achieves second-order accuracy, and it consistently outperforms standard LBM when simulating pulsating flow such as Womersley flow. Furthermore, the FV-iLBM model has been shown to perform well in complex scenarios, such as lid-driven cavity flow, where it accurately reproduces velocity profiles and vortex characteristics, and external flow over NACA0012 airfoil, where predictions of pressure coefficient distribution, flow separation, and vortex shedding align closely with benchmark results, highlighting its suitability for both internal and external flow problems.
The FV-iLBM solver has been validated for simulating non-Newtonian blood flow using simulations of flows through a straight as well as a stenosed channel with the FV-iLBM model, accurately capturing the velocity and viscosity profiles. Simulating blood flow through a multi-stenosed artery demonstrates the FV-iLBM solver’s capability to effectively capture complex hemodynamic behaviors. The model accurately predicts viscosity and velocity profiles, as well as wall shear stress distribution, within the triple-stenosed artery. The presence of multiple stenoses leads to complex flow interactions, including flow acceleration, recirculation, and localized shear stress variations. Increased viscosity and a flattened velocity profile along the core, resulting from low shear rates, capture the non-Newtonian characteristics of blood flow in these constricted regions. Additionally, the velocity and wall shear stress profiles exhibit expected trends, with peaks at each stenosis throat, followed by regions of flow separation and reattachment, consistent with the principles of incompressible fluid dynamics. These results underscore the FV-iLBM solver’s potential for providing detailed insights into cardiovascular flow conditions, crucial for understanding the progression of diseases like atherosclerosis and aneurysms.

Author Contributions

A.D.: Conceptualization, Data Curation, Formal analysis, Software, Validation, Investigation, Visualization, Writing—Original Draft. J.R.M.: Methodology, Writing—Review and Editing. S.-L.Y.: Conceptualization, Methodology, Writing—Review and Editing, Supervision. All authors have read and agreed to the published version of the manuscript.

Funding

This research received no external funding.

Data Availability Statement

The original contributions presented in this study are included in the article. Further inquiries can be directed to the corresponding author(s).

Acknowledgments

The High-Performance Computing Shared Facility (Superior) at Michigan Technological University was used in obtaining the results presented in this publication.

Conflicts of Interest

The authors declare that they have no known competing financial interests or personal relationships that could have appeared to influence the work reported in this paper.

Abbreviations

The following abbreviations are used in this manuscript:
AB2Second-order Adams–Bashforth Scheme
BGKBhatnagar–Gross–Krook
CFDComputational Fluid Dynamics
CFLCourant–Friedrichs–Lewy
CTComputed Tomography
CVDCardiovascular Disease
DNSDirect Numerical Simulation
EDFEquilibrium Distribution Function
FEMFinite Element Method
FVFinite Volume
FV-iLBMFinite Volume Incompressible Lattice Boltzmann Method
FVLBMFinite Volume Lattice Boltzmann Method
FVMFinite Volume Method
GCGhost Cell
IBM        Immersed Boundary Method
iLBMIncompressible Lattice Boltzmann Method
LBLattice Boltzmann
LBMLattice Boltzmann Method
LLSLeast Linear Squares
LRLinear Reconstruction
MRIMagnetic Resonance Imaging
NACANational Advisory Committee for Aeronautics
NEENon-Equilibrium Extrapolation
NSENavier–Stokes Equation
OSIOscillatory Shear Index
QLSQuadratic Least Squares
RHSRight-Hand Side
SRTSingle Relaxation Time
TAWPTime-Averaged Wall Pressure
TAWSS   Time-Averaged Wall Shear Stress
TVDTotal Variation Diminishing
WSSWall Shear Stress

References

  1. World Health Organization. World Health Statistics 2021: Monitoring Health for the SDGs; World Health Organization: Geneva, Switzerland, 2021; Available online: https://www.who.int/publications/i/item/9789240027053 (accessed on 15 January 2025).
  2. Malek, A.M.; Alper, S.L.; Izumo, S. Hemodynamic shear stress and its role in atherosclerosis. JAMA 1999, 282, 2035–2042. [Google Scholar] [CrossRef] [PubMed]
  3. Ku, D.N. Blood Flow in Arteries. Annu. Rev. Fluid Mech. 1997, 29, 399–434. [Google Scholar] [CrossRef]
  4. Chien, S. Mechanotransduction and endothelial cell homeostasis: The wisdom of the cell. Am. J. Physiol. Heart Circ. Physiol. 2007, 292, H1209–H1224. [Google Scholar] [CrossRef]
  5. Meng, H.; Tutino, V.M.; Xiang, J.; Siddiqui, A.H. High WSS or Low WSS? Complex Interactions of Hemodynamics with Intracranial Aneurysm Initiation, Growth, and Rupture: Toward a Unifying Hypothesis. AJNR Am. J. Neuroradiol. 2014, 35, 1254–1262. [Google Scholar] [CrossRef]
  6. Steinman, D.A. Image-Based Computational Fluid Dynamics Modeling in Realistic Arterial Geometries. Ann. Biomed. Eng. 2002, 30, 483–497. [Google Scholar] [CrossRef]
  7. Cebral, J.R.; Mut, F.; Raschi, M.; Scrivano, E.; Ceratto, R.; Lylyk, P.; Putman, C.M. Aneurysm rupture following treatment with flow-diverting stents: Computational hemodynamics analysis of treatment. AJNR Am. J. Neuroradiol. 2011, 32, 27–33. [Google Scholar] [CrossRef]
  8. Taylor, C.A.; Steinman, D.A. Image-Based Modeling of Blood Flow and Vessel Wall Dynamics: Applications, Methods and Future Directions. Ann. Biomed. Eng. 2010, 38, 1188–1203. [Google Scholar] [CrossRef]
  9. Hoi, Y.; Woodward, S.H.; Kim, M.; Taulbee, D.B.; Meng, H. Validation of CFD simulations of cerebral aneurysms with implication of geometric variations. J. Biomech. Eng. 2006, 128, 844–851. [Google Scholar] [CrossRef]
  10. Cebral, J.R.; Castro, M.A.; Burgess, J.E.; Pergolizzi, R.S.; Sheridan, M.J.; Putman, C.M. Characterization of Cerebral Aneurysms for Assessing Risk of Rupture Using Patient-Specific Computational Hemodynamics Models. AJNR. Am. J. Neuroradiol. 2005, 26, 2550–2559. [Google Scholar]
  11. Quarteroni, A.; Veneziani, A.; Vergara, C. Geometric Multiscale Modeling of the Cardiovascular System, Between Theory and Practice. Comput. Methods Appl. Mech. Eng. 2016, 302, 193–252. [Google Scholar] [CrossRef]
  12. Succi, S. The Lattice Boltzmann Equation for Fluid Dynamics and Beyond; Oxford University Press: Oxford, UK, 2001. [Google Scholar]
  13. Kruger, T.; Kusumaatmaja, H.; Kuzmin, A.; Silva, G.; Viggen, E.M. The Lattice Boltzmann Method: Principles and Practice; Springer: Cham, Switzerland, 2017. [Google Scholar]
  14. Peng, G.; Xi, H.; Duncan, C.; Chou, S.H. Lattice Boltzmann method on irregular meshes. Phys. Rev. E 1998, 58, 4124. [Google Scholar] [CrossRef]
  15. Patil, D.V.; Lakshmisha, K.N. Finite volume TVD formulation of lattice Boltzmann simulation on unstructured mesh. J. Comput. Phys. 2009, 228, 5262–5279. [Google Scholar] [CrossRef]
  16. Guo, Z.; Shu, C. Lattice Boltzmann Method and its Applications in Engineering; World Scientific Publishing Co. Pte. Ltd.: Singapore, 2013. [Google Scholar]
  17. Murdock, J.; Yang, S.L. Alternative and explicit derivation of the lattice Boltzmann equation for the unsteady incompressible Navier-Stokes equation. Int. J. Comput. Eng. Res. 2016, 6, 2250–3005. [Google Scholar]
  18. Succi, S.; Amati, G.; Benzi, R. Challenges in lattice Boltzmann computing. J. Stat. Phys. 1995, 81, 5–16. [Google Scholar] [CrossRef]
  19. He, X.; Luo, L.-S.; Dembo, M. Some Progress in Lattice Boltzmann Method. Part I. Nonuniform Mesh Grids. J. Comput. Phys. 1996, 129, 357–363. [Google Scholar] [CrossRef]
  20. Chen, H. Volumetric formulation of the lattice Boltzmann method for fluid dynamics: Basic concept. Phys. Rev. E 1998, 58, 3955–3963. [Google Scholar] [CrossRef]
  21. Peng, G.; Xi, H.; Duncan, C.; Chou, S. Finite volume scheme for the lattice Boltzmann method on unstructured meshes. Phys. Rev. E 1999, 59, 4675–4682. [Google Scholar] [CrossRef]
  22. Xi, H.; Peng, G.; Chou, S. Finite-volume lattice Boltzmann method. Phys. Rev. E 1999, 59, 6202–6205. [Google Scholar] [CrossRef]
  23. Xi, H.; Peng, G.; Chou, S. Finite-volume lattice Boltzmann schemes in two and three dimensions. Phys. Rev. E 1999, 60, 3380–3388. [Google Scholar] [CrossRef]
  24. Ubertini, S.; Succi, S.; Bella, G. Lattice Boltzmann schemes without coordinates. Phil. Trans. R. Soc. A. 2004, 362, 1763–1771. [Google Scholar] [CrossRef]
  25. Ubertini, S.; Succi, S. Recent advances of Lattice Boltzmann techniques on unstructured grids. Prog. Comput. Fluid Dyn. 2005, 5, 85–96. [Google Scholar] [CrossRef]
  26. Stiebler, M.; Tölke, J.; Krafczyk, M. An upwind discretization scheme for the finite volume lattice Boltzmann method. Comput. Fluids 2006, 35, 814–819. [Google Scholar] [CrossRef]
  27. Patil, D.V.; Lakshmisha, K.N. Two-dimensional flow past circular cylinders using finite volume lattice Boltzmann formulation. Int. J. Numer. Meth. Fluids 2011, 69, 1149–1165. [Google Scholar] [CrossRef]
  28. Delanaye, M.; Geuzaine, P.; Essers, J.A. The quadratic reconstruction finite volume scheme: An attractive sequel to linear reconstruction, used on unstructured adaptive meshes. Lect. Notes Phys. 1997, 490, 617–622. [Google Scholar]
  29. Zarghami, A.; Maghrebi, M.J.; Ubertini, S.; Succi, S. Modeling of bifurcation phenomena in suddenly expanded flows with a finite volume lattice Boltzmann method. Int. J. Mod. Phys. C 2011, 22, 977–1003. [Google Scholar] [CrossRef]
  30. Zarghami, A.; Maghrebi, M.J.; Ghasemi, J.; Ubertini, S. Lattice Boltzmann finite volume formulation with improved stability. Commun. Comput. Phys. 2012, 12, 42–64. [Google Scholar] [CrossRef]
  31. Wang, Y.; Zhong, C.; Cao, J.; Zhuo, C.; Liu, S. A simplified finite volume lattice Boltzmann method for simulations of fluid flows from laminar to turbulent regime, Part I: Numerical framework and its application to laminar flow simulation. Comput. Math. Appl. 2020, 79, 1590–1618. [Google Scholar] [CrossRef]
  32. Zou, Q.; Hou, S.; Chen, S.; Doolen, G. An improved incompressible lattice Boltzmann model for time-independent flows. J. Stat. Phys. 1995, 81, 35–48. [Google Scholar] [CrossRef]
  33. Lin, Z.; Fang, H.; Tao, R. Improved lattice Boltzmann model for incompressible two-dimensional steady flows. Phys. Rev. E 1996, 54, 6323–6330. [Google Scholar] [CrossRef]
  34. Chen, Y.; Ohashi, H. Lattice-BGK methods for simulating incompressible fluid flows. Int. J. Mod. Phys. C 1997, 8, 793–803. [Google Scholar] [CrossRef]
  35. Guo, Z.; Shi, B.; Wang, N. Lattice BGK model for incompressible Navier-Stokes equation. J. Comput. Phys. 2000, 165, 288–306. [Google Scholar] [CrossRef]
  36. Shi, B.; He, N.; Wang, N. A unified thermal lattice BGK model for Boussinesq equations. Prog. Comput. Fluid Dyn. 2005, 5, 50–64. [Google Scholar] [CrossRef]
  37. Banda, M.K.; Yong, W.A.; Klar, A. A stability notion for lattice Boltzmann equations. SIAM J. Sci. Comput. 2006, 27, 2098–2111. [Google Scholar] [CrossRef]
  38. Murdock, J.; Ickes, J.C.; Yang, S.L. Transition flow with an incompressible lattice Boltzmann method. Adv. Appl. Math. Mech. 2016, 9, 1271–1288. [Google Scholar] [CrossRef]
  39. Chien, S. Shear Dependence of Effective Cell Volume as a Determinant of Blood viscosity. Science 1970, 168, 977–979. [Google Scholar] [CrossRef]
  40. Gijsen, F.J.H.; van de Vosse, F.N.; Janssen, J.D. The Influence of the Non-Newtonian Properties of Blood on the Flow in Large Arteries: Unsteady Flow in a 90° Curved Tube. J. Biomech. 1999, 32, 705–713. [Google Scholar] [CrossRef]
  41. Carreau, P.J. Rheological Equations from Molecular Network Theories. J. Rheol. 1972, 16, 99–127. [Google Scholar] [CrossRef]
  42. Saad, Y. Iterative Methods for Sparse Linear Systems; Society for Industrial and Applied Mathematics: Philadelphia, PA, USA, 2003. [Google Scholar]
  43. Bhatnagar, P.; Gross, E.; Krook, M. A model for collision processes in gases. I. Small amplitude processes in charged and neutral one-component systems. Phys. Rev. 1954, 94, 511–525. [Google Scholar] [CrossRef]
  44. Barth, T.J.; Frederickson, P.O. Higher order solution of the Euler equations on unstructured grids using quadratic reconstruction. In Proceedings of the 28th Aerospace Sciences Meeting, Reno, NV, USA, 8–11 January 1990. Paper No. AIAA-90-0013. [Google Scholar]
  45. Roe, P.L. Approximate Riemann solvers, parameter vectors, and difference schemes. J. Comput. Phys. 1981, 43, 357–372. [Google Scholar] [CrossRef]
  46. Hairer, E.; Nørsett, S.P.; Wanner, G. Solving Ordinary Differential Equations I: Nonstiff Problems, 2nd ed.; Springer: Berlin/Heidelberg, Germany, 1993. [Google Scholar]
  47. Frink, N.T. Upwind scheme for solving the Euler equations on unstructured tetrahedral meshes. AIAA J. 1992, 30, 70–77. [Google Scholar] [CrossRef]
  48. Grasinger, M.; Overacker, J.; Brigham, J. Numerical investigation of the accuracy, stability, and efficiency of lattice Boltzmann methods in simulating non-Newtonian flow. Comput. Fluids 2018, 166, 253–264. [Google Scholar] [CrossRef]
  49. Li, J.; Wang, Z. An alternative scheme to calculate the strain rate tensor for the LES applications in LBM. Math. Probl. Eng. 2010, 2010, 724578. [Google Scholar] [CrossRef]
  50. Janela, J.; Sequeira, A.; Pontrelli, G.; Succi, S.; Ubertini, S. Unstructured lattice Boltzmann method for hemodynamic flows with shear-dependent viscosity. Int. J. Mod. Phys. C 2010, 21, 795–811. [Google Scholar] [CrossRef]
  51. Pereira, F.S.; Grinstein, F.F.; Israel, D.M.; Rauenzahn, R.; Girimaji, S.S. Modeling and simulation of transitional Taylor-Green vortex flow with partially averaged Navier-Stokes equations. Phys. Rev. Fluids 2021, 6, 054611. [Google Scholar] [CrossRef]
  52. Press, W.H.; Teukolsky, S.A.; Vetterling, W.T.; Flannery, B.P. Numerical Recipes: The Art of Scientific Computing; Cambridge University Press: Cambridge, UK, 1986. [Google Scholar]
  53. Hennig, F.; Holzer, M.; Rude, U. Advanced automatic code generation for multiple relaxation-time lattice Boltzmann methods. SIAM J. Sci. Comput 2023, 45, C233–C254. [Google Scholar] [CrossRef]
  54. Lehmann, M.; Krause, M.J.; Amati, G.; Sega, M.; Harting, J.; Gekle, S. Accuracy and performance of the lattice Boltzmann method with 64-bit, 32-bit, and customized 16-bit number formats. Phys. Rev. E 2022, 106, 015308. [Google Scholar] [CrossRef]
  55. Sofonea, V.; Sekerka, R.F. Boundary conditions for the upwind finite difference lattice Boltzmann model: Evidence of slip velocity in micro-channel flow. J. Comput. Phys. 2005, 207, 639. [Google Scholar] [CrossRef]
  56. Womersley, J.R. Method for calculation of velocity, rate of flow and viscous drag in arteries when the pressure gradient is known. J. Physiol. 1955, 127, 553–563. [Google Scholar] [CrossRef]
  57. Ghia, U.; Ghia, K.N.; Shin, C.T. High-Re solutions for incompressible flow using Navier-Stokes equations and a multigrid method. J. Comput. Phys. 1982, 48, 387–411. [Google Scholar] [CrossRef]
  58. Kurtulus, D.F. On the unsteady behavior of the flow around NACA0012 airfoil with steady external conditions at Re = 1000. Int. J. Micro Air Veh. 2015, 7, 301–326. [Google Scholar] [CrossRef]
  59. Huang, R.F.; Wu, J.Y.; Jeng, J.H.; Chen, R.C. Surface flow and vortex shedding of an impulsively started wing. J. Fluid Mech. 2001, 441, 265–292. [Google Scholar] [CrossRef]
  60. Ang, K.C. A Computational Fluid Dynamic Study of Blood Flow Through Stenosed Arteries. Ph.D. Thesis, University of Adelaide, Adelaide, Australia, 1996. [Google Scholar]
  61. Cho, Y.I.; Kinsey, K.R. Effects of the non-Newtonian viscosity of blood on flows in a diseased arterial vessel. Part 1: Steady flows. Biorheology 1991, 28, 241–262. [Google Scholar] [CrossRef]
  62. Nadeem, Z.A.; Dakhil, S.F.; Abdullah, H.M. Numerical analysis of blood flow through multiple stenosis right coronary artery. Int. J. Appl. Eng. Res. 2018, 13, 16064–16071. [Google Scholar]
  63. Abbasian, M.; Shams, M.; Valizadeh, Z.; Moshfegh, A.; Javadzadegan, A.; Cheng, S. Effects of different non-Newtonian models on unsteady blood flow hemodynamics in patient-specific arterial models with in-vivo validation. Comput. Methods Programs Biomed. 2020, 186, 105185. [Google Scholar] [CrossRef]
  64. Pabi, S.; Khan, M.K.; Jain, S.K.; Sen, A.K.; Raj, A. Effect of stenotic shapes and arterial wall elasticity on the hemodynamics. Phys. Fluids 2023, 35, 101908. [Google Scholar] [CrossRef]
  65. MATLAB, version R2021b; The MathWorks, Inc.: Natick, MA, USA, 2021. Available online: https://www.mathworks.com/ (accessed on 4 September 2023).
  66. Chiu, J.J.; Chien, S. Effects of disturbed flow on vascular endothelium: Pathophysiological basis and clinical perspectives. Physiol. Rev. 2011, 91, 327–387. [Google Scholar] [CrossRef]
  67. Gimbrone, M.A.; García-Cardeña, G. Endothelial cell dysfunction and the pathobiology of atherosclerosis. Circ. Res. 2016, 118, 620–636. [Google Scholar] [CrossRef]
Figure 1. D 2 Q 9 lattice velocity vectors ( α ).
Figure 1. D 2 Q 9 lattice velocity vectors ( α ).
Mathematics 13 01671 g001
Figure 2. Schematic of the unstructured grid.
Figure 2. Schematic of the unstructured grid.
Mathematics 13 01671 g002
Figure 3. Advective flux calculations [15].
Figure 3. Advective flux calculations [15].
Mathematics 13 01671 g003
Figure 4. Reconstruction of distribution functions at the border cell interface [31].
Figure 4. Reconstruction of distribution functions at the border cell interface [31].
Mathematics 13 01671 g004
Figure 5. The x-direction velocity profiles along y / W = 0.75 obtained using the FV-iLBM model in conjunction with the LR scheme for simulation of Taylor–Green vortex flow. Lines are the analytical solutions while symbols are numerical predictions.
Figure 5. The x-direction velocity profiles along y / W = 0.75 obtained using the FV-iLBM model in conjunction with the LR scheme for simulation of Taylor–Green vortex flow. Lines are the analytical solutions while symbols are numerical predictions.
Mathematics 13 01671 g005
Figure 6. The L 2 error norm of spatial error for simulation of Taylor–Green vortex flow.
Figure 6. The L 2 error norm of spatial error for simulation of Taylor–Green vortex flow.
Mathematics 13 01671 g006
Figure 7. The x-direction velocity profiles along the centerline at x = 0.5 obtained using the FV-iLBM model in conjunction with the LR scheme for the simulation of attenuation of a shear wave. Lines are the analytical solutions while symbols are numerical predictions.
Figure 7. The x-direction velocity profiles along the centerline at x = 0.5 obtained using the FV-iLBM model in conjunction with the LR scheme for the simulation of attenuation of a shear wave. Lines are the analytical solutions while symbols are numerical predictions.
Mathematics 13 01671 g007
Figure 8. The time evolution of kinematic viscosity extracted from the numerical simulation of attenuation of a shear wave.
Figure 8. The time evolution of kinematic viscosity extracted from the numerical simulation of attenuation of a shear wave.
Mathematics 13 01671 g008
Figure 9. (a) The velocity profiles at the outlet of a 2D channel obtained using the FV-iLBM model in conjunction with the LR scheme. The line is the analytical solution while symbols represent the numerical predictions. (b) Distribution of pressure along the length of the channel at the centerline obtained for simulating the flow in a 2D channel.
Figure 9. (a) The velocity profiles at the outlet of a 2D channel obtained using the FV-iLBM model in conjunction with the LR scheme. The line is the analytical solution while symbols represent the numerical predictions. (b) Distribution of pressure along the length of the channel at the centerline obtained for simulating the flow in a 2D channel.
Mathematics 13 01671 g009
Figure 10. The x-direction velocity profiles for Womersley flow obtained along the centerline at x = 0.5 using the FV-iLBM model in conjunction with the LR scheme. Lines are the analytical solutions while symbols are numerical predictions.
Figure 10. The x-direction velocity profiles for Womersley flow obtained along the centerline at x = 0.5 using the FV-iLBM model in conjunction with the LR scheme. Lines are the analytical solutions while symbols are numerical predictions.
Mathematics 13 01671 g010
Figure 11. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity for R e = 100 obtained using the FV-iLBM model in conjunction with LR scheme. Symbols are the benchmark solution by Ghia et al. [57] while lines are numerical predictions.
Figure 11. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity for R e = 100 obtained using the FV-iLBM model in conjunction with LR scheme. Symbols are the benchmark solution by Ghia et al. [57] while lines are numerical predictions.
Mathematics 13 01671 g011
Figure 12. Streamline pattern for lid-driven flow in a 2D square cavity: (a) Re = 1000 and (b) Re = 3200.
Figure 12. Streamline pattern for lid-driven flow in a 2D square cavity: (a) Re = 1000 and (b) Re = 3200.
Mathematics 13 01671 g012
Figure 13. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity obtained using the FV-iLBM model in conjunction with the LR scheme: (a) Re = 400 and (b) Re = 1000. Symbols are benchmark solution by Ghia et al. [57] while lines are numerical predictions.
Figure 13. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity obtained using the FV-iLBM model in conjunction with the LR scheme: (a) Re = 400 and (b) Re = 1000. Symbols are benchmark solution by Ghia et al. [57] while lines are numerical predictions.
Mathematics 13 01671 g013
Figure 14. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity for R e = 3200 obtained using the FV-iLBM model in conjunction with the LR scheme. Symbols are benchmark solution by Ghia et al. [57] while lines are numerical predictions. The FV-iLBM predictions are represented by the red line whereas the blue line represents the numerical predictions obtained by Patil et al. [15].
Figure 14. Velocity profiles along ( 0.5 , y ) and ( x , 0.5 ) in a lid-driven flow in a 2D square cavity for R e = 3200 obtained using the FV-iLBM model in conjunction with the LR scheme. Symbols are benchmark solution by Ghia et al. [57] while lines are numerical predictions. The FV-iLBM predictions are represented by the red line whereas the blue line represents the numerical predictions obtained by Patil et al. [15].
Mathematics 13 01671 g014
Figure 15. (a) Schematic of the simulation domain and (b) unstructured grid surrounding the NACA0012 airfoil.
Figure 15. (a) Schematic of the simulation domain and (b) unstructured grid surrounding the NACA0012 airfoil.
Mathematics 13 01671 g015
Figure 16. (a) Pressure coefficient distribution along the surface of NACA0012 airfoil at an 8 angle of attack obtained using the FV-iLBM model. Lines are benchmark solution by Kurtulus [58], whereas symbols are numerical predictions. (b) The variation in L2 error with computational time for three different grid resolutions (38 k, 75 k, and 120 k cells).
Figure 16. (a) Pressure coefficient distribution along the surface of NACA0012 airfoil at an 8 angle of attack obtained using the FV-iLBM model. Lines are benchmark solution by Kurtulus [58], whereas symbols are numerical predictions. (b) The variation in L2 error with computational time for three different grid resolutions (38 k, 75 k, and 120 k cells).
Mathematics 13 01671 g016
Figure 17. Streamline pattern for flow over the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 .
Figure 17. Streamline pattern for flow over the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 .
Mathematics 13 01671 g017
Figure 18. Distribution of mean pressure coefficient over the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 . Lines are benchmark solution by Kurtulus [58] while symbols are numerical predictions obtained using the FV-iLBM model in conjunction with the LR scheme.
Figure 18. Distribution of mean pressure coefficient over the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 . Lines are benchmark solution by Kurtulus [58] while symbols are numerical predictions obtained using the FV-iLBM model in conjunction with the LR scheme.
Mathematics 13 01671 g018
Figure 19. Instantaneous pressure field for the NACA0012 airfoil: (a) θ = 7 and (b) θ = 8 .
Figure 19. Instantaneous pressure field for the NACA0012 airfoil: (a) θ = 7 and (b) θ = 8 .
Mathematics 13 01671 g019
Figure 20. Instantaneous vorticity for the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 .
Figure 20. Instantaneous vorticity for the NACA0012 airfoil: (a) θ = 7 , (b) θ = 8 , (c) θ = 9 , and (d) θ = 11 .
Mathematics 13 01671 g020
Figure 21. Schematic of the 2D straight channel.
Figure 21. Schematic of the 2D straight channel.
Mathematics 13 01671 g021
Figure 22. (a) Velocity profiles for λ = 0.01 ,   0.1 s and the corresponding Newtonian case ( λ = 0 s). (b) Viscosity profiles for λ = 0.01 ,   0.1 s. Symbols are the benchmark numerical solutions by Janela et al. [50] and lines are numerical predictions obtained using the FV-iLBM model in conjunction with the LR scheme.
Figure 22. (a) Velocity profiles for λ = 0.01 ,   0.1 s and the corresponding Newtonian case ( λ = 0 s). (b) Viscosity profiles for λ = 0.01 ,   0.1 s. Symbols are the benchmark numerical solutions by Janela et al. [50] and lines are numerical predictions obtained using the FV-iLBM model in conjunction with the LR scheme.
Mathematics 13 01671 g022
Figure 23. Schematic of the 2D stenosed channel.
Figure 23. Schematic of the 2D stenosed channel.
Mathematics 13 01671 g023
Figure 24. Velocity profiles for flow through 2D stenosed channel: (a) at the throat ( x = 0 ) of the stenosis and (b) at the centerline along the length of the channel. Symbols represent the numerical predictions obtained by Janela et al. [50], whereas the line represents the numerical predictions obtained using the FV-iLBM model.
Figure 24. Velocity profiles for flow through 2D stenosed channel: (a) at the throat ( x = 0 ) of the stenosis and (b) at the centerline along the length of the channel. Symbols represent the numerical predictions obtained by Janela et al. [50], whereas the line represents the numerical predictions obtained using the FV-iLBM model.
Mathematics 13 01671 g024
Figure 25. Viscosity profile at the throat ( x = 0 ) of the stenosis obtained using the FV-iLBM model in conjunction with the LR scheme. Symbols represent the numerical predictions obtained by Janela et al. [50], whereas the line represents the numerical predictions obtained using the FV-iLBM model.
Figure 25. Viscosity profile at the throat ( x = 0 ) of the stenosis obtained using the FV-iLBM model in conjunction with the LR scheme. Symbols represent the numerical predictions obtained by Janela et al. [50], whereas the line represents the numerical predictions obtained using the FV-iLBM model.
Mathematics 13 01671 g025
Figure 26. Schematic of the artery with triple stenoses.
Figure 26. Schematic of the artery with triple stenoses.
Mathematics 13 01671 g026
Figure 27. Inlet pulsatile flow rate (Q).
Figure 27. Inlet pulsatile flow rate (Q).
Mathematics 13 01671 g027
Figure 28. Numerical mesh used for simulating flow through an artery afflicted with multiple stenoses.
Figure 28. Numerical mesh used for simulating flow through an artery afflicted with multiple stenoses.
Mathematics 13 01671 g028
Figure 29. (a) Time-averaged wall shear stress at the top wall obtained using three different grids and (b) a closer look at the peak of time-averaged wall shear stress at the top wall shown in the adjacent figure.
Figure 29. (a) Time-averaged wall shear stress at the top wall obtained using three different grids and (b) a closer look at the peak of time-averaged wall shear stress at the top wall shown in the adjacent figure.
Mathematics 13 01671 g029
Figure 30. Time-averaged wall pressure along the top wall of the stenosed artery.
Figure 30. Time-averaged wall pressure along the top wall of the stenosed artery.
Mathematics 13 01671 g030
Figure 31. Instantaneous velocity and viscosity profiles at the peak of the cardiac cycle: (a) velocity profiles and (b) viscosity profiles along the throat of three stenoses.
Figure 31. Instantaneous velocity and viscosity profiles at the peak of the cardiac cycle: (a) velocity profiles and (b) viscosity profiles along the throat of three stenoses.
Mathematics 13 01671 g031
Figure 32. (a) Time-averaged wall shear stress at the top wall. (b) Instantaneous centerline velocity profile along the length of the artery at the peak of the cardiac cycle.
Figure 32. (a) Time-averaged wall shear stress at the top wall. (b) Instantaneous centerline velocity profile along the length of the artery at the peak of the cardiac cycle.
Mathematics 13 01671 g032
Figure 33. Oscillatory shear index at the top wall: (a) for small stenosis, (b) for large stenosis, and (c) for medium stenosis.
Figure 33. Oscillatory shear index at the top wall: (a) for small stenosis, (b) for large stenosis, and (c) for medium stenosis.
Mathematics 13 01671 g033
Figure 34. (a) Streamlines and (b) vorticity contours at different time instances of the cardiac cycle.
Figure 34. (a) Streamlines and (b) vorticity contours at different time instances of the cardiac cycle.
Mathematics 13 01671 g034
Table 1. The error norms (L1, L2, and L∞) with respect to mesh refinement for the Taylor–Green vortex flow simulation.
Table 1. The error norms (L1, L2, and L∞) with respect to mesh refinement for the Taylor–Green vortex flow simulation.
δ l L1 Error NormL2 Error NormL∞ Error Norm
3.281 × 10 3 2.0413 × 10 5 2.8834 × 10 5 8.6470 × 10 5
2.241 × 10 3 5.9725 × 10 6 7.5234 × 10 6 2.3648 × 10 5
1.898 × 10 3 6.7683 × 10 6 7.9522 × 10 6 1.8634 × 10 5
1.70 × 10 3 7.0616 × 10 6 8.3448 × 10 6 2.0597 × 10 5
Table 2. Comparison of analytical solution of u m a x at the center of the domain with that obtained using the FV-iLBM and standard LBM models. The % error in the parenthesis is calculated with respect to the analytical solution.
Table 2. Comparison of analytical solution of u m a x at the center of the domain with that obtained using the FV-iLBM and standard LBM models. The % error in the parenthesis is calculated with respect to the analytical solution.
Time PeriodAnalyticaliLBM (% Error)Std. LBM (% Error)
T/8−0.0932108−0.0966616 (3.70%)−0.0989200 (6.12%)
T/40.00385210.0012198 (68.34%)0.0007089 (81.59%)
3T/80.09865840.0966830 (2.0%)0.0948343 (3.80%)
T/20.13567200.1334973 (1.60%)0.1316358 (2.97%)
Table 3. Comparison of memory and runtime performance of the FV-iLBM model with the standard LBM model. The L2 error is calculated with respect to the analytical solution of the Womersley flow.
Table 3. Comparison of memory and runtime performance of the FV-iLBM model with the standard LBM model. The L2 error is calculated with respect to the analytical solution of the Womersley flow.
MetricStandard LBMiLBMImprovement
Memory per cell (Bytes)∼96∼104∼8.3% more
Runtime per iteration (s)∼0.2207∼0.1872∼15.2% faster
L2 Error0.004190.00262∼38.9% accurate
Table 4. X- and y-coordinates of the centers of primary, bottom right, and bottom left vortices for lid-driven flow with R e = 100 ,   400 and 1000 obtained using the FV-iLBM model.
Table 4. X- and y-coordinates of the centers of primary, bottom right, and bottom left vortices for lid-driven flow with R e = 100 ,   400 and 1000 obtained using the FV-iLBM model.
ReStudyPrimaryBottom RightBottom Left
Ghia et al. [57](0.6172, 0.7344)(0.9453, 0.0625)(0.0313, 0.0391)
100Patil et al. [15](0.6161, 0.7296)(0.9451, 0.0574)(0.0345, 0.0324)
Present(0.6149, 0.7390)(0.9436, 0.0606)(0.0345, 0.0342)
Ghia et al. [57](0.5547, 0.6055)(0.8906, 0.1250)(0.0508, 0.0469)
400Patil et al. [15](0.5506, 0.5972)(0.8862, 0.1258)(0.0526, 0.0471)
Wang et al. [31](0.5543, 0.6061)(0.8859, 0.1225)(0.0507, 0.0471)
Present(0.5568, 0.6097)(0.8862, 0.1236)(0.0485, 0.0463)
Ghia et al. [57](0.5313, 0.5625)(0.8594, 0.1094)(0.0859, 0.0781)
1000Patil et al. [15](0.5259, 0.5777)(0.8778, 0.1261)(0.0904, 0.0989)
Wang et al. [31](0.5310, 0.5665)(0.8644, 0.1130)(0.0828, 0.0774)
Present(0.5321, 0.5706)(0.8640, 0.1160)(0.0828, 0.0757)
Table 5. Width and height of the corner vortices for lid-driven flow with R e = 1000 obtained using the FV-iLBM model.
Table 5. Width and height of the corner vortices for lid-driven flow with R e = 1000 obtained using the FV-iLBM model.
Bottom LeftBottom Right
WidthHeightWidthHeight
Ghia et al. [57]0.21880.16800.30340.3536
Patil et al. [15]0.21670.20050.28880.3431
Wang et al. [31]0.21510.16410.29700.3530
Present0.21130.16130.30110.3623
Table 6. X- and y-coordinates of the centers of primary, bottom right, bottom left, and top left vortices for lid-driven flow with R e = 3200 obtained using the FV-iLBM model.
Table 6. X- and y-coordinates of the centers of primary, bottom right, bottom left, and top left vortices for lid-driven flow with R e = 3200 obtained using the FV-iLBM model.
Ghia et al. [57]Patil et al. [15]Present
Primary(0.5165, 0.5469)(0.5189, 0.5441)(0.5190, 0.5417)
Bottom Right(0.8125, 0.0859)(0.8619, 0.0971)(0.8335, 0.0932)
Bottom Left(0.0859, 0.1094)(0.0993, 0.0963)(0.0859, 0.1087)
Top Left(0.0547, 0.8984)(0.0316, 0.8689)(0.0416, 0.8875)
Table 7. Width and height of the corner vortices for lid-driven flow with R e = 3200 obtained using the FV-iLBM model.
Table 7. Width and height of the corner vortices for lid-driven flow with R e = 3200 obtained using the FV-iLBM model.
Bottom LeftBottom RightTop Left
WidthHeightWidthHeightWidthHeight
Ghia et al. [57]0.28440.23050.34060.41020.08590.2057
Patil et al. [15]0.31460.24430.30180.39250.04940.1819
Wang et al. [31]0.28160.23560.33580.38390.08770.1938
Present0.28400.22340.33970.40490.06620.1667
Table 8. Severity of stenosis for different δ values.
Table 8. Severity of stenosis for different δ values.
δ XSeverity of Stenosis (%)Designation
0.20.636S
0.30.851M
0.61.084L
Table 9. Fourier series coefficients for pulsatile flow rate (Q).
Table 9. Fourier series coefficients for pulsatile flow rate (Q).
n A n Q B n Q
10.10110.07513
2−0.00352−0.00835
30.03160.03158
40.01809−0.01486
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Dongre, A.; Murdock, J.R.; Yang, S.-L. Finite Volume Incompressible Lattice Boltzmann Framework for Non-Newtonian Flow Simulations in Complex Geometries. Mathematics 2025, 13, 1671. https://doi.org/10.3390/math13101671

AMA Style

Dongre A, Murdock JR, Yang S-L. Finite Volume Incompressible Lattice Boltzmann Framework for Non-Newtonian Flow Simulations in Complex Geometries. Mathematics. 2025; 13(10):1671. https://doi.org/10.3390/math13101671

Chicago/Turabian Style

Dongre, Akshay, John Ryan Murdock, and Song-Lin Yang. 2025. "Finite Volume Incompressible Lattice Boltzmann Framework for Non-Newtonian Flow Simulations in Complex Geometries" Mathematics 13, no. 10: 1671. https://doi.org/10.3390/math13101671

APA Style

Dongre, A., Murdock, J. R., & Yang, S.-L. (2025). Finite Volume Incompressible Lattice Boltzmann Framework for Non-Newtonian Flow Simulations in Complex Geometries. Mathematics, 13(10), 1671. https://doi.org/10.3390/math13101671

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop