• Keine Ergebnisse gefunden

Discretization

We use a discontinuous Galerkin (dG) discretization in space. This is motivated by the stability of this scheme for the advection dominated equation in the fluid domain as ε→ 0, but the use of discontinuous elements also allows the use a single dG function to represent both lumen and wall concentrations.

Furthermore, the interface condition can be easily formulated in the framework of dG jumps and averages, allowing a simple implementation in existing dG code. We refer to [DE12] for an exhaustive introduction into discontinuous Galerkin methods. A similar dG discretization is analyzed in [CGJ13;CGJ16]

with nonlinear coupling conditions. A conforming finite element discretization of a similar equation is analyzed in [QVZ02b] using domain decomposition methods to solve fluid and structure problems separately.

For simplicity we assume that Ωf and Ωs are polygonal domains using a linear interpolation of the continuous deformation field for the interface, even though e.g. isoparametric approaches would be better suited for the curved ge-ometry [BS08]. LetΩh,f be a triangulation ofΩf in the sense thatΩh,f consists of disjoint, open, non-degenerate simplices K h,f with S

Kh,fK = Ωf

and no vertex of any simplex lies in the interior of an edge of another sim-plex. SimilarlyΩh,s denotes a triangulation ofΩsandΩh:= Ωh,f h,s. The triangulations are assumed to match at the permeable interfaceΓ.

We denote the set of all edgese⊂∂K of allK h,f byEh,f and define analogously Eh,s and write Eh for the set of edges in both Eh,f and Eh,s. Edges shared by both Eh,f and Eh,s but not lying on the permeable part of the interface are assumed to be distinct in the sense of a disjoint union. We assume that any edge on the domain boundaries∂Ωf and∂Ωs lies entirely in

if, of, wf, ∂Ωs\Γ or Γ. We writeEhint for the set of interior edges which excludes, by convention, interface edges which we denote by EhΓ. The exterior edges are denoted by Ehext := Eh\(Ehint∪EhΓ) and subdivided into inflow edgesEh,fin :={e∈Eh,f |e⊂∂if}and Neumann-type boundary edges Eh,fN :={e∈Eh,f |e⊂∂of ∪∂wf}. The set of exterior boundary edges of Eh,sis denoted byEh,sN :={e∈Eh,s|e⊂∂Ωs\Γ}. We writeENh :=Eh,fN ∪Eh,sN for the set of all Neumann-type boundary edges. Exterior edges may lie on (∂Ωf∩∂Ωs)\Γ but are, by the disjoint union construction mentioned above, assumed to be adjacent only to one element. For every interior or interface edge e∈Einth ∪EΓh we choose an orientation by denoting the two elements sharing that edge byK+andKhwith outward normal unit vectorsn:=n+ and n, respectively. For exterior edges, n+ is the outward normal unit vector.

We write

Ch:={ch: ΩhR|ch|K P1(K) ∀K∈h}

for the space of dG functions of first order. As common for discontinuous Galerkin methods we define average and jump of a dG function chCh over edges. We writec+h andch for the continuous extension ofch|K+, respectively ch|K, toe. Jump and average ofch overeare then defined by

JchK:=c+hn++chn, {ch}:= 1

2 c+h +ch

one∈Ehint∪EhΓ

for interior and interface edges. For exterior edges we define

JchK:=chn+, {ch}:=ch one∈Ehext.

The gradient of a dG function is not defined over the whole domain, but we use the notationhchfor the broken gradient defined as theL2function satisfying

hch|K := (ch|K) for eachK h. For vector-valued dG functions, such as hch, the definition of jump and average are analogous, using the scalar product with the normal vector for the definition of the jump.

With the notation for jumps and averages the condition on the permeable interface can be formulated as

Jε∇cεK= 0, {ε∇cε}+εξJcεK= 0 onΓ. (6.61)

The discretization of the advection-diffusion equation in Ωf is standard with a symmetric interior penalty Galerkin method and upwinding for the advective term, see [DE12] for an introduction to these methods. A symmetric interior penalty method is also employed for the diffusion-reaction equation in Ωs. Using the representation from eqs. (6.61)of the interface condition it can be checked by a lengthy but elementary calculation that the following equation for the discrete solutionch,εCh is consistent:

Z

ε∇hch,ε· ∇hϕhdx Z

f

ch,εvf· ∇hϕhdx+ Z

s

ε ch,εϕhdx

X

eEhintEinh,f

Z

e

{ε∇hch,ε}JϕhK+Jch,εK· {ε∇hϕh} −εη

heJch,εK·JϕhKdo

+ X

eEh,f\(EhΓEinh,f)

Z

e

{ch,ε}vf·JϕhK+12|vf·n+|Jch,εK·JϕhKdo

+ X

eEhΓ

Z

e

εξJch,εK·JϕhKdo

= X

eEinh,f

Z

e

−cinfε∇ϕ·n+−vf·n+cinfϕ+ηε

hecinfϕdo

for all ϕh Ch where η > 0 is a penalty parameter andhe :=diam(e). The inflow boundary condition is only enforced weakly. We refer to [CGJ13;CGJ16]

for theoretical results for a dG discretization of a similar nonlinear problem.

The discretization for the limit system is very similar, given as solution

ch,0Ch to

for all ϕhCh. Apart from the obvious changes due to the missing diffusion in Ωf in the limit problem, note that the interface term only contains the test functionϕh,s from the structure domain. The solution onΩh,f is in particular decoupled fromΩh,s, allowing a more efficient numerical solution.

For the instationary problem an implicit Euler discretization was chosen for both theεand limit system for simplicity. An adaptive step size control as discussed in [HV03] with fixed minimal step size was implemented to reduce the cost after the transient initial phase. We remark that while κ denoted the macro step size in Chapter 5we will keep our notation from the previous theoretical results and refer to the macro step size by name.

The following numerical calculations were carried out using EniCS v2018.1 [Aln+15;LWH12;Log+12;Aln+14;Kir04;ALM12].

Numerical Test Case

To observe the effect of increasing stenosis on the quality of the approximation ofcεbyc0we will use a family of 2D fluid domains as defined inChapter 5, with complementary structure domains, with a growth parameter q ∈Q := [0,1).

No growth actually occurs, so qis a fixed parameter.

Forq= 0both fluid and structure domains are rectangular and given by Ω0,f := (L2,L2)×(0,1), Ω0,s:= (L2,L2)×(0.3,0)

with L:= 5. For q∈Qwe define Ωq,f and Ωq,s through a transformation of those rectangular domains, just as in Chapter 4 and Chapter 5. Let η be a bump function as inExample 4.1.2, i.e.

η(s) :=

3.7e-6 1.2e-4

1e-5

Figure 6.2: Area of triangles for a discretization of Ωq,f q,s for q = 0.3.

Logarithmic color scale.

with plaque length L0 := 3.5. Φq is a linear interpolation in y between the fixed boundaryy= 1inΩ0,f, respectivelyy=0.3inΩ0,s, and the graph of a bump-shaped function at the interfacey= 0. Then define fluid and structure domains by

q,f := Φq(Ω0,f), Ωq,s:= Φq(Ω0,s).

Note thatΩf,qcorresponds toΩqas defined inChapter 5. In the following there will always hold Ωf = Ωq,f and Ωs = Ωq,s for some q Q. The boundaries are just as shown inFigure 6.1at the beginning of this section with permeable interfaceΓ0:= (L20,L20)×{0}spanning the whole section which gets deformed andΓq:= Φq0).

Forq= 0we will use the Poiseuille-like flow fields v0(x, y) =v0(yκ(1−y)κ,0)T in Ω0,f

with κ N0 as advection velocity, v = v0. Such velocity fields were found in Example 6.2.14 to satisfy Assumption 6.2.12 such that our theory with vanishing velocities is applicable. The advection field forq∈Qisv=vq where vq is the inverse Piola transformation ofv0fromeq. (4.5), preserving the vector field’s solenoidality and vanishing behavior near the interface, i.e.

vq(x, y) := (Pq1v0)(x, y) in Ωq,f.

Following the model by Yang et. al. we assume thatcinf 1. As a conse-quence the fluid concentration in the limit solution is known a priori,c0,f 1, such that only the structure concentrationc0,s must be determined.

For the instationary problem we setc0ε,s :=c0s := 0. On the fluid domain we set either c0ε,f := 0 or c0ε,f := 1 to investigate the occurrence of boundary layers if the initial value and c0,f disagrees, as predicted inTheorem 6.3.5.

The computational meshes were generated by triangulating the fluid and structure domains, delimited by the exterior boundaries and∂Ωq,f∩∂Ωq,susing Gmsh [GR09]. The triangulation was manually refined around the interface to better resolve the boundary layer. This meshing approach guarantees an even triangulation in both subdomains, in contrast to the method from Chapter 5 where a (structured) reference mesh forq= 0was deformed byΦq. We present results for q ∈ {0,0.3,0.6} with similar observed behavior for other values of q. The size of mesh elements forq= 0.3 is displayed inFigure 6.2. This mesh consisted of 438 390 degrees of freedom, 280 566 in the fluid and 157 824 in the structure domain, the other meshes had a similar total number of degrees of freedom with decomposition in fluid and structure nodes depending onq.

Results for the Stationary Problem

Figure 6.3shows the solutioncεof the stationary problem forq= 0andκ= 0.

Forκ∈ {0, . . . ,3} the error between cε andc0 is in good agreement with the theoretical results fromTheorem 6.2.11forκ= 0andTheorem 6.2.17forκ >0 as evident fromFigure 6.4, noting that sincec0,f 1the improved estimates from ineqs. (6.9), respectively ineqs. (6.25), hold. In Figure 6.4 and in the following k · k2H1

0(Ωf) = k∇ · k2L2(Ωf). The numerical order of convergence is directly compared to the theoretical predictions inFigure 6.4(b), showing only slight under-estimation of the predicted order of convergence for the L2(Ωf) error for largeκ.

For stenosed domains with q > 0 similar good agreement with the theo-retical results was found, cf. Figure 6.6. Only for κ = 0 the H01(Ωf) errors deviate from the predicted results, presumably due to numerical errors tangen-tial to the permeable interface, most pronounced at the beginning and end of the bump as shown in Figure 6.7. For κ = 0 the simulation was in general most sensitive to the mesh refinement and quality near the interface, which is unsurprising given that the advection is affecting the fluid concentration near the interface with full force forκ= 0, an unrealistic configuration. Note that it is not apparent that the discrete solution possesses the sameH01(Ωf)stability as the continuous solution, which rested onAssumption 6.2.2.

Results for the Instationary Problem

As mentioned above we use an implicit Euler discretization for the temporal discretization of both εand limit system on a time interval ofI = (0,T)with T = 1. A step size control is employed to reduce the cost after the initial transient phase, with a minimal macro step size of 0.1·ε. For simplicity of implementation the step size control is only employed for theεsystem and the solution of the limit equation which is compared to this solution employs the same temporal discretization. This is not considered a problem since the step size for the pure diffusion problem onΩsin the limit equation is not a bottleneck for the accuracy. Figure 6.8 shows the step sizes used for our computation.

The spatial discretization, including the underlying mesh, is identical to the stationary problem but only the domain with q= 0is investigated.

InFigure 6.9the error for the instationary problem withκ= 0andc0ε,f = 0, i.e. an initial value not satisfying the stronger condition from ineq. (6.43), is plotted in various space-time norms to test the results from Theorem 6.3.5.

These numerical results for the fully discrete equation mostly agree with the predictions from Theorem 6.3.5, with the exception that the L2(I, H01(Ωf)) error is of order ε1/4 even though the boundary layer is included, instead of ε0 as predicted. Furthermore, the order of convergence for the norms inΩs is with approximatelyε0.58 slightly better than the predictedε1/2.

The boundary layer estimates require knowledge ofτ0 which by eq. (6.42) depends on an unknown constant µ0. The boundary layer behavior for the L2(Ωf) norm for κ = 0 and c0ε,f 1 is depicted in Figure 6.10, making it apparent that for ε = 0.1 the boundary layer with transient behavior spans across the whole time interval. We set µ0 = 1/8 such that τ0 ≈ −2εlnε, omittingη, lies behind the transient phase forε <0.1.

1.0

Figure 6.3: Solution cε of the stationary problem for κ = 0 and multiple values ofq andε.

1e-04 1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2f) H10f) H1s)

ε3/4 ε1/4 ε1/2

(a) Errors forκ= 0.

1e-04 1e-03 1e-02 1e-01 1e+00

1e-05 1e-03 1e-01

cε - c0

ε κ = 1

ε3/6 ε1/6 ε1/3

1e-05 1e-03 1e-01

ε κ = 2

ε3/8 ε1/8 ε1/4

1e-05 1e-03 1e-01 ε

κ = 3

ε3/10 ε1/10 ε1/5

(b) Errors forκ∈ {1,2,3}. Solid lines with the same meaning as in (a).

Figure 6.4: Error between the numerical approximations ofcεandc0for the stationary problem on Ωq for q = 0 for different norms with κ= 0, . . . ,3. The dashed lines show the predicted convergence rates fromineqs. (6.9)in Theorem 6.2.11.

0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8

0 1 2 3

order

κ order of L2f) error order of H10f) error order of H1s) error

3/(4+2κ) 1/(4+2κ) 1/(2+κ)

Figure 6.5: Numerically determined order of convergence inεfromFigure 6.4 for q = 0and different values of κin comparison with the pre-dicted orders fromTheorem 6.2.17.

Figure 6.11 complements Figure 6.9 by showing the errors from Theo-rem 6.3.5 which exclude the boundary layer, with τ0 as specified above. In contrast to the theoretical predictions theL(I0, L2(Ωf))error is of the same order ε3/4 as the L2(I0, L2(Ωf)) error, which itself is improved compared to ε1/2forL2(I, L2(Ωf)), cf.Figure 6.9, as predicted by the theory. The exclusion of the boundary layer does not change the convergence for the H01(Ωf)error, which was already better than expected inFigure 6.9, as remarked above, but has the predicted order if the boundary layer is excluded. As mentioned in the discussion of Figure 6.10 the behavior of the error at ε = 0.1 should be ignored. Another choice ofµ0 did not improve the convergence but the results deteriorate asµ0→ ∞to those on the whole intervalI, as expected.

For the initial value c0ε,f 1, which is a plausible choice in the model by Yang et. al., no boundary layer appears as predicted by the theory, cf.

Figure 6.12. The convergence behavior is as predicted in Theorem 6.3.5 with the exception of the error in L(I, L2(Ωf)) which is of order ε3/4 just as observed for c0ε,f 0. As expected the exclusion of a boundary layer in the error norms does not improve the convergence in this case (not pictured).

Forκ= 1 the discrepancies between numerical and theoretical results in-crease. As Figure 6.13(a) shows the error in L2(I, L2(Ωf)) converges with rate ε0.47 instead of ε1/3 as predicted inTheorem 6.3.5, which is close to the order of convergence ε3/6 =ε1/2 predicted if the boundary layer is excluded, while the error in L2(I, H01(Ωf)) again behaves as predicted by our theory if the boundary layer is excluded. The convergence for the errors inΩs is again slightly better than predicted with ε0.41 compared to ε1/3. If the boundary layer is excluded, Figure 6.13(b), the behavior is very similar to κ= 0, with good agreement with the theoretical results except for theL(I0, L2(Ωf)) er-ror which converges with the same rate as the temporalL2error. Similar mixed agreement with the theoretical results was observed forκ >1.

1e-04

Figure 6.6: Error between cε and c0 for the stationary problem for q {0.3,0.6} andκ∈ {0,1,2}. Compare withFigure 6.4forq= 0.

6e-7 magnifica-tion of the error near the permeable interface. Colored by error magnitude in logarithmic scale.

Figure 6.8: Macro step size used for our multiscale convergence computa-tions, as determined from the step size control.

1e-04 1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2(𝓘, L2f)) L(𝓘, L2f)) L2(𝓘, H10f)) L(𝓘, L2s)) L2(𝓘, H1s))

ε1/2

ε1/4 ε0.58

Figure 6.9: Error betweencεandc0 for the instationary problem withκ= 0 and c0ε,f 0 for various norms including the boundary layer, together with some convergence orders.

1e-04 1e-03 1e-02 1e-01 1e+00 1e+01

1e-06 1e-05 0.0001 0.001 0.01 0.1 1

cε(τ) - c0(τ) f

τ

ε = 1e-01

ε = 1e-02 ε = 1e-03 ε = 1e-04 ε = 1e-05 τ0,1e-01

τ0,1e-01 τ0,1e-02 τ0,1e-02 τ0,1e-03

τ0,1e-03 τ0,1e-04

τ0,1e-04 τ0,1e-05

τ0,1e-05

Figure 6.10: Pointwise-in-time error betweencε and c0 for the instationary problem withκ = 0 and c0ε,f 0 for the L2(Ωf) norm. The boundary layer timeτ0 withµ0:= 1/8for eachεis also plotted (dashed lines).

1e-04 1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2(𝓘0, L2f)) L(𝓘0, L2f)) L2(𝓘0, H10f))

ε3/4 ε1/4

Figure 6.11: Error betweencεandc0for the instationary problem withκ= 0 andc0ε,f 0for various norms excluding the boundary layer for τ0 as depicted in Figure 6.10, together with some convergence orders.

1e-04 1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2(𝓘, L2f)) L(𝓘, L2f)) L2(𝓘, H10f)) L(𝓘, L2s)) L2(𝓘, H1s))

ε3/4

ε1/4 ε1/2

Figure 6.12: Error betweencεandc0for the instationary problem withκ= 0 andc0ε,f 1for various norms, together with some convergence orders.

1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2(𝓘, L2f)) L(𝓘, L2f)) L2(𝓘, H10f)) L(𝓘, L2s)) L2(𝓘, H1s))

ε0.47

ε1/6 ε0.41

(a) Errors including the boundary layer.

1e-03 1e-02 1e-01 1e+00

1e-05 1e-04 1e-03 1e-02 1e-01

cε - c0

ε

L2(𝓘0, L2f)) L(𝓘0, L2f)) L2(𝓘0, H10f))

ε3/6 ε1/6

(b) Errors excluding the boundary layer.

Figure 6.13: Error betweencε andc0 for the instationary problem with q= 0, κ = 1 and c0ε,f 0 for various norms, together with some convergence orders.

[AV05] L. Ai and K. Vafai. “An Investigation of Stokes’ Second Prob-lem for Non-Newtonian Fluids”. In: Numerical Heat Transfer;

Part A: Applications 47.10 (2005), pp. 955–980. doi: 10.1080/

10407780590926390.

[AV06] L. Ai and K. Vafai. “A coupling model for macromolecule transport in a stenosed arterial wall”. In:International Journal of Heat and Mass Transfer 49.9-10 (2006), pp. 1568–1591. doi: 10.1016/j.

ijheatmasstransfer.2005.10.041.

[Aln+15] M. S. Alnæs, J. Blechta, J. Hake, A. Johansson, B. Kehlet, A.

Logg, C. Richardson, J. Ring, M. E. Rognes, and G. N. Wells. “The FEniCS Project Version 1.5”. In: Archive of Numerical Software 3.100 (2015).doi:10.11588/ans.2015.100.20553.

[ALM12] M. S. Alnæs, A. Logg, and K.-A. Mardal. “UFC: a Finite Ele-ment Code Generation Interface”. In:Automated Solution of Dif-ferential Equations by the Finite Element Method. Ed. by A. Logg, K.-A. Mardal, and G. N. Wells. Berlin, Heidelberg: Springer, 2012.

Chap. 16.doi: 10.1007/978-3-642-23099-8_16.

[Aln+14] M. S. Alnæs, A. Logg, K. B. Ølgaard, M. E. Rognes, and G. N. Wells. “Unified Form Language: A domain-specific lan-guage for weak formulations of partial differential equations”. In:

ACM Transactions on Mathematical Software 40.2 (2014). doi:

10.1145/2566630.

[Alz+18] G. Alzetta, D. Arndt, W. Bangerth, V. Boddu, B. Brands, D.

Davydov, R. Gassmöller, T. Heister, L. Heltai, K. Kormann, M.

Kronbichler, M. Maier, J.-P. Pelteret, B. Turcksin, and D. Wells.

“The deal.II library, Version 9.0”. In:Journal of Numerical Mathe-matics 26.4 (2018), pp. 173–183.doi:10.1515/jnma-2018-0054.

[AW12] D. M. Ambrose and J. Wilkening. “Computing Time-periodic So-lutions of Nonlinear Systems of Partial Differential Equations”. In:

Proceedings of Hyperbolic Problems: Theory, Numerics, and Ap-plications. Beijing, China, 2010. Ed. by T. Li and S. Jiang. Sin-gapore: World Scientific / Higher Education Press, 2012, pp. 273–

280.doi:10.1142/9789814417099_0022.

[AM02] D. Ambrosi and F. Mollica. “On the mechanics of a growing tumor”. In: International Journal of Engineering Science 40.12 (2002), pp. 1297–1316.doi:10.1016/S0020-7225(02)00014-9.

175

[Arb+16] G. Arbia, I. E. Vignon-Clementel, T. Y. Hsia, and J. F. Gerbeau.

“Modified Navier–Stokes equations for the outflow boundary con-ditions in hemodynamics”. In: European Journal of Mechanics, B/Fluids60 (2016), pp. 175–188. doi:10.1016/j.euromechflu.

2016.06.001.

[ADF17] W. Arendt, D. Dier, and S. Fackler. “J. L. Lions’ problem on max-imal regularity”. In:Archiv der Mathematik 109.1 (2017), pp. 59–

72.doi: 10.1007/s00013-017-1031-6.

[Art07] Z. Artstein. “Averaging of time-varying differential equations revisited”. In: Journal of Differential Equations 243.2 (2007), pp. 146–167.doi:10.1016/j.jde.2007.01.022.

[AH13] P. Assemat and K. Hourigan. “Evolution and rupture of vulnerable plaques: a review of mechanical effects”. In:ChronoPhysiology and Therapy 3 (2013), pp. 23–40.doi: 10.2147/CPT.S32050.

[AFM17] L. Athanasiou, D. Fotiadis, and L. Michalis.Atherosclerotic Plaque Characterization Methods Based on Coronary Imaging. London:

Academic Press, 2017, p. 234.

[AN19] N. A. Avgerinos and P. Neofytou. “Mathematical Modelling and Simulation of Atherosclerosis Formation and Progress: A Review”.

In:Annals of Biomedical Engineering47.8 (2019), pp. 1764–1785.

doi:10.1007/s10439-019-02268-3.

[AM09] B. Ayuso and L. D. Marini. “Discontinuous Galerkin Methods for Advection-Diffusion-Reaction Problems”. In:SIAM Journal on Numerical Analysis 47.2 (2009), pp. 1391–1420. doi: 10 . 1137 / 080719583.

[BV92] A. V. Babin and M. I. Vishik.Attractors of Evolution Equations.

Vol. 25. Studies in Mathematics and Its Applications. Amsterdam:

North-Holland, 1992, p. 531.

[BQQ09] S. Badia, A. Quaini, and A. Quarteroni. “Coupling Biot and Navier-Stokes equations for modelling fluid-poroelastic media in-teraction”. In: Journal of Computational Physics 228.21 (2009), pp. 7986–8014.doi: 10.1016/j.jcp.2009.07.019.

[Bal+] S. Balay, S. Abhyankar, M. Adams, J. Brown, P. Brune, K.

Buschelman, L. Dalcin, A. Dener, V. Eijkhout, W. Gropp, D.

Karpeyev, D. Kaushik, M. Knepley, D. May, L. C. McInnes, R. T. Mills, T. Munson, K. Rupp, P. Sanan, B. Smith, S.

Zampini, H. Zhang, and H. Zhang. PETSc Web page. url:

https://www.mcs.anl.gov/petsc.

[Bel+09] J. Bell, C. Breward, T. Chou, P. W. Fok, J. M. Haugh, Q. Li, M. Nowwar, L. Rossi, A. Walter, X. Yang, A. Zemlyanova, and N.

Zhang.Mathematical models for vulnerable plaques : MPI Work-shop Delaware 2009. Tech. rep. 2009, pp. 1–9.

[Ben14] M. Beneš. “A note on regularity and uniqueness of natural convec-tion with effects of viscous dissipaconvec-tion in 3D open channels”. In:

Zeitschrift fur Angewandte Mathematik und Physik 65.5 (2014), pp. 961–975.doi:10.1007/s00033-013-0373-6.

[BK16] M. Beneš and P. Kučera. “Solutions to the Navier-Stokes equations with mixed boundary conditions in two-dimensional bounded do-mains”. In: Mathematische Nachrichten 289.2-3 (2016), pp. 194–

212.doi:10.1002/mana.201400046.

[Ben+14] J. F. Bentzon, F. Otsuka, R. Virmani, and E. Falk. “Mechanisms of plaque formation and rupture”. In:Circulation Research114.12 (2014), pp. 1852–1866.doi:10.1161/CIRCRESAHA.114.302721.

[Ber+18] C. Bertoglio, A. Caiazzo, Y. Bazilevs, M. Braack, M. Esmaily, V.

Gravemeier, A. L. Marsden, O. Pironneau, I. E. Vignon-Clementel, and W. A. Wall. “Benchmark problems for numerical treatment of backflow at open boundaries”. In: International Journal for Numerical Methods in Biomedical Engineering 34.2 (2018). doi:

10.1002/cnm.2918.

[Blu+08] D. Bluestein, Y. Alemu, I. Avrahami, M. Gharib, K. Dumont, J. J.

Ricotta, and S. Einav. “Influence of microcalcifications on vulner-able plaque mechanics using FSI modeling”. In:Journal of Biome-chanics 41.5 (2008), pp. 1111–1118. doi: 10.1016/j.jbiomech.

2007.11.029.

[BM14] M. Braack and P. B. Mucha. “Directional Do-Nothing Condition for the Navier-Stokes Equations”. In: Journal of Computational Mathematics32.5 (2014), pp. 507–521. doi: 10.4208/jcm.1405-m4347.

[BS08] S. C. Brenner and L. R. Scott.The Mathematical Theory of Finite Element Methods. 3rd ed. Vol. 15. Texts in Applied Mathematics.

New York: Springer, 2008, p. 398. doi: 10 . 1007 / 978 0 387 -75934-0.

[Buk+15] M. Bukac, I. Yotov, R. Zakerzadeh, and P. Zunino. “Effects of Poroelasticity on Fluid-Structure Interaction in Arteries: a Com-putational Sensitivity Study”. In:Modeling the Heart and the Cir-culatory System. Ed. by A. Quarteroni. Vol. 14. MS&A. Cham:

Springer, 2015. Chap. 8, pp. 197–220.doi: 10.1007/978-3-319-05230-4_8.

[BD12] M. A. K. Bulelzai and J. L. A. Dubbeldam. “Long time evolution of atherosclerotic plaques”. In:Journal of Theoretical Biology297 (2012), pp. 1–10.doi:10.1016/j.jtbi.2011.11.023.

[CZ06] F. Calabrò and P. Zunino. “Analysis of parabolic problems on partitioned domains with nonlinear conditions at the interface.

Application to mass transfer through semi-permeable membranes”.

In: Mathematical Models and Methods in Applied Sciences 16.4 (2006), pp. 479–501.doi:10.1142/S0218202506001236.

[Cal+09] V. Calvez, A. Ebde, N. Meunier, and A. Raoult. “Mathematical modelling of the atherosclerotic plaque formation”. In: ESAIM:

Proceedings28 (2009). Ed. by M. Ismail, B. Maury, and J.-F. Ger-beau, pp. 1–12.doi:10.1051/proc/2009036.

[CGJ13] A. Cangiani, E. H. Georgoulis, and M. Jensen. “Discontinuous Galerkin Methods for Mass Transfer through Semipermeable Membranes”. In: SIAM Journal on Numerical Analysis 51.5 (2013), pp. 2911–2934.doi:10.1137/120890429.

[CGJ16] A. Cangiani, E. H. Georgoulis, and M. Jensen. “Discontinuous Galerkin methods for fast reactive mass transfer through semi-permeable membranes”. In: Applied Numerical Mathematics 104 (2016), pp. 3–14.doi:10.1016/j.apnum.2014.06.007.

[CW14] L. Cardoso and S. Weinbaum. “Changing Views of the Biome-chanics of Vulnerable Plaque Rupture: A Review”. In: Annals of Biomedical Engineering 42.2 (2014), pp. 415–431.doi: 10.1007/

s10439-013-0855-x.

[CLR13] A. N. Carvalho, J. A. Langa, and J. C. Robinson. Attractors for infinite-dimensional non-autonomous dynamical systems. Vol. 182.

Applied Mathematical Sciences. New York: Springer, 2013, p. 412.

Applied Mathematical Sciences. New York: Springer, 2013, p. 412.