A New Two-Dimensional Blood Flow Model and Its RKDG Approximation

Abstract

We propose a new two-dimensional blood flow reduced model taking into account of complex artery geometry as in the case of severe aneurysm. We derive the model from the three-dimensional Navier-Stokes equations written in a curvilinear coordinate system under the thin-artery assumption, with boundary conditions including wall tissue deformation. We show that the model is energetically consistent with the full Navier-Stokes problem. This model, obtained via radial averaging, is, up to our knowledge, the first one. It has the advantage of being more accurate than the classical one-dimensional models and being solved in a reasonable time in comparison with the Navier-Stokes models. To this purpose, we use a Runge-Kutta Discontinuous Galerkin (RKDG) method to solve the two-dimensional problem. We end the paper with several numerical test cases to show the efficiency and robustness of the numerical model, and in particular, we show the limit of the one-dimensional models in the case of a severe aneurysm.

Share and Cite:

Mannes, Y. , Ersoy, M. , Eker, Ö. and Ajroud, A. (2025) A New Two-Dimensional Blood Flow Model and Its RKDG Approximation. Journal of Applied Mathematics and Physics, 13, 3930-3967. doi: 10.4236/jamp.2025.1311220.

1. Introduction

Modeling the cardiovascular system in arteries holds a central place in medical science, particularly in connection with cardiovascular diseases such as coronary heart disease, stroke, peripheral artery disease, aneurysms, and others. This is especially important today in understanding and forecasting the impact of developed countries’ way of life on people’s healthcare (around 30% of cardiovascular disease deaths are from developed countries). Therefore, it is of major interest to develop an accurate mathematical model.

The dynamic of such flow is mainly influenced by the fluid-structure interaction with the artery wall. The forecast to predict the motion of blood through the artery is a difficult task to which substantial effort has been devoted [1]-[8].

One of the most widely used models to describe the motion of blood through the artery is the one-dimensional (1D) Blood Flow equation derived, for instance, in [1] [5] [6] [9]-[11]. This classical model is a hyperbolic system of Partial Differential Equations (PDE) describing the conservation laws linking the wall elasticity to the fluid dynamics. This model is derived from an ansatz for the velocity profile in Equation (2) and reads,

{ t A+ x Q=0, t Q+ x ( α Q 2 A + 1 ρ AP( A,x ) )= 1 ρ P( A,x ) x AK Q A , (1)

where the unknowns A( t,x ) stands artery’s section area (assumed to be cylindrical), Q( t,x )=A( t,x ) u x ¯ ( t,x ) is the flow rate and u x ¯ is the mean speed over the artery’s section (see [1] [6] for further details). The function P( A,x ) denotes the pressure of blood at the wall and reads,

P( A,x )=b( x ) A A 0 A 0 ,

where b encompasses the elastic behavior of the artery, i.e., b( x )= E( x ) 1ξ h π , where E is the Young’s modulus, ξ is the Poisson ratio, and h is the wall thickness. The velocity profile is given by

u x ( t,r,x )= Q( t,x ) A( t,x ) γ+2 γ [ 1 ( r R( t,x ) ) γ ], (2)

where γ is an integer (often set to 9, see for instance [6] [12]). The friction term K is defined as a function of γ by K=2πν( γ+2 ) where ν is the kinematic viscosity of the blood. In Equation (1), the Bousinessq coefficient is given by α= γ+2 γ+1 (c.f. [6] [7] [12]). In recent work, inspired from [13]-[15], an inviscid hyperbolic one-dimensional model and a viscous one was derived without the ansatz assumption and by section-averaging techniques. These models are

{ t A+ x Q=0, t Q+ x ( Q 2 A + 1 ρ AP( A,x ) )= 1 ρ P( A,x ) x A+2πRk Q A , (3)

{ t A+ x Q=0, t Q+ x ( Q 2 A + 1 ρ AP( A,x ) ) x ( 3νA x ( Q A ) )= 1 ρ P( A,x ) x A+ 2πRk 1 Rk 4ν Q A , (4)

where R( t,x ) is the radius, A=π R 2 the area, Q=A u x ¯ the flow rate, u x ¯ the mean speed of blood per section, ρ the density of blood, P , the pressure, ν the kinematic viscosity, and k a negative friction coefficient. For these models, several mathematical and physical properties have been obtained. These two new one-dimensional models, while similar to existing ones in the literature, are derived using a well-known technique used, for instance, in [14]-[16]. This method allows the construction of each asymptotic term one by one, distinguishing it from the classical approach using ansatz (see Equation (1) and [6]). The most notable advantage of these one-dimensional models is the ease of implementation of fast and robust numerical methods and providing good results in the context of quasi-cylindrical arteries.

Although, in the presence of aneurysms, both previously derived models may suffer from precision issues due to the non-uniform deformation in the radial direction [17]. To avoid those issues a three-dimensional model can be used, however, it leads to costly numerical computations. This leads to our idea of developing the first two-dimensional blood flow model in complex artery geometry. This new model reads

{ t A+ θ ( Q Rθ A )+ s ( Q s )=0, t ( Q Rθ )+ θ ( Q Rθ 2 2 A 2 +AP )+ s ( Q Rθ Q s A )= 2R 3 Csinθ Q s 2 A +2Rk Q Rθ A + θ AP, t ( Q s )+ θ ( Q s Q Rθ A 2 )+ s ( Q s 2 A Q Rθ 2 2 A 2 +AP )= 2R 3 Csinθ Q s Q Rθ A 2 +kR Q s A + s AP, P= P ext +b R R 0 R 0 2 . (5)

where A( t,θ,s ) is now define as R 2 2 with s the curvilinear abscissa and θ the angle, Q Rθ = 3 4 RA u θ ¯ , Q s =A u s ¯ , P the pressure, C the curvature of the

artery and k a negative friction coefficient. This new model takes into account the variations of the geometry more accurately than one-dimensional models and yields to less expensive numerical method than the three-dimensional ones.

We outline the rest of the paper as follows: in Section 2, as our starting point we present the Navier-Stokes equations and the boundary conditions including friction and the wall law deformation. We derive the radial-averaged two-dimensional equations. In Section 3, we use a Discontinues Galerkin (DG) method from [18] called the Runge-Kutta Discontinues Galerkin method (RKDG). We use explicit Runge-Kutta for time integration. We provide extensive numerical testing in Section 4 of the resulting code. A Julia1 implementation of this code, written by Y. Mannes and M. Ersoy, is freely available on request.

2. On the Derivation of a New Two-Dimensional Model for Blood Flow in Arteries

In this section, we present the full derivation of the new two-dimensional model for blood flow (Equation (5)) starting from the Navier-Stokes equations.

2.1. Navier-Stokes Equations in a Curvilinear Coordinate System

We aim to construct a mathematical model for blood flow in an artery consistent with the phenomena that can affect its motion. We propose a model reduction of the three-dimensional Navier-Stokes equations leading to a new two-dimensional model following the technique in [14]-[16]. We study the case of a curvilinear artery (with a star-like cross-section, see Figure 1) and consider suitable boundary conditions to account for artery wall radial deformation and friction. In contrast with existing models for which the radius is θ -independant, we assume here that the radius is a function of θ , thus yielding radial non-uniform deformation. This assumption allows us to, accurately, describe aneurysms, stenosis, etc.

Figure 1. Artery shape.

We start in Subsection 2.1.1 by reviewing the Navier-Stokes equations in a curvilinear coordinate frame (using a Serret-Frenet in a cylindrical framework), describing the physics with the artery wall boundary. We then introduce the boundary condition at the wall in Subsection 2.1.2.

2.1.1. Geometric Set-Up and the Three-Dimensional Navier-Stokes Equations in Curvilinear Coordinates

Regarding arteryshape2d, we consider arteries with star-like cross-sections, meaning, all cross-sections are convex to a curve c C 3 ( [ 0,L ], 3 ) with L the length of the artery, and belong to the orthogonal plane to c ( s ) , where s stands for the curvilinear abscissa. Moreover, we suppose c verifies c ( s ) 3 =1 for all s[ 0,L ] and c ( s ) 3 0 for all s[ 0,L ] .

We consider an incompressible fluid moving in the time-space domain

Ω={ ( x,y,z ) 3 ; ( x,y,z )c( s( x,y,z ) ) 3 R( t,x,y,z ),s( x,y,z )[ 0,L ],t[ 0,T ] }, (6)

where, s( x,y,z ) is such that ( x,y,z ) belongs to the orthogonal plane of c ( s ) as displayed in Figure 2, R( t,x,y,z ) is the radius of the cross-section at a particular angle θ and T>0 an arbitrary final time.

We assume that the velocity u of the viscous flow satisfies, on the domain Ω , the three-dimensional incompressible Navier-Stokes equations

{ divu=0, t u+div( uu )+pdivσ=0, (7)

where u= u x i+ u y j+ u z k with ( i,j,k ) the cartesian basis, p= P ρ where P is the pressure and ρ , the density of the fluid. Finally, the stress tensor is σ=ν( u+ ( u ) t ) where ν is the kinematic viscosity. Consider the following change of variable,

e r ( θ,s )=cosθn( s )+sinθb( s ), e θ ( θ,s )=sinθn( s )+cosθb( s ), (8)

where t( s )= c ( s ) , n( s )= c ( s ) C( s ) , and b ( s )= t ( s ) n ( s ) with C( s )= c ( s ) 3 for all s[ 0,L ] , the curvature of the artery, then the domain Ω from Equation (6) is expressed as

Ω={ c( s )+r e r ( θ,s ) 3 |r[ 0,R( t,x ) ],θ[ 0,2π ],s[ 0,L ],t[ 0,T ] }.

Figure 2. Serret frenet frame.

The velocity u= u r e r + u θ e θ + u s t where u r is the radial speed, u θ is the angular speed and u s is the axial speed.

The coordinate transformation reads M( r,θ,s )=c( s )+r e r ( θ,s ) leading to the following Jacobian matrix, A 1 = ( 1 0 0 0 r rT 0 0 β ) e r , e θ ,t where T( s )= 1 C 2 ( s ) det( c ( s ), c ( s ), c ( 3 ) ( s ) ) is the torsion of the curve and β( r,θ,s )=1rC( s )cosθ . The inverse Jacobian matrix then reads, A= 1 J ( rβ 0 0 0 β rT 0 0 r ) e r , e θ ,t where J=rβ=det( A 1 ) . Coordinate change in Equation (8) leads to p= ( r p 1 r θ p s pT( s ) θ p β ) e r , e θ ,t = ( r p 1 r θ p T p β ) e r , e θ ,t where T = s T θ , and,

divu= 1 rβ r ( rβ u r )+ 1 rβ θ ( β u θ )+ 1 rβ T ( r u s ),

u= ( r u r r u θ r u s θ u r u θ r θ u θ + u r r θ u s r T u r +Ccosθ u s β T u θ Csinθ u s β T u s C( cosθ u r sinθ u θ ) β ) e r , e θ ,t ,

divσ= ( 1 rβ r ( rβ σ rr )+ 1 rβ θ ( β σ θr )+ 1 rβ T ( r σ sr ) 1 r σ θθ + Ccosθ β σ ss 1 rβ r ( rβ σ rθ )+ 1 rβ θ ( β σ θθ )+ 1 rβ T ( r σ sθ )+ 1 r σ θr Csinθ β σ ss 1 rβ r ( rβ σ rs )+ 1 rβ θ ( β σ θs )+ 1 rβ T ( r σ ss ) C β ( cosθ σ sr sinθ σ sθ ) ) e r , e θ ,t ,

where,

σ= ( σ rr σ rθ σ rs σ θr σ θθ σ θs σ sr σ sθ σ ss ) e r , e θ ,t =ν ( 2 r u r r u θ + θ u r u θ r r u s + T u r +Ccosθ u s β // 2 θ u θ + u r r θ u s r + T u θ Csinθ u s β // // 2 T u s C( cosθ u r sinθ u θ ) β ) e r , e θ ,t . (9)

Finally, the Navier Stokes equations from Equation (7) in curvilinear coordinates from Equation (8) are

Divergence equation:

1 rβ r ( rβ u r )+ 1 rβ θ ( β u θ )+ 1 rβ T ( r u s )=0, (10)

Radial momentum equation:

t u r + 1 rβ r ( rβ u r 2 )+ 1 rβ θ ( β u r u θ )+ 1 β T ( u r u s )+ r p u θ 2 r + Ccosθ β u s 2 =ν [ 2 rβ r ( rβ r u r )+ 1 rβ θ ( β( r u θ + θ u r u θ r ) ) + 1 rβ T ( r( r u s + T u r +Ccosθ u s β ) ) 2 r θ u θ + u r r + Ccosθ β ( 2 T u s C( cosθ u r sinθ u θ ) β ) ] (11)

Angular momentum equation:

t u θ + 1 rβ r ( rβ u r u θ )+ 1 rβ θ ( β u θ 2 )+ 1 β T ( u θ u s )+ 1 r θ p+ u θ u r r Csinθ β u s 2 =ν [ 1 rβ r ( rβ( r u θ + θ u r u θ r ) )+ 2 rβ θ ( β θ u θ + u r r ) + 1 rβ T ( r( θ u s r + T u θ Csinθ u s β ) )+ 1 r ( r u θ + θ u r u θ r ) Csinθ β ( 2 T u s C( cosθ u r sinθ u θ ) β ) ] (12)

Axial momentum equation:

t u s + 1 rβ r ( rβ u r u s )+ 1 rβ θ ( β u θ u s )+ 1 β T ( u s 2 )+ 1 β T p C β ( u r cosθ u θ sinθ ) u s =ν [ 1 rβ r ( rβ( r u s + T u r +Ccosθ u s β ) )+ 1 rβ θ ( β( θ u s r + T u θ Csinθ u s β ) ) + 1 rβ T ( r( 2 T u s C( cosθ u r sinθ u θ ) β ) ) C β ( cosθ( r u s + T u r +Ccosθ u s β )sinθ( θ u s r + T u θ Csinθ u s β ) ) ] (13)

2.1.2. The Artery Wall Boundary

Crucial to our model derivation is the particular situation at the wall boundary, where the effect of wall deformation plays a central role. The wall boundary is the set of points

Γ={ c( s )+R( t,θ,s ) e r ( θ,s )|θ [ 0,2π [ ,s[ 0,L ],t[ 0,T ] }.

We define Γ’s tangential and outward normal vectors by

t s w = 1 G s ( t+ T R β e r ), t θ w = 1 G θ ( e θ + θ R R e r ), n w = 1 G ( e r θ R R e θ T R β t ),

where G s , G θ and G are the axial, circumferential and normal arclength

G s = 1+ ( T R β ) 2 , G θ = 1+ ( θ R R ) 2 , G= 1+ ( θ R R ) 2 + ( T R β ) 2 .

Since the wall is assumed to be rough, it produces friction, and due to its elastic behavior, it may get deformed. We take friction into account by considering the following Navier boundary condition on the wall Γ,

( σ n w ) t s w =ku t s w ,( σ n w ) t θ w =ku t θ w , (14)

where k0 is a friction term. Fluid-structure interaction is modeled with the condition

u n w = t R e r n w . (15)

As assumed in [6], thanks to the following hypothesis:

H1 Small thickness and plain stresses: the vessel wall thickness h is assumed to be, a constant, small enough to allow a shell-type representation of the artery geometry. The vessel structure is subjected to plain stresses.

H2 Radial displacement: the artery is described by a star-like cross-section around a curvilinear curve, and its displacements are only in the radial direction.

H3 Small deformation gradients and linear elastic behavior: we suppose that the artery wall behaves like a linear elastic solid where T R and θ R are assumed to be bounded in time.

H4 Incompressibility: the wall tissue is incompressible [12].

H5 Dominance of circumferential stresses. Stresses acting along the axial direction can be neglected compared to circumferential ones.

One can derive the wall dynamic law:

t 2 η+ ρ h ρ w b η R 0 2 = R R 0 ρ h ρ w [ p p ext Gσ n w e r ], (16)

where η=R R 0 is the displacement of the wall, R 0 =R( t=0,θ,s ) is the initial radius of the artery, ρ w is the wall tissues density, h is the wall thickness,

p ext is the external pressure b( θ,s )= E( θ,s )h ρ( 1 ξ 2 ) is a function of the Young modulus E , σ from Equation (9) is the fluid stress tensor at r=R , and p is the fluid pressure at r=R .

Remark. These assumptions allow us to properly set the asymptotic regime discussed in the following sections of this paper. More precisely,

H1 implies that the arterial wall thickness can be considered small compared to the artery radius. This assumption holds both for large and small arteries.

H2 represents a fundamental limitation of this model, clearly marking the boundary with 3D models. Nevertheless, it remains far more reasonable than in the 1D case.

H3 can be relaxed, as is often done in the 1D framework; the adaptation to 2D should be similar. However, our objective here is to show that a bidimensional model with arbitrary friction can still retain energetic consistency with the Navier-Stokes equations. For this reason, we did not include a very detailed arterial wall model. Such a refinement could nonetheless be necessary for complex studies of blood flow in cerebral arteries. Similarly, aneurysm cases might be affected by the absence of hyperelasticity.

H4 is reasonable for a solid such as the arterial wall.

H5 may seem restrictive in light of [6], where the authors show how to avoid it. In our case, the same calculation can also be carried out, and the corresponding term can be added if needed. However, it remains of lower order in the asymptotic expansion presented later in this paper. The derivation of the arterial model is not detailed here, but a complete derivation confirms the asymptotic consistency of the model. We choose to keep the assumption for consistency with [6] but it is a direct consequence of the asymptotic regime.

Gathering Equations (14), (15) and (16), boundary conditions can be written:

Normal boundary condition

u r θ R R u θ T R β u s = t R, (17)

Axial tangential boundary condition

ν [ r u s + T u r +Ccosθ u s β θ R R ( θ u s R + T u θ Csinθ u s β ) T R β ( 2 T u s C( cosθ u r sinθ u θ ) β ) + T R β ( 2 r u r θ R R ( r u θ + θ u r u θ R ) T R β ( r u s + T u r +Ccosθ u s β ) ) ] =Gk( u s + T R β u r ), (18)

Angular tangential boundary condition

ν [ r u θ + θ u r u θ R θ R R ( 2 θ u θ + u r R ) T R β ( θ u s R + T u θ Csinθ u s β ) + θ R R ( 2 r u r θ R R ( r u θ + θ u r u θ R ) T R β ( r u s + T u r +Ccosθ u s β ) ) ] =Gk( u θ + θ R R u r ), (19)

Wall dynamic law

h ρ w ρ R 0 R t 2 R+b R R 0 R R 0 +ν[ 2 r u r θ R R ( r u θ + θ u r u θ R ) T R β ( r u s + T u r +Ccosθ u s β ) ] =p p ext . (20)

2.2. Blood Flow Model with Wall Deformation via Radial-Averaging

We now proceed to write the Navier-Stokes equations with boundary conditions in non-dimensional form. Next, under a thin-artery assumption, we consider the radius of the artery to be small compared to the length, introducing a small parameter ε . This assumption may be rather restrictive for large arteries. However, it has been shown that a similarly derived one-dimensional model remains effective in such cases [6]. The applicability of our model to strongly deformed arteries requires thorough testing in order to properly define its range of validity. Such a study lies beyond the scope of this paper, since our focus here is on the model derivation and its energetic consistency rather than on an exhaustive validation.

We formally make an asymptotic expansion of the Navier-Stokes system in first order with respect to ε . Finally, we derive a radial-averaged first-order two-dimensional model for blood flow. Our approach is similar to those used in [6] [14]-[16] [19].

2.2.1. Dimensionless Navier-Stokes Equations

To derive the blood flow model, we assume that the artery’s radius is small compared to its length and that radial variations in velocity are small compared to axial ones. This is achieved by postulating a small parameter ratio

ε:= R ¯ L = U r U s = U r U θ 1,

where, R ¯ , L , U r , U θ , and U s are the scales of, respectively, radius, length, radial velocity, angular velocity, and axial velocity. As a consequence, the time

scale T is such that T= L U s = L U θ = R ¯ U r . We also choose the pressure scale to be

p ¯ = U s 2 = U θ 2 . (21)

It is convenient to define L, U s , U θ and T , as finite constants with respect to ε , while R ¯ =εL and U r =ε U s =ε U θ . This allows us to introduce the dimensionless quantities of time t ˜ , space ( s ˜ , r ˜ , θ ˜ ), pressure p ˜ and velocity field ( u ˜ s , u ˜ θ , u ˜ r ) via the following scaling relations

t ˜ := t T , p ˜ ( t ˜ , r ˜ , θ ˜ , s ˜ )= p( t,r,θ,s ) p ¯ , s ˜ := s L , u ˜ s ( t ˜ , r ˜ , θ ˜ , s ˜ )= u s ( t,r,θ,s ) U s , r ˜ := r R ¯ = r εL , u ˜ r ( t ˜ , r ˜ , θ ˜ , s ˜ )= u r ( t,r,θ,s ) U r , θ ˜ := θ ε , u ˜ θ ( t ˜ , r ˜ , θ ˜ , s ˜ )= u θ ( t,r,θ,s ) U θ . (22)

We also rescale the following coefficients

k ˜ = k U r = k ε U s = k ε U θ , R ˜ ( t ˜ , θ ˜ , s ˜ )= R( t,θ,s ) R ¯ , h ˜ = h ε R ¯ , E ˜ ( θ ˜ , s ˜ )=ε E( θ,s ) ρ U s 2 , R ˜ 0 ( θ ˜ , s ˜ )= R 0 ( θ,s ) R ¯ C ˜ ( s ˜ )=LC( s ) T ˜ ( s ˜ )=LT( s ). (23)

Finally, we define the non-dimensional Reynolds number R e = L U s ν and ν 0 = ( ε R e ) 1 yielding to the asymptotic regime

R e 1 = ν 0 ε. (24)

Let us also remark that

β( r ˜ , θ ˜ , s ˜ )=1ε r ˜ C ˜ cosθ=1+O( ε ) and T = 1 L T ˜ = 1 L ( s ˜ ε T ˜ θ ˜ )= 1 L s ˜ +O( ε ).

With these assumptions, the effect of torsion is neglected.

Using these dimensionless variables, Equations (21)-(24) in the Navier-Stokes equations from Equations (10)-(13), we get

Dimensionless divergence equation:

1 r ˜ β ˜ r ˜ ( r ˜ β ˜ u ˜ r )+ 1 r ˜ β ˜ θ ˜ ( β ˜ u ˜ θ )+ 1 β ˜ T ˜ ( u ˜ s )=0, (25)

Dimensionless radial momentum equation:

r ˜ p ˜ u ˜ θ 2 r ˜ =ε δ rε , (26)

with

δ rε =ε[ t ˜ u ˜ r + 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ u ˜ r 2 )+ 1 r ˜ β ˜ θ ˜ ( β ˜ u ˜ r u ˜ θ )+ 1 β ˜ T ˜ ( u ˜ r u ˜ s ) ]+ C ˜ cos θ ˜ β ˜ u ˜ s 2 ν 0 [ 2 r ˜ β ˜ r ˜ ( r ˜ β ˜ r ˜ u ˜ r )+ 1 r ˜ β ˜ θ ˜ ( β ˜ ( r ˜ u ˜ θ + ε 2 θ ˜ u ˜ r u ˜ θ r ˜ ) ) 2 r ˜ θ ˜ u ˜ θ + u ˜ r r ˜ + 1 r ˜ β ˜ T ˜ ( r ˜ ( r ˜ u ˜ s + ε 2 T ˜ u ˜ r +ε C ˜ cos θ ˜ u ˜ s β ˜ ) ) + ε C ˜ cos θ ˜ β ˜ ( 2 T ˜ u ˜ s C ˜ ( εcos θ ˜ u ˜ r sin θ ˜ u ˜ θ ) β ˜ ) ]

Dimensionless angular momentum equation:

t ˜ u ˜ θ + 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ u ˜ r u ˜ θ )+ 1 r ˜ β ˜ θ ˜ ( β ˜ u ˜ θ 2 )+ 1 β ˜ T ˜ ( u ˜ θ u ˜ s )+ 1 r ˜ θ ˜ p ˜ + u ˜ θ u ˜ r r ˜ C ˜ sin θ ˜ β ˜ u ˜ s 2 = 1 ε ν 0 [ 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ ( r ˜ u ˜ θ u ˜ θ r ˜ ) )+ r ˜ u ˜ θ r ˜ u ˜ θ r ˜ 2 ]+ε δ θε , (27)

with

δ θε = ν 0 [ 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ ( θ ˜ u ˜ r ˜ r ˜ ) )+ 2 r ˜ β ˜ θ ˜ ( β ˜ θ ˜ u ˜ θ + u ˜ r r ˜ ) + 1 r ˜ β ˜ T ˜ ( r ˜ ( θ ˜ u ˜ s r ˜ + T ˜ u ˜ θ C ˜ sin θ ˜ u ˜ s β ˜ ) ) + 1 r ˜ ( θ ˜ u ˜ r r ˜ ) C ˜ sin θ ˜ β ˜ ( 2 T ˜ u ˜ s C ˜ ( εcos θ ˜ u ˜ r sin θ ˜ u ˜ θ ) β ˜ ) ]

Dimensionless axial momentum equation:

t ˜ u ˜ s + 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ u ˜ r u ˜ s )+ 1 r ˜ β ˜ θ ˜ ( β ˜ u ˜ θ u ˜ s )+ 1 β ˜ T ˜ ( u ˜ s 2 )+ 1 β ˜ T ˜ p ˜ + C ˜ sin θ ˜ β ˜ u ˜ θ u ˜ s = ν 0 ε [ 1 r ˜ β ˜ r ˜ ( r ˜ β ˜ r ˜ u ˜ s )ε C ˜ r ˜ β ˜ cos θ ˜ u ˜ s ]+ε δ sε , (28)

with

δ sε = C ˜ cos θ ˜ β ˜ u ˜ r u ˜ s + ν 0 [ 1 r ˜ β ˜ r ˜ ( r ˜ T ˜ u ˜ r )+ 1 r ˜ β ˜ θ ˜ ( β ˜ ( θ ˜ u ˜ s r ˜ + T ˜ u ˜ θ C ˜ sin θ ˜ u ˜ s β ˜ ) ) + 1 r ˜ β ˜ T ˜ ( r ˜ ( 2 T ˜ u ˜ s C ˜ ( εcos θ ˜ u ˜ r sin θ ˜ u ˜ θ ) β ˜ ) ) C ˜ β ˜ ( cos θ ˜ ( ε T ˜ u ˜ r + C ˜ cos θ ˜ u ˜ s β ˜ )sin θ ˜ ( θ ˜ u ˜ s r ˜ + T ˜ u ˜ θ C ˜ sin θ ˜ u ˜ s β ˜ ) ) ].

Similarly, the boundary conditions from Equations (17)-(20) become

Dimensionless normal boundary condition

u ˜ r θ ˜ R ˜ R ˜ u ˜ θ T ˜ R ˜ β u ˜ s = t ˜ R ˜ , (29)

Dimensionless axial tangential boundary condition

ν 0 r ˜ u ˜ s =ε( G ˜ k ˜ u ˜ s ν 0 C ˜ cos θ ˜ β ˜ u ˜ s )+ ε 2 δ Rsε , (30)

with,

δ Rsε = ν 0 [ T ˜ u ˜ r β ˜ θ ˜ R ˜ R ˜ ( θ ˜ u ˜ s R ˜ + T ˜ u ˜ θ C ˜ sin θ ˜ u ˜ s β ˜ ) T ˜ R ˜ β ˜ ( 2 T ˜ u ˜ s C ˜ ( εcos θ ˜ u ˜ r sin θ ˜ u ˜ θ ) β ˜ ) + T ˜ R ˜ β ˜ ( 2 r ˜ u ˜ r θ ˜ R ˜ R ˜ ( ε 2 r ˜ u ˜ θ + θ ˜ u ˜ r u ˜ θ R ˜ ) T ˜ R ˜ β ˜ ( r ˜ u ˜ s + ε 2 T ˜ u ˜ r +ε C ˜ cos θ ˜ u ˜ s β ˜ ) ) ]+ G ˜ k ˜ T ˜ R ˜ β ˜ u ˜ r ,

Dimensionless angular tangential boundary condition

ν 0 [ r ˜ u ˜ θ u ˜ θ R ˜ ]=ε k ˜ u ˜ θ + ε 2 δ Rθε , (31)

with

δ Rθε = ν 0 [ θ ˜ u ˜ r R ˜ θ ˜ R ˜ R ˜ ( 2 θ ˜ u ˜ θ + u ˜ r R ˜ ) T ˜ R ˜ β ˜ ( θ ˜ u ˜ s R ˜ + T ˜ u ˜ θ C ˜ sin θ ˜ u ˜ s β ˜ ) + θ ˜ R ˜ R ˜ ( 2 r ˜ u ˜ r θ ˜ R ˜ R ˜ ( r ˜ u ˜ θ + ε 2 θ ˜ u ˜ r u ˜ θ R ˜ ) T ˜ R ˜ β ˜ ( r ˜ u ˜ s + ε 2 T ˜ u ˜ r +ε C ˜ cos θ ˜ u ˜ s β ˜ ) ) ]+ G ˜ k ˜ θ ˜ R ˜ R ˜ u ˜ r ,

Dimensionless wall dynamic law

b ˜ R ˜ R ˜ 0 R ˜ R ˜ 0 = p ˜ p ˜ ext +ε δ Rε , (32)

with,

δ Rε = ε 2 h ˜ ρ w ρ R ˜ 0 R ˜ t ˜ 2 R ˜ ν 0 [ 2 r ˜ u ˜ r θ ˜ R ˜ R ˜ ( r ˜ u ˜ θ + ε 2 θ ˜ u ˜ r u ˜ θ R ˜ ) T ˜ R ˜ β ˜ ( r ˜ u ˜ s + ε 2 T ˜ u ˜ r +ε C ˜ cos θ ˜ u ˜ s β ˜ ) ]

where b ˜ ( θ ˜ , s ˜ )= E ˜ ( θ ˜ , s ˜ )h 1 ξ 2 .

2.2.2. First Order Approximation of the Dimensionless Navier-Stokes Equations

In the following, we omit the ˜ . Identifying terms of order 1 ε in the axial momentum Equation (28), we obtain the motion by radius (similar to the so-called motion by slices, see [13]-[16]) decomposition

ν 0 1 r r ( r r u s )=O( ε )r r u s =O( ε ) u s ( t,r,θ,s )= u s,0 ( t,θ,s )+O( ε ),

for some function u s,0 and where we gathered all ε terms in O( ε ) . Similarly, identifying terms of order 1 ε in the angular momentum Equation (27), we obtain the motion by radial decomposition

ν 0 [ 1 rβ r ( rβ( r u θ u θ r ) )+ r u θ r u θ r 2 ]=O( ε ),

ν 0 [ 1 r r ( r 2 r ( u θ r ) )+ r ( u θ r ) ]=O( ε ).

ν 0 [ r ( r r ( u θ r )+2 u θ r ) ]=O( ε ).

Using the angular tangential boundary condition from Equation (31), it is straightforward to see that the only solution is,

u θ r =( u θ r )( r=R )+O( ε ).

Noting

u s ¯ ( t,θ,s )= 1 A( t,θ,s ) 0 R( t,θ,s ) r u s ( t,r,θ,s )dr, u θ ¯ ( t,θ,s )= 1 A( t,θ,s ) 0 R r u θ ( t,r,θ,s )dr,

as the mean axial and angular speeds of the fluid over a radius where

A( t,θ,s )= R 2 ( t,θ,s ) 2 , (33)

we have the following properties:

u s ( t,r,θ,s )= u s ¯ ( t,θ,s )+O( ε )and u s 2 ( t,r,θ,s ) ¯ = u s ¯ 2 ( t,θ,s )+O( ε ), (34)

u θ ( t,r,θ,s )= 3 2 u θ ¯ ( t,θ,s ) r R +O( ε )and u θ 2 ( t,r,θ,s ) ¯ = 9 8 u θ ¯ 2 ( t,θ,s )+O( ε ). (35)

Multiplying by r and integrating the divergence Equation (25) over a radius, we obtain

0= 0 R [ r ( r u r )+ θ ( u θ )+ s ( r u s ) ] +O( ε ) =R u r ( r=R )+ θ ( 0 R u θ dr ) θ R u θ ( r=R ) + s ( 0 R r u s dr ) s RR u s ( r=R )+O( ε ).

In view of the normal boundary condition from Equation (29), we get the conservation equation

t A+ θ ( 3 2 Q θ R )+ s ( Q s )=O( ε ), (36)

where,

Q θ ( t,θ,s )=A( t,θ,s ) u θ ¯ ( t,θ,s )= 0 R r u θ dr , Q s ( t,θ,s )=A( t,θ,s ) u s ¯ ( t,θ,s )= 0 R r u s dr . (37)

Then, integrating the radial momentum Equation (26) between r and R , we obtain the following pressure

p( t,r,θ,s )=p( t,R,θ,s ) r R u θ 2 s ds +O( ε ) =p( t,R,θ,s ) 9 8 Q θ 2 A 2 ( 1 ( r R ) 2 )+O( ε ) (38)

We proceed with multiplying by r 2 and integrating over a radius the angular momentum Equation (27)

0 R r 2 [ t u θ + 1 r r ( r u r u θ )+ 1 r θ ( u θ 2 )+ s ( u θ u s )+ 1 r θ p+ u θ u r r Csinθ u s 2 ]dr = 0 R r 2 [ 1 ε ν 0 [ 1 r r ( r( r u θ u θ r ) )+ r u θ r u θ r 2 ] ]dr+O( ε ),

yielding to

0 R r 2 t u θ + 0 R r ( r 2 u r u θ ) + 0 R θ ( r u θ 2 ) + 0 R s ( r 2 u θ u s ) + 0 R θ ( rp ) Csinθ 0 R r 2 u s 2 = 0 R [ 1 ε ν 0 [ r r ( r 2 r ( u θ r ) )+ r 2 r ( u θ r ) ] ] +O( ε ),

and then,

0 R r 2 t u θ + 0 R r ( r 2 u r u θ ) + 0 R θ ( r u θ 2 ) + 0 R s ( r 2 u θ u s ) + 0 R θ ( rp ) Csinθ 0 R r 2 u s 2 = 0 R r [ 1 ε ν 0 [ r 3 r ( u θ r ) ] ]+O( ε ),

Using the definitions of A in Equation (33), Q θ and Q s in Equation (37), thanks to the normal boundary condition from Equation (29), we have

t ( 0 R r 2 u θ )+ θ ( 0 R r u θ 2 )+ s ( 0 R r 2 u θ u s )+ θ ( 0 R rp ) θ Ap( r=R ) Csinθ 0 R r 2 u s 2 = 1 ε ν 0 [ R 2 ε ν 0 k u θ ( r=R ) ]+O( ε ),

Then, using the properties from Equation (34) and Equation (35), the expression of the pressure in Equation (38) and the angular tangential boundary condition in Equation (31), we obtain

t ( 3R 4 Q θ )+ θ ( 9R 8 Q θ 2 RA )+ s ( 3R 4 Q θ Q s A )+ θ ( Ap( r=R ) 9R 16 Q θ 2 RA ) θ Ap( r=R ) 2R 3 Csinθ Q s 2 A = 3R 2 Rk Q θ A +O( ε ), (39)

Finally, multiplying by r and integrating over a radius the axial momentum Equation (28)

0 R r [ t u s + 1 r r ( r u r u s )+ 1 r θ ( u θ u s )+ s ( u s 2 )+ s p+Csinθ u θ u s ]dr = 0 R r [ ν 0 ε [ 1 rβ r ( rβ r u s )+ε Ccosθ r u s ] ]dr+O( ε ),

we get

0 R t ( r u s ) +R u r ( r=R ) u s ( r=R )+ 0 R θ ( u θ u s ) + 0 R s ( r u s 2 ) + 0 R s ( rp ) +Csinθ 0 R r u θ u s = 0 R r [ ν 0 ε [ 1 rβ r ( rβ r u s )+ε Ccosθ r u s ] ]dr+O( ε ),

Using the definitions of A from Equation (33), Q θ and Q s from Equation (37), thanks to the normal boundary condition in Equation (29), we have

t ( Q s )+ θ ( 0 R u θ u s )+ s ( 0 R r u s 2 )+ s ( 0 R rp ) s Ap( r=R )+Csinθ 0 R r u θ u s = ν 0 ε [ R( r u s )( r=R )+ 0 R r β β r r u s +εCcosθ 0 R u s ]+O( ε ),

Then, using the properties from Equation (34) and Equation (35), the expression of the pressure in Equation (38) and the axial tangential boundary condition in Equation (30), we obtain

t ( Q s )+ θ ( 3 2 Q s Q θ AR )+ s ( Q s 2 A )+ s ( Ap( r=R ) 9 16 Q θ 2 A ) s Ap( r=R ) =kR Q s A Csinθ Q s Q θ A +O( ε ),

leading to

t ( Q s )+ θ ( 3 2 Q s Q θ AR )+ s ( Q s 2 A 9 16 Q θ 2 A +Ap( r=R ) ) =kR Q s A Csinθ Q s Q θ A + s Ap( r=R )+O( ε ). (40)

Finally from Equations (36), (39), (40) and the wall dynamic law in Equation (32) dropping all terms of the first order, we obtain the following radial-averaged two-dimensional model for blood flow

{ t A+ θ ( 3 2 Q θ R )+ s ( Q s )=0, t ( 3R 4 Q θ )+ θ ( 9R 16 Q θ 2 RA +Ap )+ s ( 3R 4 Q θ Q s A )= 2R 3 Csinθ Q s 2 A + 3R 2 Rk Q θ A + θ Ap, t ( Q s )+ θ ( 3 2 Q s Q θ AR )+ s ( Q s 2 9 16 Q θ 2 A +Ap )=kR Q s A Csinθ Q s Q θ A + s Ap, p= p ext +b R R 0 R 0 2 .

where we have replaced p( r=R= 2A ) by p for simplicity. Lastly, using a simple change of variable Q Rθ = 3 4 R Q θ , we get,

{ t A+ θ ( Q Rθ A )+ s ( Q s )=0, t ( Q Rθ )+ θ ( Q Rθ 2 2 A 2 +Ap )+ s ( Q Rθ Q s A )= 2R 3 Csinθ Q s 2 A +2Rk Q Rθ A + θ Ap, t ( Q s )+ θ ( Q s Q Rθ A 2 )+ s ( Q s 2 A Q Rθ 2 2 A 2 +Ap )= 2R 3 Csinθ Q s Q Rθ A 2 +kR Q s A + s Ap, p= p ext +b R R 0 R 0 2 . (41)

2.2.3. Mathematical Properties for the Two-Dimensional Model

We have the following results

Theorem 1. Let ( A, u θ ¯ , u s ¯ ) , and Q Rθ = 3 4 R Q θ = 3 4 RA u θ ¯ , Q s =A u s ¯ satisfy the two-dimensional blood flow system in Equation (41). Then, we have:

1) System (41) is strictly hyperbolic if A>0 and A p ( A ) 9 8 u θ ¯ 2 0 .

2) For smooth solution ( A, u θ ¯ , u s ¯ ) , in the region where A>0 , we have the following head equation,

t ψ+ 3 2 u θ ¯ R θ ( ψ+ p ¯ )+ u s ¯ s ( ψ+ p ¯ )+ p p ¯ A t A= 9 4A Rk u θ ¯ 2 + 1 A kR u s ¯ 2 . (42)

where ψ( u θ , u s ,p )= 9 8 u θ 2 + u s 2 2 is the total head and p ¯ =p 9 16 u θ ¯ 2 is the mean pressure over a radius.

3) For smooth solution ( A, u θ ¯ , u s ¯ ) , the steady state reads u θ ¯ =0 , u s ¯ =0 and p= p 0 for some constant p 0 . In particular, for A= A 0 , we have p 0 =0 .

4) The pair of function ( E,E+ p ˜ ) with E:=A( ψ+p ) p ˜ forms a mathematical entropy pair for system (41), in that they satisfy the following entropy relation for smooth solution ( A, u θ ¯ , u s ¯ ) :

t E+ div θ,s ( ( 3 2 u θ ¯ R u s ¯ )( E+ p ˜ 9 16 A u θ ¯ 2 ) )= 9 4 Rk u θ ¯ 2 +kR u s ¯ 2 .

5) The quantity E is consistent with the total energy energy e= ε 2 u r 2 + u θ 2 + u s 2 2 of the Navier-Stokes Equations (25)-(28), in the sense that,

t ( 0 R re )+ 0 R rdiv ( u( e+p ) ) = t E+di v θ,s ( ( 3 2 u θ ¯ R u s ¯ )( E+ p ˜ 9 16 A u θ ¯ 2 ) )+O( ε )

where u=( ε u r u θ u s ) .

Remark. The condition A p ( A ) 9 8 u θ ¯ 2 0 is always satisfied in real life situations [12] [17].

Proof.

1) To prove the hyperbolicity of system (41), we write

t U+ H θ θ U+ H s s U=S

where

U=( A Q Rθ Q s ), H θ =( Q Rθ A 2 1 A 0 Q Rθ 2 A 3 +A p ( A ) Q Rθ A 2 0 2 Q Rθ Q s A 3 Q s A 2 Q Rθ A 2 ),

H s =( 0 0 1 Q Rθ Q s A 2 Q s A Q Rθ A Q s 2 A 2 + Q Rθ 2 A 3 +A p ( A ) Q Rθ A 2 2 Q s A ),S=( 0 2R 3 Csinθ Q s 2 A +2Rk Q Rθ A 2R 3 Csinθ Q s Q Rθ A 2 +kR Q s A )

Then, remark that the eigenvalues for H θ are Sp( H θ )={ Q Rθ A 2 , p ( A ) , p ( A ) } . For H s , the eigenvalues are Sp( H s )={ Q s A , Q s A A p ( A ) , Q s A + A p ( A ) } . The system (41) is strictly hyperbolic if A>0 and Q Rθ A 2 ± p ( A ) which can be written as A p ( A ) 9 8 u θ ¯ 2 0 .

2) Next, from simple manipulation, system (41) becomes,

{ t A+ θ ( 3 2 A u θ ¯ R )+ s ( A u s ¯ )=0, t ( 3R 4 A u θ ¯ )+ θ ( 9R 16 A u θ ¯ 2 R )+ s ( 3R 4 A u θ ¯ u s ¯ )+A θ p= 2R 3 CsinθA u s ¯ 2 + 3R 2 Rk u θ ¯ , t ( A u s ¯ )+ θ ( 3 2 A u s ¯ u θ ¯ R )+ s ( A u s ¯ 2 9 16 A u θ ¯ 2 )+A s p=CsinθA u s ¯ u θ ¯ +kR u s ¯ , p= p ext +b R R 0 R 0 2 .

We first focus on the second equation, dividing by R , we have,

t ( 3 4 A u θ ¯ )+ θ ( 9 16 A u θ ¯ 2 R )+ s ( 3 4 A u θ ¯ u s ¯ )+ 3 4R A u θ ¯ [ t R+ 3 4 u θ ¯ R θ R+ u s ¯ s R ] + R 2 θ p= 2 3 CsinθA u s ¯ 2 + 3 2 Rk u θ ¯ .

Then, we use the mass conservation Equation (36) and divide by A to get,

t ( 3 4 u θ ¯ )+ u θ R θ ( 9 16 u θ ¯ ) 9 16 u θ ¯ A θ ( A u θ R )+ 3 4R u θ ¯ [ t R+ 3 4 u θ ¯ R θ R+ u s ¯ s R ] + u s s ( 3 4 u θ ¯ )+ R 2A θ p= 2 3 Csinθ u s ¯ 2 + 3 2A Rk u θ ¯

which can be easily written as,

t ( 3 4 u θ ¯ )+ 3 4R u θ ¯ [ t R+ u s ¯ s R ]+ u s s ( 3 4 u θ ¯ )+ 1 R θ p= 2 3 Csinθ u s ¯ 2 + 3 2A Rk u θ ¯ .

Finally, we multiply by 3 2 u θ ¯ to get,

t ( 9 16 u θ ¯ 2 )+ 9 8R u θ ¯ 2 [ t R+ u s ¯ s R ]+ u s s ( 9 16 u θ ¯ 2 )+ 3 2 u θ R θ p =Csinθ u θ ¯ u s ¯ 2 + 9 4A Rk u θ ¯ 2 .

Similarly, for the third equation in system (41), using the divergence equation and dividing by A leads to,

t ( u s ¯ )+ 3 2 u θ ¯ R θ ( u s ¯ )+ u s ¯ s ( u s ¯ ) 1 A s ( 9 16 A u θ ¯ 2 )+ s p =Csinθ u s ¯ u θ ¯ + 1 A kR u s ¯ ,

and multiplying by u s ¯ ,

t ( u s ¯ 2 2 )+ 3 2 u θ ¯ R θ ( u s ¯ 2 2 )+ u s ¯ s ( u s ¯ 2 2 ) u s ¯ A s ( 9 16 A u θ ¯ 2 )+ u s ¯ s p =Csinθ u s ¯ 2 u θ ¯ + 1 A kR u s ¯ 2 .

Finally gathering our two results we obtain,

t ψ+ 3 2 u θ ¯ R θ ( ψ+p 9 16 u θ ¯ 2 )+ u s ¯ s ( ψ+p )+ 9 8R u θ ¯ 2 [ t R+ u s ¯ s R ] u s ¯ A s ( 9 16 A u θ ¯ 2 )= 9 4A Rk u θ ¯ 2 + 1 A kR u s ¯ 2

where ψ= 9 16 u θ ¯ 2 + 1 2 u s 2 is the total head. Reminding p ¯ =p 9 16 u θ ¯ 2 , we get,

t ψ+ 3 2 u θ ¯ R θ ( ψ+ p ¯ )+ u s ¯ s ( ψ+ p ¯ )+ p p ¯ A t A= 9 4A Rk u θ ¯ 2 + 1 A kR u s ¯ 2 .

3) The proof is based on simple algebraic computations and is left to the reader.

4) We consider the head Equation (42) and multiply by A ,

t ( Aψ )ψ t A+ θ ( 3 2 A u θ ¯ R ( ψ+ p ¯ ) )+ s ( A u s ¯ ( ψ+ p ¯ ) )+( ψ+ p ¯ ) t A +( p p ¯ ) t A= 9 4 Rk u θ ¯ 2 +kR u s ¯ 2 ,

leading to

t ( A( ψ+p ) p ˜ )+ θ ( 3 2 A u θ ¯ R ( ψ+ p ¯ ) )+ s ( A u s ¯ ( ψ+ p ¯ ) )= 9 4 Rk u θ ¯ 2 +kR u s ¯ 2 ,

with p ˜ such that, p ˜ ( A )=A p ( A ) . We call energy the quantity E:=A( ψ+p ) p ˜ and remark,

t ( E )+ θ ( 3 2 u θ ¯ R ( E+ p ˜ 9 16 A u θ ¯ 2 ) )+ s ( u s ¯ ( E+ p ˜ 9 16 A u θ ¯ 2 ) )= 9 4 Rk u θ ¯ 2 +kR u s ¯ 2 .

Moreover, the total energy in our domain π π 0 L Edsdθ decreases, i.e.

d dt ( E tot )= 9 4 ( Rk ) u θ ¯ 2 +( Rk ) u s 2 0,

with k supposed negative in the domain.

5) In this proof, we use Equations (25)-(28) by omitting ˜ and gathering all remainder terms in O( ε ) . Multiplying respectively the radial momentum Equation (26), angular momentum Equation (27), and axial momentum Equation (28) by u r , u θ , and u s , and summing up the three equations obtained, one has

t ( u θ 2 + u s 2 2 )+ u r r ( u θ 2 + u s 2 2 )+ u θ r θ ( u θ 2 + u s 2 2 )+ u s s ( u θ 2 + u s 2 2 ) + u r r p+ u θ r θ p+ u s s p = ν 0 ε [ u s rβ r ( rβ r u s )+ε Ccosθ r u s 2 + u θ rβ r ( rβ( r u θ u θ r ) ) + u θ r u θ r u θ 2 r 2 ]+O( ε ).

Defining ϕ= u θ 2 + u s 2 2 , recalling e= ε 2 u r 2 + u θ 2 + u s 2 2 , and therefore e=ϕ+O( ε 2 ) , keeping it in mind, multiplying by rβ the previous equation, we have:

t ( rϕ )+ r ( r u r ( ϕ+p ) )+ θ ( u θ ( ϕ+p ) )+ s ( r u s ( ϕ+p ) ) = ν 0 ε [ u s r ( rβ r u s )+εCcosθ u s 2 + u θ r r ( r 2 β( r u θ u θ r ) ) ]+O( ε ).

We proceed by integrating the above-equation, making use of the normal boundary condition from Equation (29), to get:

t ( A ϕ ¯ )+ θ ( 0 R u θ ( ϕ+p ) )+ s ( 0 R r u s ( ϕ+p ) )+ t Ap( r=R ) = ν 0 ε 0 R [ u s r ( rβ r u s )+εCcosθ u s 2 + u θ r r ( r 2 β( r u θ u θ r ) ) ] +O( ε ),

where ϕ ¯ = 1 A 0 R rϕ . Using the profile from Equations. (35) and (34) we get,

t ( A( ϕ ¯ +p( r=R ) ) p ˜ )+ θ ( 3 2 u θ ¯ R A( ϕ ¯ + p ¯ ) )+ s ( u s ¯ A( ϕ ¯ + p ¯ ) ) = ν 0 ε [ u s ¯ Rβ( r=R )( r u s )( r=R )+εCcosθR u s ¯ 2 + 3 2 u θ ¯ R ( R 2 β( r=R )( ( r u θ )( r=R ) u θ ( r=R ) R ) ) ]+O( ε ),

where p ˜ is such that, p ˜ ( A )=A p R ( A ) with p R =p( r=R ) . Finally, using the boundary condition Equations (31) and (30) in the preceding equation, we get:

t ( A( ϕ ¯ +p( r=R ) ) p ˜ )+ θ ( 3 2 u θ ¯ R A( ϕ ¯ + p ¯ ) )+ s ( u s ¯ A( ϕ ¯ + p ¯ ) ) = ν 0 ε [ u s ¯ R( ε ν 0 k u s ¯ εCcosθ u s ¯ )+εCcosθR u s ¯ 2 + 9 4 u θ ¯ R ε ν 0 k u θ ¯ ]+O( ε ),

yielding to

t ( A( ϕ ¯ +p( r=R ) ) p ˜ )+ θ ( 3 2 A u θ ¯ R ( ϕ ¯ + p ¯ ) )+ s ( A u s ¯ ( ϕ ¯ + p ¯ ) ) =Rk u s ¯ 2 + 9 4 Rk u θ ¯ 2 +O( ε ).

Remarking that ϕ ¯ = 1 A 0 R r u θ 2 + u s 2 2 dr=ψ , we obtain the result:

t ( 0 R re )+ 0 R rdiv ( u( e+p ) ) = t E+ div θ,s ( ( 3 2 u θ ¯ R u s ¯ )( E+ p ˜ 9 16 A u θ ¯ 2 ) )+O( ε ).

3. A Discontinuous Galerkin Method for the Two-Dimensional Model

In this section, we present a discontinuous Galerkin method to solve a general two-dimensional hyperbolic system of equations, in particular for model (41), using the RKDG method from [18] on a cartesian grid. It can be easily generalized to non-conforming meshes (see for instance [20] [21]).

3.1. Model Problem

poussel2023runge Our aim is to construct a high-order numerical method for the blood flow problem from Equation (41) derived in Section 2. To this purpose, we propose a Discontinuous Galerkin approach for two-dimensional hyperbolic problems following [18]. Let us consider the following non-linear two-dimensional hyperbolic problem:

{ t u+ x f 1 + y f 2 =s, ( t,x,y )] 0,T ]×] a 1 , b 1 [×] a 2 , b 2 [, u( t=0,x,y )= u 0 (x,y), ( x,y )[ a 1 , b 1 ]×[ a 2 , b 2 ], u( t,x= a 1 ,y )= u left ( t,y ), ( t,y )] 0,T ]× [ a 2 , b 2 [ , u( t,x= b 1 ,y )= u right ( t,y ), ( t,y )] 0,T ]× [ a 2 , b 2 [ , u( t,x,y= a 2 )= u bottom ( t,x ), ( t,x )] 0,T ]× [ a 1 , b 1 [ , u( t,x,y= b 2 )= u top ( t,x ), ( t,x )] 0,T ]× [ a 1 , b 1 [ . (43)

where ( u right , u left , u top , u bottom ) ( d ) 4 are Dirichlet boundary conditions and u 0 ( x,y ) d is the initial condition. Here f 1 ( t,x,y,u ) d is the advection component in the x direction, f 2 ( t,x,y,u ) is the advection component in the y direction, and s( t,x,y,u, x,y u ) is the source term.

3.2. Space Discretization

Since the objective is to solve Equation (43) using a numerical scheme, defining a partition of the computational domain [ a 1 , b 1 ]×[ a 2 , b 2 ] is mandatory. For simplicity, a cartesian fixed mesh is used and its description is given in subsection 3.2.1. Following this description, we derive the discrete variational formulation in subsection 3.2.2. Finally, this will lead to an ODE system in subsection 3.2.3.

3.2.1. Mesh Description

Let us define a partition of the computational domain [ a 1 , b 1 ]×[ a 2 , b 2 ] . The set of all open faces of all elements E is denoted by . Moreover, we can define two subsets of , for the boundary faces and in for the interior faces.

For a given element E , there exists a set of face E ={ F|FE } which defines boundaries of E . Then, for all interior faces of E , i.e. F E in , there exists a neighboring element E r such that E E r =F . Consequently, the normal unit vector n E,F :=( n x n y ) pointing from E to E r is well defined. Moreover for all boundary faces of E , i.e., F E , there exists E a fictitious element such that E E =F . Again, n E,F is well defined.

For simplicity, all elements are considered rectangular and faces are straight lines with normal vector n E,F =( ±1 0 ) for vertical faces or n E,F =( 0 ±1 ) for horizontal ones.

In the discontinuous Galerkin framework, the solutions are considered piecewise polynomials per element. Many basis exist for the polynomial space over an element as monomial, Legendre, Dubiner, and others [20] [22]. For simplicity, we only consider the monomial basis in this section. Finally, the approximate space is given as

V p ( )={ v:[ a 1 , b 1 ]×[ a 2 , b 2 ]; v | E p ( E ),E }.

3.2.2. Weak Formulation

By multiplying the system (43) by a test function v V p ( ) and integrating over an element E , we obtain

E t uv E ( f 1 x v+ f 2 y v )dE + F E F ( f 1 f 2 ) n E,F v | E dF = E svdE .

We look for u DG V p ( ) such that

E t u DG v E ( f 1 x v+ f 2 y v )dE + F E F f ^ v | E dF = E svdE . (44)

where f ^ is the numerical flux which we choose, for simplicity, as the Rusanov flux

f ^ ( t,x,y, u DG , n E,F )={ ( f 1 ( t,x,y, u DG ) f 2 ( t,x,y, u DG ) ) n E,F }+ c 2 [ u DG ],

where c= max i=1,,d | λ i ( t, x n ,u,n ) | with λ i the eigenvalues of ( u f 1 u f 2 )n , { v }= v | E + v | E r 2 the average of v at the face F and [ v ]= v | E v | E r the jump of v across the face F . Remark that, for a face F F , we consider u DG | E ( F )= u boundary where u boundary are the boundary conditions set in Equation (43).

3.2.3. ODE System

Consider the monomial two-dimensional basis functions of p ( E ) defined as nbc= ( p+1 )( p+2 ) 2 function defined by,

φ i E ( x,y )= φ k( k+1 ) 2 +j E ( x ^ , y ^ )= x ^ kj y ^ j , (45)

where 0kp , 0jk and, x ^ = 2 h x ( x x n+ 1 2 ) , y ^ = 2 h y ( y y n+ 1 2 ) , with h x and h y the length and the width of the element E respectively. We look for a solution u DG of Equation (44) in V p ( ) that we decompose in the basis Equation (45):

u DG ( t,x,y )= E i=0 nbc φ i E ( x,y ) U i E ( t ) E ( x,y ),

where the coefficients U i E ( t ) are unknown time-dependent functions and ( x,y ) is the characteristic function of the element E . Similarly, v( x,y )= E i=0 nbc φ i E ( x,y ) V i E E ( x,y ) , with V i E constant coefficients. Following these definitions, one can write:

E i=0 nbc j=0 nbc ( E ϕ i E ϕ j E ) t U i E V j E E j=0 nbc E ( f 1 x ϕ j E + f 2 y ϕ j E )dE V j E + E j=0 nbc F E F f ^ ϕ j E dF V j E = E j=0 nbc E s ϕ j E dE V j E .

Finally, this can be written in matrix form as,

V t M t U V t F( t,U )= V t S( t,U ),

where, U= ( U i E ) i 1,nbc,E , V= ( V i E ) i 1,nbc,E , M= ( E ϕ i E ϕ j E ) i 1,nbc,j 1,nbc,E and

F( t,U )= ( E ( f 1 x ϕ j E + f 2 y ϕ j E )dE F E F f ^ ϕ j E dF ) j 1,nbc,E , S( t,U )= ( E s ϕ j E dE ) j 1,nbc,E . Simplifying by V t , we get the following ODE system

M t U=F( t,U )+S( t,U ). (46)

3.3. Time Discretization

In this section, we propose a time discretization based on the Runge-Kutta (RK) methods applied to the ODE system (46).

3.3.1. RK Methods

We recall the RK methods presented in [23]. RK methods are used to solve a system of ODEs of the form

U ( t )=R( t,U ) (47)

where R is some function. Let t k [ 0,T ] and Δt a well-chosen time step, s -stage-Runge-Kutta methods reads, for i 1,s ,

{ K ( i ) = U ( k ) +Δt j=1 s a ij R ( t k + c j Δt, K ( j ) ), U ( k+1 ) = U ( k ) +Δt i=1 s b i R ( t k + c i Δt, K ( i ) ),

where U ( k ) U( t k ) is the approximate solution of Equation (47) at time t k and U ( k+1 ) U( t k +Δt ) the approximate solution at time t k+1 = t k +Δt . The Butcher coefficient ( a ij ) i 1,s,j 1,s , ( b i ) i 1,s , ( c i ) i 1,s are constrained, at a minimum, by certain order of accuracy and stability considerations as discussed in [23].

3.3.2. Application to the ODE System

We write the ODE from Equation (46) in the form of Equation (47) leading to, t ( U )= M 1 R( t,U ) with R( t,U )=F( t,U )+S( t,U ) leading to the following scheme

{ M K ( i ) =M U ( k ) +Δt j=1 s a ij R ( t k + c j Δt, K ( j ) ), M U ( k+1 ) =M U ( k ) +Δt i=1 s b i R ( t k + c i Δt, K ( i ) ), (48)

The time step is given by

Δt= cfl 2p+1 min E Area( E ) Diam( E ) 1 c k ,

where cfl] 0,1 ] , p is the polynomial degree, Area( E ) , the area of an element, Diam( E ) its diameter and c k , the characteristic speed define as c k = max E | λ( t k , U k ,E ) | , with λ( t,u,E ) the maximum of the eigenvalues of u f 1 ( t,x,y,u )+ u f 2 ( t,x,y,u ) for ( x,y )E . This CFL condition is obtained by a von Neumann stability analysis of the RKDG methods [18] [24].

We use the following explicit time scheme depending on p (see Table 1), and butcher tables can be found in [21] [25]. Those algorithms are sometimes called the TVD-RK (Total Variation Diminishing-RK) scheme or SSP-RK (Strong Stability Preserving-RK) scheme.

Table 1. Time schemes for different values of p .

p

Time scheme

0

Euler

1

TVDRK2

2

TVDRK3

3

TVDRK4

4

TVDRK5

3.4. Still-Steady States Solutions

One can easily obtain a well-balanced scheme for the two-dimensional blood flow problem in Equation (41) derived in Section 2 by a simple change of variable. This is an important stability property of the numerical scheme. It is achieved by introducing the change of variable

a=A A 0 .

Thus, one can write the system (41) as

{ t ( a )+ θ ( Q Rθ a+ A 0 )+ s ( Q s )=0, t ( Q Rθ )+ θ ( Q Rθ 2 2 ( a+ A 0 ) 2 +( a+ A 0 )p )+ s ( Q Rθ Q s a+ A 0 ) = 2R 3 Csinθ Q s 2 a+ A 0 +2Rk Q Rθ a+ A 0 + θ ( a+ A 0 )p, t ( Q s )+ θ ( Q s Q Rθ ( a+ A 0 ) 2 )+ s ( Q s 2 a+ A 0 Q Rθ 2 2 ( a+ A 0 ) 2 +( a+ A 0 )p ) = 2R 3 Csinθ Q s Q Rθ ( a+ A 0 ) 2 +kR Q s a+ A 0 + s ( a+ A 0 )p, p= p ext +b R R 0 R 0 2 . (49)

Then, we have the following property:

Proposition 2. The numerical scheme in Equation (48) preserves exactly the still-steady states solutions (see Theorem 1).

The proof is based on the recursivity principle and is left to the reader.

4. Test Cases

In this chapter, we present several test cases for the Discontinuous Galerkin (DG) method developed in Section 3 for the two-dimensional blood flow system (41). The main objective of these test cases is to evaluate the robustness of the DG method. From now on, we consider the model (49) instead of Equation (41).

4.1. Convergence Order

To solve the two-dimensional blood flow model (see Section 2), we use the DG method presented in Section 3. We aim to compute the numerical order of convergence for a given exact solution. We consider the following friction coefficient k=11 ν R . We also recall the pressure p=b A A 0 A 0 with β a physical parameter for the wall. The physical and numerical parameters used are given in Table 2 together with the following geometric parameters: c( s )= ( cos( s ),sin( s ),s ) 2 , leading to, t( s )= ( sin( s ),cos( s ),1 ) 2 , and, n( s )=( cos( s ),sin( s ),0 ) where C( s )= 2 . We compute a reference solution for the 2D numerical scheme, as shown in Figure 3, using 128 × 128 elements. In Figure 4, we compute the convergence order for N×N elements with N=4,8,16 . We compute the error ϵ= u REF u DG l 2 ( [ 0,1 ] ) with u REF the reference solution calculated before and u DG the solution obtain at time t=T . We show that all variables converge at an order of p+1 in agreement with the classical result in the literature on the RKDG schemes (see for instance [18]).

Table 2. Parameters for the convergence test.

Parameter

Value

β

3

A 0

2

ν

3 × 102

T

1

L

10

cfl

0.5

Figure 3. Reference solution for the 2D numerical scheme.

Figure 4. Convergence order for the 2D numerical scheme.

4.2. Stationary Solutions

For this test case, the aim is to show that the numerical method captures exactly the still-steady state solutions. We have used the following parameters in Table 3 and the following geometrical parameters:

c( s )=( s, e 1 2 ( s L 2 ) 2 ,0 ) , leading to, t( s )= ( 1,( s L 2 ) e 1 2 ( s L 2 ) 2 ,0 ) 1+ ( s L 2 ) 2 e ( s L 2 ) 2 , and, n( s )= ( 0,( ( s L 2 ) 2 1 ) e 1 2 ( s L 2 ) 2 ,0 ) | ( s L 2 ) 2 1 | e 1 2 ( s L 2 ) 2 =( 0,sign( ( s L 2 ) 2 1 ),0 ) ,

where C( s )= c ( s ) c ( s ) = | ( s L 2 ) 2 1 | e 1 2 ( s L 2 ) 2 1+ ( s L 2 ) 2 e ( s L 2 ) 2 . The initial geometry is represented in Figure 5 and it is defined by A 0 ( x,θ )= 1 2 ( R 0 +( R 1 R 0 ) e 4( x L 2 )2( θπ ) ) 2 . and characterized by β( x,θ )=( E 0 +( E 1 E 0 ) e 4( x L 2 )2( θπ ) ) h 2 2ρ( 1 ξ 2 ) . Starting with a null speed, A= A 0 , as in proved in Theorem 1, in Figure 6, we show that the still-steady state’s solutions are exactly preserved.

Table 3. Physical and Numerical parameters for the 2D stationary test case.

Parameter

Value

Unit

Description

E 0

3 × 106

kg∙cm−1∙s−2

Minimum Young modulus

E 1

3 × 108

kg∙cm−1∙s−2

Maximum Young modulus

h

0.05

cm

Thickness

ρ

1

kg∙cm−3

Density

ξ

0.0

Poisson coefficient

R 0

0.5

cm

Maximum radius

R 1

0.3

cm

Minimum radius

ν

0.03

Cm2∙s−1

Kinematic viscosity

T

0.25

s

Final time

L

15

cm

Artery’s length

cfl

0.5

Cfl

N s

32

Number of elements in the s direction

N θ

32

Number of elements in the θ direction

p

1

Polynomial degree

Figure 5. Artery geometry.

Figure 6. Stationary solutions at t=T .

4.3. Realistic Pressure Wave in a Straight Artery

In this test case, we compare the one-dimensional models 1D inviscid from Equation (3) (solved by a TGS-Taylor Galerkin Scheme, see [6]), 1D viscous from Equation (4) (solved by a DG method, see [26]), and 2D Equation (41) solved by the DG method presented in Section 3.

In Table 4, we give the physical and numerical parameters of the test case, also, we consider, for simplicity, the pressure at r=R to be P=β A A 0 A 0 even in the viscous case in Equation (4). The following parameters are considered: β= Eh π ρ( 1 ξ 2 ) , A 0 =π R 0 2 In the 2D case, these parameters are: β= Eh 2 ρ( 1 ξ 2 ) , A 0 = R 0 2 2 . We use the following curve c( s )=( s,0,0 ) and we choose n=( 0,1,0 ) by setting the curvature C( s )=0 . To simulate a pressure wave entering into the domain, we use the following sinus-wave: P( 0,t )={ P 0 sin( π t T p ) ift T p 0 otherwise . This lead to the following initial and boundary conditions,

A( s,0 )= A 0 Q( s,0 )=0 A( 0,t )= ( A 0 β P( 0,t )+ A 0 ) 2 s Q( 0,t )=0 s A( 15,t )=0 s Q( 15,t )=0

Table 4. Physical and numerical parameters for TC1 (Realistic Pressure Wave in a straight artery).

Parameter

Value

Unit

Description

E

3 × 106

kg∙cm−1∙s−2

Young modulus

h

0.05

cm

Thickness

ρ

1

kg∙cm−3

Density

ξ

0.0

Poisson coefficient

R 0

0.5

cm

Initial radius

ν

0 or 0.03

cm2∙s−1

Kinematic viscosity

T

0.25

s

Final time

L

15

cm

Artery’s length

P 0

2 × 104

kg∙cm−1∙s−2

Entering pressure amplitude

T p

0.165

s

Pressure wave duration

σ

100

penalty parameter

cfl

0.5

Cfl

N

128

Number of elements for the 1D model

N s

128

Number of elements in the s direction

N θ

4

Number of elements in the θ direction

p

2

Polynomial degree

and for the 2D, with P( 0,θ,t )={ P 0 ift T p 0 otherwise , we set

A( s,θ,0 )= A 0 Q θ ( s,θ,0 )=0 Q s ( s,θ,0 )=0 A( 0,θ,t )= ( A 0 β P( 0,θ,t )+ A 0 ) 2 s Q θ ( 0,θ,t )=0 s Q s ( 0,θ,t )=0 s A( 15,θ,t )=0 s Q θ ( 15,θ,t )=0 s Q s ( 15,θ,t )=0.

Periodic conditions are imposed on the direction θ . Figure 7 shows the geometry colored with the axial speed at time t= T 2 . In Figure 8, we compare the pressure obtained using the nonviscous 1D model in Equation (3) with the data obtained from [6]. We also display the axial speed of the blood. We do the same in the viscous case (see Equations (4)) in Figure 9 and in the 2D case (see Equations (41)) in Figure 10. Our numerical results are compared to those in [6] where the TGS (Taylor Galerkin Scheme) is used. As expected, our numerical results (2D and 1D) are in a perfect agreement with those obtained in [6]. The results of the 1D and 2D models are almost identical because of the axisymmetry and curvaturless of the geometry. One can also remark that, in this case, the angular speed of the 2D model is almost zero everywhere (at least zero numerically) as shown in Figure 11. Moreover, one can see throughout this test case that the 1D viscous models provide mildly different numerical solutions compared to the inviscid models (TGS model and our 1D inviscid model).

4.4. Addon of the 2D Model and the Limit of 1D Model in the Case of Aneurysm

In this test case, we compare the one-dimensional models 1D inviscid from Equation (3) and 2D Equation (41) solved by the DG method presented in Section 3 in the case of a mild and a severe aneurysm to show the addon of the 2D model

Figure 7. Artery geometry colored with axial speed at time t= T 2 .

Figure 8. Pressure and Speed for the 1D non-viscous model and comparison with data obtained from [6].

Figure 9. Pressure and Speed for the 1D viscous model and comparison with data obtained from [6].

Figure 10. Pressure and Speed for the 2D model and comparison with data obtained from [6].

Figure 11. Angular Speed for the 2D model.

and the limit of the 1D model. In the medical literature [27], the classification of aneurysm severity depends on the location. For intracranial aneurysms, diameters below 7 mm are usually considered small, 7 - 12 mm medium, 13 - 24 mm large, and above 25 mm giant. For abdominal aortic aneurysms (AAA), diameters above 5.5 cm are typically considered severe and represent a threshold for surgical intervention.

In Table 5, we present the physical and numerical parameters of the test case. We consider, for simplicity, the pressure at r=R to be P=β A A 0 A 0 .

We consider two different geometries mimicking a mild and a severe aneurysm. The initial geometry is given by:

Table 5. Physical and numerical parameters for TC4 (Addon of the 2D model over the 1D model in complex geometry).

Parameter

Value

Unit

Description

E

3 × 106

kg∙cm−1∙s−2

Young modulus

h

0.1

cm

Thickness

ρ

1

kg∙cm−3

Density

ξ

0.0

Poisson coefficient

R 0

0.5

cm

Initial radius

R 1

2.0

cm

Secondary radius

ν

0 or 0.03

cm2∙s−1

Kinematic viscosity

T

0.03

s

Final time

L

10

cm

Artery’s length

P 0

13,332

kg∙cm−1∙s−2

Entering pressure amplitude

T p

0.005

s

Pressure wave duration

σ

1

Penalty parameter

cfl

0.5

Cfl

N

32

Number of elements for the 1D model

N s

32

Number of elements in the s direction

N θ

32

Number of elements in the θ direction

p

2

Polynomial degree

A 0 ( s,θ )= 1 2 ( R 0 +( R 1 R 0 ) e ( s L 2 ) 2 ( e θ 2 + e ( θ2π ) 2 ) ) 2 . The mild aneurysm is defined by R 1 =0.6 and the severe one by R 1 =2 (see Figure 12).

To compare the results issue from the 1D model to the 2D model, we integrate the numerical results from the 2D model over θ . The numerical results are presented in Figure 13 and Figure 14. We show the behavior in time of the pressure, the speed, and the maximum angular speed at the point L 2 . As expected, in the case of a mild aneurysm, since the geometry of the artery is almost cylindrical, the results from the 1D and the 2D models are almost similar (see Figure 13). Whenever the aneurysm is severe, the geometry is no longer almost cylindrical, at least around the aneurysm, and important differences can be observed as shown in Figure 14. This is mainly because the angular speed is not zero in this case and can take large values. The 2D model can in practice compute more realistic solutions than the 1D one. The same observation holds at the control point 3L/4 . After the aneurysm, even if the geometry is cylindrical since the blood passed away a zone where the angular speed was not 0 (see Figure 15 and Figure 16), they are distinguishable difference between the 1D and the 2D models which confirms the limit of the 1D model. The more the amplitude of the maximum angular speed is, the more the difference observed between the 1D and the 2D models is. Note that the 2D model is computationally more demanding than the 1D one. For example, in the case of tableTC4, it requires 32×32× ( 2+1 ) 2 =9216 DDOF per variable, whereas the 1D model only needs 32×( 2+1 )=96 DDOF. Nevertheless, the cost remains far lower than in the 3D case, which would involve 32×32×32× ( 2+1 ) 3 =884736 DDOF for a similar configuration, not to mention the additional mesh adaptation required in 3D.

Figure 12. Initial geometry and Speed for the 2D at t= T 2 .

Figure 13. Pressure, axial speed and maximum angular speed for the 2D and 1D model at the point L 2 for R 1 =0.6 .

5. Conclusion

In conclusion, we have developed a new two-dimensional model for blood flow simulations, for which we implemented a discontinuous Galerkin method. We have determined several mathematical and numerical properties, notably establishing that the scheme we constructed is well-balanced. Furthermore, through various test cases, we demonstrated the robustness of our method. Specifically, we compared 1D models with the 2D model in the context of both severe and

Figure 14. Pressure and Speed for the 2D and 1D model at the point L 2 for R 1 =2 .

Figure 15. Pressure, axial speed and maximum angular speed for the 2D and 1D model at the point 3L 4 for R 1 =0.6 .

Figure 16. Pressure, axial speed and maximum angular speed for the 2D and 1D model at the point 3L 4 for R 1 =2 .

mild aneurysms. This test case highlighted the limitations of 1D models. Beyond these achievements, the proposed model has potential clinical relevance, particularly for improving the understanding of blood flow in pathological situations such as aneurysms or stenoses. Future work will focus on validating the model against experimental or clinical data, which is essential to assess its predictive capabilities. In addition, coupling this approach with patient-specific geometries could make the model a valuable tool for surgical planning or for evaluating treatment strategies. Further research will also aim at extending the framework to more complex arterial wall models and at investigating the role of hyperelasticity in aneurysm growth and rupture.

Acknowledgements

This work has been supported by the ADEN-MED project (Adaptability to Extreme events and Natural risks -application to the Mediterranean and Djibouti), funded by the Région Sud Provence-Alpes-Côte d’Azur under the AAP MEDCLIMAT “Natural risks and food sovereignty”?

NOTES

1https://julialang.org/.

Conflicts of Interest

The authors declare no conflicts of interest regarding the publication of this paper.

References

[1] Formaggia, L., Nobile, F. and Quarteroni, A. (2002) A One-Dimensional Model for Blood Flow: Application to Vascular Prosthesis. Mathematical Modeling and Numerical Simulation in Continuum Mechanics: Proceedings of the International Symposium on Mathematical Modeling and Numerical Simulation in Continuum Mechanics, Yamaguchi, 29 September-3 October 2000, 137-153.[CrossRef
[2] Formaggia, L., Gerbeau, J.F., Nobile, F. and Quarteroni, A. (2001) On the Coupling of 3D and 1D Navier-Stokes Equations for Flow Problems in Compliant Vessels. Computer Methods in Applied Mechanics and Engineering, 191, 561-582.[CrossRef
[3] Čanić, S. and Kim, E.H. (2003) Mathematical Analysis of the Quasilinear Effects in a Hyperbolic Model Blood Flow through Compliant Axi‐Symmetric Vessels. Mathematical Methods in the Applied Sciences, 26, 1161-1186.[CrossRef
[4] Čanić, S. (2002) Blood Flow through Compliant Vessels after Endovascular Repair: Wall Deformations Induced by the Discontinuous Wall Properties. Computing and Visualization in Science, 4, 147-155.[CrossRef
[5] Berntsson, F., Ghosh, A., Kozlov, V.A. and Nazarov, S.A. (2018) A One-Dimensional Model of Blood Flow through a Curvilinear Artery. Applied Mathematical Modelling, 63, 633-643.[CrossRef
[6] Quarteroni, A. and Formaggia, L. (2004) Mathematical Modelling and Numerical Simulation of the Cardiovascular System. In: Handbook of Numerical Analysis, Elsevier, 3-127.[CrossRef
[7] Ventre, J. (2020) Reduced-Order Models for Blood Flow in the Large Arteries: Applications to Cardiovascular Pathologies. PhD Thesis, Sorbonne Université.
[8] Krivovichev, G.V. (2022) Computational Analysis of One-Dimensional Models for Simulation of Blood Flow in Vascular Networks. Journal of Computational Science, 62, Article ID: 101705.[CrossRef
[9] Azer, K. and Peskin, C.S. (2007) A One-Dimensional Model of Blood Flow in Arteries with Friction and Convection Based on the Womersley Velocity Profile. Cardiovascular Engineering, 7, 51-73.[CrossRef] [PubMed]
[10] Nardinocchi, P., Pontrelli, G. and Teresi, L. (2005) A One-Dimensional Model for Blood Flow in Prestressed Vessels. European Journal of MechanicsA/Solids, 24, 23-33.[CrossRef
[11] Huo, Y. and Kassab, G.S. (2007) A Hybrid One-Dimensional/Womersley Model of Pulsatile Blood Flow in the Entire Coronary Arterial Tree. American Journal of PhysiologyHeart and Circulatory Physiology, 292, H2623-H2633.[CrossRef] [PubMed]
[12] Fung, Y.-C. (2013) Biomechanics: Mechanical Properties of Living Tissues. Springer Science & Business Media.
[13] Ersoy, M. (2015) Dimension Reduction for Incompressible Pipe and Open Channel Flow Including Friction. Conference Applications of Mathematics 2015, in Honor of the 90th Birthday of Ivo Babuška and 85th Birthday of Milan Práger and Emil Vitásek, Prague, November 2015, 17-33.
[14] Ersoy, M., Lakkis, O. and Townsend, P. (2020) A Saint-Venant Model for Overland Flows with Precipitation and Recharge. Mathematical and Computational Applications, 26, Article No. 1.[CrossRef
[15] Gerbeau, J. and Perthame, B. (2001) Derivation of Viscous Saint-Venant System for Laminar Shallow Water; Numerical Validation. Discrete & Continuous Dynamical SystemsB, 1, 89-102.[CrossRef
[16] Ersoy, M. (2016) Dimension Reduction for Compressible Pipe Flows Including Friction. Asymptotic Analysis, 98, 237-255.[CrossRef
[17] Grinberg, L., Cheever, E., Anor, T., Madsen, J.R. and Karniadakis, G.E. (2010) Modeling Blood Flow Circulation in Intracranial Arterial Networks: A Comparative 3D/1D Simulation Study. Annals of Biomedical Engineering, 39, 297-309.[CrossRef] [PubMed]
[18] Cockburn, B. (2003) Discontinuous Galerkin Methods. ZAMMJournal of Applied Mathematics and Mechanics, 83, 731-754.[CrossRef
[19] Debyaoui, M.A. and Ersoy, M. (2021) A Generalised Serre-Green-Naghdi Equations for Variable Rectangular Open Channel Hydraulics and Its Finite Volume Approximation. In: Muñoz-Ruiz, M.L., et al., Eds., Recent Advances in Numerical Methods for Hyperbolic PDE Systems: NumHyp 2019, Springer International Publishing, 251-268.[CrossRef
[20] Poussel, C. (2024) Dynamics of Free-Surface and Groundwater Flows in Sandy Beaches. PhD Thesis, Université de Toulon.
[21] Poussel, C., Ersoy, M., Golay, F. and Mannes, Y. (2023) Runge-Kutta Discontinuous Galerkin Method Applied to Shallow Water Equations. In: Topical Problems of Fluid Mechanics 2023, Institute of Thermomechanics of the Czech Academy of Sciences, 152-159.
[22] Clément, J.-B. (2021) Numerical Simulation of Flows in Unsaturated Porous Media by an Adaptive Discontinuous Galerkin Method: Application to Sandy Beaches. PhD Thesis, Université de Toulon.
[23] Butcher, J.C. (1996) A History of Runge-Kutta Methods. Applied Numerical Mathematics, 20, 247-260.[CrossRef
[24] Cockburn, B. and Shu, C. (2001) Runge-Kutta Discontinuous Galerkin Methods for Convection-Dominated Problems. Journal of Scientific Computing, 16, 173-261.[CrossRef
[25] Gottlieb, S., Ketcheson, D.I. and Shu, C. (2008) High Order Strong Stability Preserving Time Discretizations. Journal of Scientific Computing, 38, 251-289.[CrossRef
[26] Mannes, Y., Ersoy, M., Eker, Ö.F. and Ajroud, A. (2025) On the Derivation of a New One-Dimensional Model for Blood Flows and Its Numerical Approximation. Journal of Applied Mathematics and Physics, 13, 3479-3514.[CrossRef
[27] Merritt, W.C., Berns, H.F., Ducruet, A.F. and Becker, T.A. (2021) Definitions of Intracranial Aneurysm Size and Morphology: A Call for Standardization. Surgical Neurology International, 12, Article No. 506.[CrossRef] [PubMed]

Copyright © 2025 by authors and Scientific Research Publishing Inc.

Creative Commons License

This work and the related PDF file are licensed under a Creative Commons Attribution 4.0 International License.