A CONSERVATIVE, SECOND ORDER, UNCONDITIONALLY STABLE ARTIFICIAL COMPRESSION METHOD

Size: px
Start display at page:

Download "A CONSERVATIVE, SECOND ORDER, UNCONDITIONALLY STABLE ARTIFICIAL COMPRESSION METHOD"

Transcription

1 A CONSERVATIVE, SECOND ORDER, UNCONDITIONALLY STABLE ARTIFICIAL COMPRESSION METHOD VICTOR DECARIA, WILLIAM LAYTON AND MICHAEL MCLAUGHLIN Abstract. This report presents a new artificial compression method for incompressible, viscous flows. The method has second order consistency error and is unconditionally, long time, energy stable for the velocity and, weighted by the timestep, for the pressure. It uncouples the pressure and velocity and requires no artificial pressure boundary conditions. When the viscosity ν = 0 the method also exactly conseves a system energy. The method is based on a Crank-Nicolson Leapfrog time discretization of the slightly compressible model (1 ε 1 grad div)u t + u u + 1 (div u)u ν u + p = f and ε p t + div u = 0. This report presents the method, gives a stability analysis, presents numerical tests and gives a preliminary analysis with tests of the non-physical acoustic waves generated. Consideration of the physical fidelity of the artificial compression method leads to a related method. Key words. artificial compression, Crank-Nicolson, Leapfrog 1. Introduction. Consider the time dependent incompressible Navier-Stokes equations in a d or 3d domain Ω for the fluid velocity and pressure, u(x, t), p(x, t): u t + u u ν u + p = f and div u = 0 in Ω (0, T ], (1.1) p(x, t) dx = 0, u = 0, on Ω and u(x, 0) = u 0 (x). Ω Respectively, ν, f, u 0 are the kinematic viscosity, body force and initial velocity. As problems become larger and assessment of uncertainty becomes necessary, execution time can become of primary importance. Execution time limitations often force the coupling between the velocity and pressure to be broken in various ways including adding a small (artificial) compression term, studied herein. Doing so speeds up the computations dramatically and does not require pressure boundary conditions but introduces extra numerical errors and new physical flow behaviors associated with compressibility, e.g., [Z06]. These include non-physical fast pressure oscillations (acoustics), analyzed in Section 3. These fast acoustic waves can yield restrictive timestep conditions for explicit time discretization of the pressure equation. The method presented below is a second order, artificial compression method with explicit treatment of the pressure that is, nevertheless, unconditionally stable. Since the velocity-pressure uncoupling is through the time discretization and applicable to other space discretizations, we suppress the (secondary) spacial discretization. In the tests in Sections 3 and 4, a standard finite element method is used for spacial discretization. Algorithm 1.1 (Artificial Compression Method). Given time step k > 0, t n = nk, and u n (x) = u(x, t n ), p n (x) = p(x, t n ). Pick α, β > 0 constants with αβ 1 4, Department of Mathematics, University of Pittsburgh, Pittsburgh, PA 1560, USA, s: vpd7@pitt.edu, mem66@pitt.edu, wjl@pitt.edu; The research herein was partially supported by NSF grant DMS

2 Let either u n = u n or u n = u n + u n Given (u n, p n ), (u n 1, p n 1 ), find (u n+1, p n+1 ) satisfying: u n 1 + u n 3. (1.) u n+1 u n 1 βk 1 grad div(u n+1 u n 1 )+ ( k ) +u un+1 + u n 1 n + 1 ( ) (div un+1 + u n 1 u n) + ν ( u n+1 + u n 1 ) + p n = f(x, t n ), (1.3) αk(p n+1 p n 1 ) + div u n = 0, u n+1 = 0 on Ω and p n+1 dx = 0. The roles played by the parameters α (units 1/L ), β (units L ) are as follows. αk is the standard artificial compression parameter that allows the pressure to be advanced explicitly in time. The β term is a dispersive regularization that acts through the momentum equation to ensure unconditional stability of the continuity equation, Remark 3.1 below. Thus if β = 0 the method would require a time step condition for stability. The term does increase the condition number and the coupling among velocity components in the linear system to be solved at each step. In d the increased coupling can be corrected using the sparse-grad-div adjustment of [BBR14]. The nonlinearity is explicitly skew symmetrized in the second line of the algorithm and in the numerical tests in Section 4. The extrapolation (1.) is an idea of Ingram [I13] with roots back to Baker [B76]. Often uncoupling of velocity and pressure has been achieved by fractional step or operator splitting methods, e.g., [T69], [Y71], [PT83]. Further efficiency gains per step can be obtained at a cost of an Re related time step condition by explicit discretization of the nonlinear terms; for interesting recent work in this approach see [YBC16]. This method (1.3) is inspired by the original method of Chorin [C68] and a recent pressure correction method connected with the stabilized implicit-explicit (IMEX) method CNLFstab of [JKLMT15]. Artificial (or quasi- or pseudo-) compressibility methods are closely related to pressure projection methods. See Prohl [P97] and Guermond, Minev, Shen [GMS06] for surveys and [A15], [GHKL15], [JL04], [K86],[OST10], [GM15], [GM17] and [OA10] for recent developments in this very active field. Algorithm 1.1 is a time discretization of the slightly compressible model Ω (1 β grad div)u t + u u + 1 (div u)u ν u + p = f, (1.4) αk p t + div u = 0. In all AC methods p(x, 0) must be specified but pressure boundary conditions are not required. In our tests we take the Stokes solution to the given problem data as initial condition. The method (1.3) is an IMEX combination of second order methods (Crank-Nicolson and Leapfrog). The α, β terms are O(k ) perturbations. Thus, the consistency error is O(k ). Theorem.1 (below) shows the velocity is L stable and the pressure weighted by the timestep is L stable: u n + k p n C(data).

3 This stability result, applied to the error equation, suggests the expected rates of convergence of O(k ) and O(k) for the velocity and pressure respectively (e.g., [S96a]). These rates are observed in the tests in Section 4. Section 3 presents preliminary tests on the nonphysical acoustic phenomena introduced by the artificial compression. Section 5 presents conclusions and a few natural open questions.. Unconditional stability. We prove next unconditional, long time, energy stability of the velocity and timestep-weighted pressure in the artificial compression method. For this, let (, ), denote the usual L (Ω) inner product and norm. The proof is based on a time-discrete energy analysis that identifies in (.3) the method s dissipation rate and energy. The first is exactly equal to the physical dissipation which vanishes when ν = 0 The method s kinetic energy, E n+1/, is total dissipation = ν u n+1 + u n 1. E n+1/ := 1 [ u n+1 + u n + β ( div u n+1 + div u n ) (.1) + αk ( p n+1 + p n ) + k(div u n, p n+1 ) k(p n, div u n+1 )]. The energy E n+1/ is quadratic in the flow variables and E n+1/ = E 1/ when ν = f = 0. It has a meaningful interpretation of an energy when positive definite, (.) below, in the flow variables (i.e., when αβ > 1/4). The first term in E n+1/, 1 u, is the standard NSE kinetic energy. The second component αk p + k(div u, p) reflects compressibility effects that vanish as k 0. The β terms in E n+1/ arise from dispersive effects, Remark 3.1 below, and vanish as u 0. Thus when αβ > 1/4, E n+1/ is consistent with the NSE s kinetic energy as k 0 and u 0 and this method, like that of [VVW03], is conservative when αβ > 1/4. Theorem.1 (Unconditional stability). Suppose α > 0, β > 0 are chosen so that We have E n+1/ 1 [ u n+1 + u n + k β αβ > 1 4. ( αβ 1 4) ( pn+1 + p n ) ]. (.) For any timestep k and any t n we have the following energy equality and stability n 1 E n+1/ + k l=0 n 1 E n+1/ + k l=0 ν u l+1 + u l ν u l+1 + u l n 1 = E 1/ + k and thus l=0 n 1 E 1/ + k l=0 (f(t n ), u n+1 + u n 1 ) (.3) 1 ν f(t l+ 1 ) 1 (.4) Proof. Existence of u n+1 follows easily from the estimates used to prove stability and standard linear analysis. We first analyze positivity of E n+1/. To begin, note 3

4 that k(div u n, p n+1 ) k(p n, div u n+1 ) β( div u n+1 + div u n ) + 4β k ( p n+1 + p n ). Thus E n+1/ 1 [ u n+1 + u n + k β ( αβ 1 4) ( pn+1 + p n ) ]. When αβ > 1/4 this is positive definite as claimed. To prove the energy equality, in Algorithm 1.1 take the inner product in the discrete momentum equation with u n+1 + u n 1 and the inner product in the discrete continuity equation with p n+1 + p n 1. Integration by parts and using the explicit skew symmetrization of the nonlinearity gives 1 k [ u n+1 + β div u n+1 ] 1 k [ u n 1 + β div u n 1 ] (p n, div (u n+1 + u n 1 )) + ν u n+1 + u n 1 = (f(t n ), u n+1 + u n 1 ) and αk p n+1 αk p n 1 + (div u n, p n+1 + p n 1 ) = 0. Multiply both equations through by k and add the two resulting equations. yields 1 [ u n+1 + β div u n+1 + αk p n+1 ] 1 [ u n 1 + β div u n 1 + αk p n 1 ] +k(div u n, p n+1 + p n 1 ) k(p n, div (u n+1 + u n 1 )) +kν ( u n+1 + u n 1 ) = k(f(t n ), u n+1 + u n 1 ). Adding and subtracting 1 [ u n + β div u n + αk p n ] gives This 1 [ u n+1 + u n + β ( div u n+1 + div u n ) + αk ( p n+1 + p n ) ] 1 [ u n + u n 1 + β ( div u n + div u n 1 ) + αk ( p n + p n 1 ) ] +k(div u n, p n+1 + p n 1 ) k(p n, div (u n+1 + u n 1 )) (.5) +kν ( u n+1 + u n 1 ) = k(f(t n ), u n+1 + u n 1 ). The terms k(div u n, p n+1 + p n 1 ) k(p n, div (u n+1 + u n 1 )) couple the pressure and incompressibility and are the key terms in the stability analysis. Rearrange them into an exact time difference as follows k(div u n, p n+1 + p n 1 ) k(p n, div (u n+1 + u n 1 )) = = [k(div u n, p n+1 ) k(p n, div u n+1 )] [k(p n, div u n 1 ) k(div u n, p n 1 )]. 4

5 Insert the rearrangement of the coupling terms into (.5). kinetic energy (.3), (.5) becomes Recalling the discrete E n+1/ E n 1/ + kν ( u n+1 + u n 1 ) = k(f(t n ), u n+1 + u n 1 ). Summing yields the claimed energy equality (.3). The energy equality and the Cauchy-Schwarz-Young inequality then imply stability (.4) provided E N+1/ > 0 for u, p 0, 0. Since this holds for αβ > 1/4 stability thus follows. 3. Testing Non-Physical Acoustic Waves. The method (1.3) is a second order discretization of the hyposonic flow model (1.4) (1 β grad div)u t + u u + 1 (div u)u ν u + p = f, (3.1) αk p t + div u = 0. When β = 0 this reduces to a slightly compressible model analyzed by Shen [S9]. Artificial compression methods replace incompressibility (sound speed c = ) with a pressure equation admitting high speed waves with c(k, α, β) as αk 0. The pressure discretization in (1.3) is a two step method and its solution has two modes. One mode converges to the true pressure in the incompressible NSE. The other mode is a spurious mode. The intuition is that this spurious mode may correspond to a non-physical, fast acoustic wave. This section explores these waves for the following test problem. Flow between offset circles. This test problem (from [JL15]) chooses Ω = {(x, y) : x + y r 1 and (x c 1 ) + (y c ) r }, r 1 = 1, r = 0.1, c = (c 1, c ) = ( 1, 0), f(x, y, t) = ( 4y(1 x y ), 4x(1 x y )) T, ν = 10 3, k = 0.01, T = 100, α = 0.5, β = 1.1. with boundary condition u = 0 on both circles. The flow (inspired by variants of Couette flow, [EP00]), stirred by a counterclockwise rotation (with f 0 at the outer circle), rotates about (0, 0) and interacts with the inner circle. This induces a vortex street which re-interacts with the immersed circle creating more complex structures. This flow also exhibits near wall streaks and a central polar vortex that pulsates. Discretize in space using the usual FEM with Taylor-Hood elements, e.g.,[g89], [P83], [Q93], using FreeFEM++[H1] and in time using (1.3). The mesh is a Delaunay mesh with 150 mesh points on the outer circle and 100 mesh points on the inner circle. The values α = 0.5, β = 1.1 were chosen so αβ = 0.75 > 1/4 without precomputations. The value ν = 10 3 is clearly beyond the setting of linear acoustics where the base state is zero velocity, constant pressure and negligible nonlinearity Fluctuations about a rest state. The usual acoustic equation describes small fluctuations about u = 0, p = const for which the quadratic u u term is negligible. In this case (3.1) takes the form (1 β grad div)u t + {negligible terms} ν u + p = f, (3.) αk p t + div u = 0. 5

6 Taking the divergence of the first equation and / t of the second equation, either p t or u (Gresho and Sani [GS00]) may be eliminated. Assuming div f = 0, we obtain that θ = div u and θ = p both satisfy the second order, damped wave equation [ β + 1]θ tt ν θ t (αk ) 1 θ = 0. This equation suggests that nonphysical oscillations in div u and p will be weakly damped by viscosity. Indeed, substituting (θ = div u or θ = p) θ(x, t) = e at φ(x), where φ, λ = Stokes eigenpair, we find that the decay rate a satisfies a νλ 1 + βλ a + λ αk (1 + βλ) = 0. This yields a decaying oscillations of the form θ(x, t) = e At (cos Bt + i sin Bt)φ(x), where A = 1 νλ 1 + βλ and B = 1 λ αk (1 + βλ) ( ) νλ. (3.3) 1 + βλ Sound Speeds. If viscosity is negligible (ν = 0), the sound speed of the nonphysical acoustic wave predicted by the above wave equation will vary with spacial frequency. Indeed, suppose p(x, 0) = e iωx, p t (x, 0) = 0. Setting p(x, t) = e iω(x+ct) and solving for the wave speed c = c(ω) gives c (k, ω) = (αk ) βω. (3.4) As expected, as k 0, the wave speed c which is necessary for consistency with the incompressible limit. This effect is modulated by the fact that higher frequencies in space have slower wave speeds due to the effect of the β terms. Remark 3.1. The effects of the α, β terms. In the artificial compression approximation, u = 0 is replaced by αk p t + u = 0. This introduces nonphysical acoustic waves with wave speed c 1/ αk. In the present method no CFL type timestep restriction is necessary due to the β grad div u t term. This term is a regularization of the problems kinetic energy altering the natural time scales of the problem, e.g., [LR13]. Increasing β slows the nonphysical acoustic waves to the point that the natural CFL condition is satisfied. Physical viscosity slowly damps these waves. Increasing β also slows the rate of damping of viscosity. Acoustic wave-speeds vs. timestep test. To test if wave speeds do indeed increase as the timestep k 0 for the flow between offset circles we computed and plotted (next) the pressure at (x, y) = (0, 0) on a time interval after initial transients pass. 6

7 00 Pressure at Origin vs Tim e, Re = 1000 dt=1/5 dt=1/50 dt=1/100 dt=1/ pressure at origin t Fig. 3.1: Re = 10 3 : Frequency increases as timestep decreases The pressure does indeed oscillate with greater frequency as the timestep decreases consistently with (3.6). Further, for fixed timestep, the amplitude also increases as Re increases for fixed t (but not as t increases for fixed Re). One possible explanation explored in Section 3. is the size of the nonlinear acoustic sound source. Time filters are a promising solution to the problem of nonphysical oscillations in artificial compression methods. An example of their positive effect on this oscillation is presented in Section Nonlinear Acoustics of the PDE Model. The analysis in the last subsection is for perturbation about a rest state u = 0, p = const. For acoustics about a state of motion, the nonlinear term is significant and the analog of the Lighthill model (see, Lighthill [Li5] and [LN09] for justification) is developed as follows. Let the usual Lighthill sound source be denoted Q(u, u) := u : ( u) T = i,j=1,,d u i x j u j x i, for d = or 3. Repeating the above derivation and retaining the nonlinear and viscous terms yields the acoustic equation αk [ β + 1]p tt p = div (u u + 1 ) (div u)u ν u. Lemma 3.. We have div (u u + 1 ) (div u)u = Q(u, u) 1 u (div u) + 1 div u. (3.5) 7

8 Proof. This is a vector identity. Thus if compressibility has negligible effects on acoustic waves then the RHS reduces to the usual Lighthill sound source div (u u + 1 ) (div u)u ν u Q(u, u), if div u 0. For artificial compression methods div u = αk p t 0, then div (u u + 1 ) (div u)u ν u = = Q(u, u) + αk u p t + αk ν p t + α k 4 p t. For ν < k the leading order non-physical source is (formally) αk u p t. Thus, the equation for pressure fluctuations about a non-rest state is αk [ β + 1]p tt p = Q(u, u) + αk u p t αk ν p t + α k 4 p t. (3.6) The nonphysical sound source terms αk u p t - αk ν p t + α k 4 p t do (formally) vanish as αk 0. The question is however what is its size relative to the physical sound source Q(u, u). We test the relative sizes of the Lighthill sound source to the leading order, non-physical sound source in the above, offset circle test problem. Magnitude of the Lighthill vs. non-physical sound source. The test computed the ratio of the Lighthill sound source to the leading order, nonphysical sound source ratio = αk u p t L. Q(u, u) L The time derivative p t was evaluated by second order central time differences. This ratio is plotted below in Figures 3. and 3.3 for k = 1/5, 1/50, 1/100, 1/00. The relative size of the nonphysical acoustic source is small but the ratio undergoes large fluctuations. As the timestep decreases, the ratio becomes more intermittent and the peaks increase. The increase is clearer when the previous figure is compared to the same data with the smallest timestep (1/00) omitted, next Evolution of u. Since u = 0 is replaced by αk p t + u = 0 one natural question is: How close to incompressible is the computed solution? This question is complicated by the (surprising when first discovered) fact that the standard, centered FEM using Hood-Taylor elements yields an approximate solution with u = O(1), [CELR11]. Figure 3.4 presents the evolution of ratio = u / u ; decreasing the timestep decreases the relative size of u. As for the standard FEM, while u decreases as k 0, it is significant for reasonable timestep values. The standard corrections, not tested herein, are either elements with discontinuous pressures or grad div stabilization in the space discretization Galilean Invariance. Comparing (3.1) to the equations of slightly compressible fluids is useful. At small Mach number, the correct model for the pressure equation in isothermal, hyposonic flow in dimensional form is αk (p t + u p) + div u = 0, (3.7) 8

9 αk u p t / Q evolution in time, Re = 1000 dt= 1/5 dt= 1/50 dt= 1/100 dt= 1/00 αk u p t Q t Fig. 3.: The ratio: Non-physical acoustic source / Lighthill source αk u p t / Q evolution in time, Re = 1000 dt= 1/5 dt= 1/50 dt= 1/ αk u p t Q t Fig. 3.3: The same ratio without k = 1/00 data 9

10 u / u evolution in time, Re = 1000 dt= 1/5 dt= 1/50 dt= 1/100 dt= 00 u u t Fig. 3.4: Relative size of div u vs time Zeytounian [Z04], Section.3, or Kreiss [K95] eqn. (1.4). The time derivative p/ t rather than the material derivative dp/dt means (1.4) violates Galilean invariance and is a source of criticism of the physical fidelity of artificial compression methods. Correction requires replacing p/ t with the material derivative. Preserving unconditional stability then requires making the discrete pressure equation linearly implicit as follows. Algorithm 3.3 (Corrected Artificial Compression Scheme). Pick α, β > 0 with αβ > 1/4 and let u n be as in Algorithm 1.1. Given (u n, p n ), (u n 1, p n 1 ), find (u n+1, p n+1 ) satisfying: αk { pn+1 p n 1 k u n+1 u n 1 βk 1 grad div(u n+1 u n 1 )+ ( k ) +u un+1 + u n 1 n + 1 ( ) (div un+1 + u n 1 u n) + ν ( u n+1 + u n 1 ) + p n = f(x, t n ), (3.8) } + div u n = 0, + u n p n+1 + p n (div u n) p n+1 + p n 1 u n+1 = 0 on Ω and p n+1 dx = 0. The error distribution for this method for a test problem with known exact solution is presented in Figure 4.1d. The nonlinear term (u p) in the material derivative dp/dt is explicitly skew symmetrized above. This preserves unconditional stability. 10 Ω

11 Theorem 3.4. Under the same conditions, the above corrected artificial compression scheme satisfies the same stability result as in Theorem.1. Proof. Take the inner product in the discrete momentum equation with u n+1 + u n 1 and the inner product in the discrete continuity equation with p n+1 + p n 1. The momentum equation is the same as previously. The discrete continuity equation gives αk p n+1 αk p n 1 + αk [(u n (p n+1 + p n 1 ), p n+1 + p n 1 ) + 1 ] (div u n (p n+1 + p n 1 ), p n+1 + p n 1 ) +(div u n, p n+1 + p n 1 ) = 0. The bracketed nonlinear terms in the discrete continuity equation satisfy (u n (p n+1 + p n 1 ), p n+1 + p n 1 ) + 1 ((div u n) (p n+1 + p n 1 ), p n+1 + p n 1 ) = 0. Thus, the continuity equation becomes the same as in the proof of Theorem.1 αk p n+1 αk p n 1 + (div u n, p n+1 + p n 1 ) = 0. The remainder of the proof is identical to that of Theorem Time filters control nonphysical acoustics. Time filters are commonly used in geophysical flow calculations to control nonphysical oscillations, e.g., [W10]. We test next the basic Robert-Asselin filter [W10], [HLT14] on the oscillations observed in Figure 3.1. Each timestep, given (u n 1, p n 1 ) and (u n, p n ) Algorithm 1.1 produced (u n+1, p n+1 ). The discrete time-curvatures are the calculated κ u := u n+1 u n + u n 1 and κ p := p n+1 p n + p n 1. The values (u n, p n ) are the updated using the coefficient γ (typically 0 < γ 0. in GFD) by u n u n + γ (un+1 u n + u n 1 ), p n p n + γ (pn+1 p n + p n 1 ). This method is still unconditionally stable provided αβ > 1 4(1 γ). (3.9) Denoting the discrete time-curvatures before and after the filter respectively by κ old,κ new, the time filter has the effect of reducing oscillations by κ new = (1 γ)κ old, see e.g., Section.1 of [HLT14]. To isolate persistent oscillations from initialization, we start the fluid at rest and ramp up the body force. Applying the time filter every step of Algorithm 1.1 for the flow between offset circles, taking k = 1/100, the pressure oscillations in Figure 3.5a are modified to those in Figure 3.5b. Noting the differences in vertical scales in the figures, the amplitude and frequency of the oscillations have been greatly reduced. In the tests in Section 4. the time filter increased the accuracy in the pressure. Any operation applied at every timestep can significantly alter the accuracy and stability of the computed solution. The analysis of the accuracy and stability of the combination of artificial compression plus time filter is underway. 11

12 pressure at origin pressure at origin t (a) AC t (b) AC+RA Fig. 3.5: p(0, 0, t) with and without filter. Note scale difference. 4. Tests of Accuracy. The accuracy tests in this section solve a d evolutionary Stokes problem (ν = 1) with exact solution from [GMS06]. This is discretized in space by a standard finite element method without penalties, stabilizations or other add-ons and using the package FreeFEM++ [H1]. Taylor-Hood elements were used except for one test with the linear-linear (P1/P1) pair which is known to violate the discrete inf-sup condition. Uniform meshes with 70 nodes per side on the boundary were used. The spacial mesh is thus fine relative to the timestep. Thus, the accuracy tests are for errors introduced by the artificial compression method. Let Ω = ( 1, 1). The exact solution from [GMS06] is u(x, y, t) = π sin t(sin πy sin πx, sin πx sin πy) p(x, y, t) = sin t cos πx sin πy. The timestep was chosen large enough that errors were expected to be dominated by timestepping errors. The exact solutions at t = 0 and t = k are used to initialize. We took T final = Pressure Correction and Artificial Compression. We compare the artificial compression (AC) scheme (1.3) to a related pressure correction (PC) method based on time discretization of the modified continuity equation ε p t + div u = 0 and αk p t n Ω = 0. Such methods generally have greater accuracy away from walls than straightforward AC methods but exhibit a boundary layer in the pressure error. Since the term ε p t controls p a smaller value of the grad-div parameter may be chosen without sacrificing unconditional stability. For all methods we have chosen near minimal parameter values consistent with unconditional stability of each: for AC method : α = 0.5, β = 1.1, for AC+RA method : α = 0.53, β = 1.1, γ = 0.1 for PC method : α =

13 The PC method is unconditionally stable and given by u n+1 u n 1 + αk grad div(u n+1 u n 1 ) ν un+1 + u n 1 k +u n un+1 + u n (div un ) un+1 + u n 1 + p n = f n, αk (p n+1 p n 1 ) + u n = 0. (4.1) Both (1.3) and (4.1) were discretized in space by the same finite element method on the same mesh. The pressure error in the AC method is (Figure 4.1a) observed to be distributed across the domain. The error is reduced by adding the RA filter (Figure 4.1c). Figure 4.1d shows similar error to the AC method with an interference pattern. (a) AC (b) PC (c) AC+RA (d) Corrected AC Fig. 4.1: Pressure error fields at final time t = 10, k = For the PC method the pressure error is concentrated along the boundary as expected, Figure 4.1b. The convergence rates (the slopes in the log-log plots in Figures 4. and 4.3 ) of the artificial compression method was O(k ) for velocity, and O(k) for the pressure as forecasted from the stability properties and consistency error. The AC method produced approximations with one extra significant digit of accuracy in the velocity error test. The log-log plot of the pressure errors, next, shows that the AC method s pressure converges as forecasted. In this test the kinetic energy 13

14 10-1 u h u l L / u l L AC, m = Corrected AC, m =.001 AC+RA, m =.10 Pressure Correction, m = k Fig. 4.: AC & PC methods O(k ) for velocity in the nonphysical acoustic modes was small enough as to not influence the overall pressure error in the artificial compression method. The error plateau in the PC method s pressure error is due to the modelled pressure boundary conditions. Indeed, in a further test, not presented herein, the exact pressure was imposed at the boundary for the PC method. The pressure error then no longer plateaued. 4.. The Linear-Linear Element Pair. We repeated the test with P1/P1 elements which do not satisfy the inf-sup condition. Liu, Liu and Pego [LLP10] concluded that pressure regularizations of the forms εp t + div u = 0 and ε p t + div u = 0 require the discrete inf-sup condition for pressure accuracy while those of the forms εp+div u = 0 and ε p+div u = 0 do not. Since the scheme studied herein was not included in their study due to the β term in the the modified momentum equation, we tested the AC method with P1/P1 elements. Velocity convergence plateaus with P1/P1 elements. The pressure diverged for P1/P1 elements and converged (as above) for Taylor-Hood elements, Figures 4.4 and 4.5. Our conclusion is that the discrete inf sup condition is necessary for convergence of both velocity and pressure for the AC method, in agreement with [LLP10]. 5. Conclusions. The artificial compression method presented is based on a two step method and thus shares the features of multi step methods. These features include efficiency for long time, constant time step simulations and the usual difficulties in starting and restarting after adapting the timestep. The first tests herein suggests that the method (1.3) is a promising tool for long time, constant timestep simulations. The method was observed to be second order convergent for the velocity, first order for the pressure and more accurate than a comparable pressure correction method. The method also does not require artificial boundary conditions for the pressure. 14

15 10 0 p h p l L / p l L AC, m = Corrected AC, m = 1.4 AC+RA, m = Pressure Correction, m = k Fig. 4.3: Pressure errors: AC method O(k), PC method shows error plateau Concerning negative features, the P1/P1 test confirmed that a good time discretization does not redeem a bad space discretization. The approximate pressure did exhibit nonphysical acoustic waves. Their wave speed increased as the timestep decreased but decreased as the spacial frequency increased. For problems with significant Reynolds number, the artificial compression method did contribute a nonphysical sound source that was small compared to the physical sound source. This sound source seems to introduce a resonance and the acoustic oscillations increased in amplitude as Re increased (but not as t increased). In preliminary tests time filters reduced significantly non-physical acoustics. The observed effects of the α, β terms are as follows. Since u = 0 is replaced by αk p t + u = 0, the α term introduces non-physical acoustic waves that speed up as k 0 with wave speed c 1/ αk. This is usually expected to introduce a CFL type timestep restriction for stability. In the present method it does not due to the β term. Increasing β slows the nonphysical acoustic waves to the point that the CFD condition is satisfied. Physical viscosity slowly damps these waves. Increasing β also slows the rate of damping of viscosity. Among open problems, there are many promising algorithmic variants such as (following Kobel kov [K0]) including grad div stabilization to the discrete momentum equation and a small amount of damping in the pressure discretization by, e.g., (1 β grad div)u t + u u + 1 (div u)u ν u γ grad div u + p = f, αk ( p n+1 p n 1 ) + αk (p n+1 + p n 1 ) + div u n = 0. k Time filters to suppress the non-physical acoustic mode are presently under care- 15

16 10 - u h u l L / u l L P/P1, m = P1/P1, m = k Fig. 4.4: Velocity error: P1/P1 elements vs Taylor-Hood elements ful study. Our preliminary tests indicate that the above pressure damping term (αk (p n+1 + p n 1 )) does not materially alter the oscillatory pressure mode but that time filters do have promise to correct the non-physical acoustics observed herein. Extending the analysis of Shen [S9], [S9a] for the compressible PDE model (1.4) to β > 0 would be a significant step in understanding the method (1.3). REFERENCES [A15] M. Akbas, S. Kaya, M.M. Jaman and L. Rebholz, Numerical analysis and testing of a fully discrete, decoupled penalty-projection algorithm for MHD in Elsasser variable, submitted 015 [B76] G.A. Baker, Galerkin approximations for the Navier-Stokes equations, Technical Report,1976. [BBR14] A. Bowers, S. Le Borne, and L. Rebholz, Error analysis and iterative solvers for Navier Stokes projection methods with standard and sparse grad div stabilization, CMAME 75 (014) [BS94] S.C. Brenner and L.R. Scott, The mathematical theory of finite element methods, Springer, Berlin, [CELR11] M. Case, V. Ervin, A. Linke and L. Rebholz, A connection between Scott-Vogelius elements and grad-div stabilization, SIAM JNA, 49(011), [C68] A.J. Chorin, Numerical solution of the Navier-Stokes equations, Math. Comp. (1968) [CHOR17] S. Charnyi, T. Heister, M.A. Olshanskii, L.G. Rebholz, On conservation laws of Navier Stokes Galerkin discretizations, JCP 337 (017), [GHKL15] D. Grapsas, R. Herbin, W. Kheriji and J.-C. Latché, An unconditionally stable staggered pressure correction scheme for the compressible Navier-Stokes equations, 015. [EP00] C. Egbers and G. Pfister, Physics of Rotating Fluids, Springer LN in Physics, v. 549, Berlin, 000. [GM15] J.-L. Guermond and P. Minev, High-Order Time Stepping for the Incompressible Navier Stokes Equations, SIAM J. Sci. Comput (015), pp. A656-A

17 10 p h p l L / p l L P/P1, m = P1/P1, m = k Fig. 4.5: Pressure error: P1/P1 elements vs Taylor-Hood elements [GM17] J.-L. Guermond and P. Minev, High-order time stepping for the Navier Stokes equations with minimal computational complexity, JCAM 310 (017) [GMS06] J.-L. Guermond, P. Minev, J. Shen, An overview of projection methods for incompressible flows, Comput. Methods Appl. Mech. Engrg., 195 (006), pp [G89] M.D. Gunzburger, Finite Element Methods for Viscous Incompressible Flows - A Guide to Theory, Practices, and Algorithms, Academic Press, [GS00] P.M. Gresho and R.L. Sani, Incompressible flows and the finite element method, volume, John Wiley and Sons, Chichester, 000. [H1] F. Hecht, New development in FreeFem++, J. Numer. Math. 0 (01), no. 3-4, Y15. [HLT14] N. Hurl, W. Layton, Y. Li and C. Trenchea, Stability analysis of the Crank-Nicolson- Leapfrog method with the Robert-Asselin-Williams time filter, BIT Numer. Math. 54(014), [I13] R. Ingram, Unconditional convergence of high-order extrapolations of the Crank- Nicolson, finite element method for the Navier-Stokes equations, Int. J. Numer. Anal. Model 10 (013) [JL15] N. Jiang and W. Layton, Numerical analysis of two ensemble eddy viscosity numerical regularizations of fluid motion, Numerical Methods for Partial Differential Equations, 31 (015), [JKLMT15] N. Jiang, M. Kubacki, W. Layton, M. Moraiti, and H. Tran, A Crank Nicolson Leapfrog stabilization: Unconditional stability and two applications. J. Comp. Appl. Math., 81 (015), [JL04] H. Johnston and J.-G. Liu, Accurate, stable and efficient Navier-Stokes solvers based on an explicit treatment of the pressure term, JCP 199(004) [K86] J. Van Kan, A second order accurate pressure-correction scheme for viscous incompressible flow, SIAM J. Sci. Computing 7(1986) [K0] G.M. Kobel kov, Symmetric approximations of the Navier-Stokes equations, Sbornik: Mathematics. 193(00), [K95] H.-O. Kreiss, On the limitations of calculations in fluid dynamics, pp in: M. Hafez and K. Oshima (eds.) CFD Review 1995, Wiley, Chichester, [LLT16] W. Layton, Y. Li and C. Trenchea, Recent Developments in IMEX Methods with Time Filters for Systems of Evolution Equations, JCAM 99(016)

18 [LN09] W. Layton and A Novotny, The exact derivation of the Lighthill acoustic analogy for low Mach number flows, Advances in Math Fluid Mech., 009, [LR13] W. Layton and L. Rebholz, On relaxation times in the Navier-Stokes-Voigt Model, IJCFD 7(013), [Li5] M.J. Lighthill, On sound generated aerodynamically, part I: general theory, Proc. Royal Soc. London A 11(195) [LLP10] J.-G. Liu, J. Liu and R. Pego, Stable and accurate pressure approximation for unsteady incompressible viscous flow, J. Comp. Phys. 9 (010) [OST10] M.A. Olshanskii, A. Sokolov, S. Turek, Error Analysis of a Projection Method for the Navier Stokes Equations With Coriolis Force, JMFM 1(010), [PT83] R. Peyret and T. Taylor, Computational methods for fluid flow, Springer, Berlin, [OA10] T. Ohwada and P. Asinari, Artificial compressibility method revisited: Asymptotic numerical method for incompressible Navier Stokes equations. J. Comp. Physics, 9: , 010. [P83] O. Pironneau, The Finite Element Methods for Fluids, John Wiley, Chichester, [P97] A. Prohl, Projection and quasi-compressibility methods for solving the incompressible Navier-Stokes equations, Springer, Berlin, [Q93] L. Quartapelle, Numerical solution of the incompressible Navier-Stokes equations: Birkhauser Verlag, [S9a] J. Shen, On error estimates of projection methods for the Navier-Stokes equations: First Order Schemes, SINUM 9(199) [S9] J. Shen, On error estimates of higher order projection and penalty-projection schemes for the Navier-Stokes equations, Numer. Math. 6(199) [S96a] J. Shen, On error estimates of the projection method for the Navier-Stokes equations: second order schemes,math. Comp. 65(1996) [T69] R. Temam, Sur l approximation de la solution des equations de Navier-Stokes par la method des pas fractionaires (I), Arch. Rational Mech. Anal., 3 (1969), [VVW03] D.R. Van der Heul, C. Vuik, and P. Wesseling, A conservative pressure-correction method for flow at all speeds, Computers & Fluids, 3: , 003. [W10] P.D. Williams, The RAW filter: an improvement to the Robert-Asselin filter in semiimplicit integrations, Mon. Weather Review 139(010) [Y71] N. Yanenko, The method of fractional steps, Springer, Berlin, [YBC16] L. Yang, S. Badia and R. Codina, A pseudo-compressible variational multiscale solver for turbulent incompressible flows, Comp. Mechanics 58(016) [Z04] R.Kh. Zeytounian, Theory and Applications of Viscous Fluid Flows, Springer, Berlin, 004. [Z06] R.Kh. Zeytounian, Topics in hyposonic flow theory, LN in Physics, Springer, Berlin,

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PSEUDO-COMPRESSIBILITY METHODS FOR THE UNSTEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Jie Shen Department of Mathematics, Penn State University University Par, PA 1680, USA Abstract. We present in this

More information

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4 Gauge Finite Element Method for Incompressible Flows Weinan E 1 Courant Institute of Mathematical Sciences New York, NY 10012 Jian-Guo Liu 2 Temple University Philadelphia, PA 19122 Abstract: We present

More information

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

SECOND-ORDER FULLY DISCRETIZED PROJECTION METHOD FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS Tenth MSU Conference on Differential Equations and Computational Simulations. Electronic Journal of Differential Equations, Conference 3 (06), pp. 9 0. ISSN: 07-669. URL: http://ejde.math.txstate.edu or

More information

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods 1 Introduction Achieving high order time-accuracy in the approximation of the incompressible Navier Stokes equations by means of fractional-step

More information

Gauge finite element method for incompressible flows

Gauge finite element method for incompressible flows INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 34: 701 710 Gauge finite element method for incompressible flows Weinan E a, *,1 and Jian-Guo Liu b,2 a Courant Institute

More information

New Discretizations of Turbulent Flow Problems

New Discretizations of Turbulent Flow Problems New Discretizations of Turbulent Flow Problems Carolina Cardoso Manica and Songul Kaya Merdan Abstract A suitable discretization for the Zeroth Order Model in Large Eddy Simulation of turbulent flows is

More information

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev Implementation of 3D Incompressible N-S Equations Mikhail Sekachev Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick

More information

Some remarks on grad-div stabilization of incompressible flow simulations

Some remarks on grad-div stabilization of incompressible flow simulations Some remarks on grad-div stabilization of incompressible flow simulations Gert Lube Institute for Numerical and Applied Mathematics Georg-August-University Göttingen M. Stynes Workshop Numerical Analysis

More information

Fast Solvers for Unsteady Incompressible Flow

Fast Solvers for Unsteady Incompressible Flow ICFD25 Workshop p. 1/39 Fast Solvers for Unsteady Incompressible Flow David Silvester University of Manchester http://www.maths.manchester.ac.uk/~djs/ ICFD25 Workshop p. 2/39 Outline Semi-Discrete Navier-Stokes

More information

Vector and scalar penalty-projection methods

Vector and scalar penalty-projection methods Numerical Flow Models for Controlled Fusion - April 2007 Vector and scalar penalty-projection methods for incompressible and variable density flows Philippe Angot Université de Provence, LATP - Marseille

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows

Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible Flows Author manuscript, published in "5th International Symposium on Finite Volumes for Complex Applications, Aussois : France 2008)" Vector Penalty-Projection Methods for the Solution of Unsteady Incompressible

More information

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS FREE BOUNDARY PROBLEMS IN FLUID MECHANICS ANA MARIA SOANE AND ROUBEN ROSTAMIAN We consider a class of free boundary problems governed by the incompressible Navier-Stokes equations. Our objective is to

More information

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

More information

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations Songul Kaya and Béatrice Rivière Abstract We formulate a subgrid eddy viscosity method for solving the steady-state

More information

ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES

ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES MATHEMATICS OF COMPUTATION Volume, Number, Pages S 5-578XX- ERROR ESTIMATES FOR SEMI-DISCRETE GAUGE METHODS FOR THE NAVIER-STOKES EQUATIONS : FIRST-ORDER SCHEMES RICARDO H. NOCHETTO AND JAE-HONG PYO Abstract.

More information

AN ALGORITHM FOR FAST CALCULATION OF FLOW ENSEMBLES

AN ALGORITHM FOR FAST CALCULATION OF FLOW ENSEMBLES AN ALGORITHM FOR FAST CALCULATION OF FLOW ENSEMBLES NAN JIANG AND WILLIAM LAYTON Abstract. This report presents an algorithm for computing an ensemble of p solutions of the Navier-Stokes equations. The

More information

A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes

A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes A connection between grad-div stabilized FE solutions and pointwise divergence-free FE solutions on general meshes Sarah E. Malick Sponsor: Leo G. Rebholz Abstract We prove, for Stokes, Oseen, and Boussinesq

More information

Towards pressure-robust mixed methods for the incompressible Navier Stokes equations

Towards pressure-robust mixed methods for the incompressible Navier Stokes equations Mohrenstrasse 39 10117 Berlin Germany Tel. +49 30 20372 0 www.wias-berlin.de 2016-05-05, Pittsburgh Weierstrass Institute for Applied Analysis and Stochastics Towards pressure-robust mixed methods for

More information

UNCONDITIONAL STABILITY OF A PARTITIONED IMEX METHOD FOR MAGNETOHYDRODYNAMIC FLOWS

UNCONDITIONAL STABILITY OF A PARTITIONED IMEX METHOD FOR MAGNETOHYDRODYNAMIC FLOWS UNCONDITIONAL STABILITY OF A PARTITIONED IMEX METHOD FOR MAGNETOHYDRODYNAMIC FLOWS CATALIN TRENCHEA Key words. magnetohydrodynamics, partitioned methods, IMEX methods, stability, Elsässer variables. Abstract.

More information

Relaxation methods and finite element schemes for the equations of visco-elastodynamics. Chiara Simeoni

Relaxation methods and finite element schemes for the equations of visco-elastodynamics. Chiara Simeoni Relaxation methods and finite element schemes for the equations of visco-elastodynamics Chiara Simeoni Department of Information Engineering, Computer Science and Mathematics University of L Aquila (Italy)

More information

Numerical Analysis of a Higher Order Time Relaxation Model of Fluids

Numerical Analysis of a Higher Order Time Relaxation Model of Fluids Numerical Analysis of a Higher Order Time Relaxation Model of Fluids Vincent J. Ervin William J. Layton Monika Neda Abstract. We study the numerical errors in finite element discretizations of a time relaxation

More information

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION JOHNNY GUZMÁN, ABNER J. SALGADO, AND FRANCISCO-JAVIER SAYAS Abstract. The analysis of finite-element-like Galerkin discretization techniques for the

More information

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 Jie Shen Department of Mathematics, Penn State University University Park, PA 1682 Abstract. We present some

More information

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS Submitted to Math. Comp. ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS J.L. GUERMOND 1 AND JIE SHEN 2 Abstract. In this paper we study the rotational form of the pressure-correction

More information

Projection Methods for Rotating Flow

Projection Methods for Rotating Flow Projection Methods for Rotating Flow Daniel Arndt Gert Lube Georg-August-Universität Göttingen Institute for Numerical and Applied Mathematics IACM - ECCOMAS 2014 Computational Modeling of Turbulent and

More information

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue

Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue 11 Basic Features of the Fluid Dynamics Simulation Software FrontFlow/Blue Yang GUO*, Chisachi KATO** and Yoshinobu YAMADE*** 1 FrontFlow/Blue 1) is a general-purpose finite element program that calculates

More information

On a class of numerical schemes. for compressible flows

On a class of numerical schemes. for compressible flows On a class of numerical schemes for compressible flows R. Herbin, with T. Gallouët, J.-C. Latché L. Gastaldo, D. Grapsas, W. Kheriji, T.T. N Guyen, N. Therme, C. Zaza. Aix-Marseille Université I.R.S.N.

More information

A Review of Solution Techniques for Unsteady Incompressible Flow

A Review of Solution Techniques for Unsteady Incompressible Flow Zeist 2009 p. 1/57 A Review of Solution Techniques for Unsteady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/57 PDEs Review : 1966 1999 Update : 2000

More information

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Johan Hoffman May 14, 2006 Abstract In this paper we use a General Galerkin (G2) method to simulate drag crisis for a sphere,

More information

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU

CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND JIAN-GUO LIU MATHEMATICS OF COMPUTATION Volume 69, Number 232, Pages 135{1407 S 0025-571(00)0124-5 Article electronically published on March 24, 2000 CONVERGENCE OF GAUGE METHOD FOR INCOMPRESSIBLE FLOW CHENG WANG AND

More information

Models. A.Dunca and Y.Epshteyn

Models. A.Dunca and Y.Epshteyn On the Adams-Stolz Deconvolution LES Models A.Dunca and Y.Epshteyn Abstract We consider a family of LES models with arbitrarily high consistency error O(δ 2N+2 ) for N = 1, 2, 3.. that are based on the

More information

General introduction to Hydrodynamic Instabilities

General introduction to Hydrodynamic Instabilities KTH ROYAL INSTITUTE OF TECHNOLOGY General introduction to Hydrodynamic Instabilities L. Brandt & J.-Ch. Loiseau KTH Mechanics, November 2015 Luca Brandt Professor at KTH Mechanics Email: luca@mech.kth.se

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Research Statement. M. Mohebujjaman

Research Statement. M. Mohebujjaman Research Statement M. Mohebuaman Research Interests I am broadly interested in computing numerical analysis for solving partial differential equations drawn from problems in fluid dynamics, electromagnetism

More information

Post-processing of solutions of incompressible Navier Stokes equations on rotating spheres

Post-processing of solutions of incompressible Navier Stokes equations on rotating spheres ANZIAM J. 50 (CTAC2008) pp.c90 C106, 2008 C90 Post-processing of solutions of incompressible Navier Stokes equations on rotating spheres M. Ganesh 1 Q. T. Le Gia 2 (Received 14 August 2008; revised 03

More information

Author(s) Huang, Feimin; Matsumura, Akitaka; Citation Osaka Journal of Mathematics. 41(1)

Author(s) Huang, Feimin; Matsumura, Akitaka; Citation Osaka Journal of Mathematics. 41(1) Title On the stability of contact Navier-Stokes equations with discont free b Authors Huang, Feimin; Matsumura, Akitaka; Citation Osaka Journal of Mathematics. 4 Issue 4-3 Date Text Version publisher URL

More information

Stability of two IMEX methods, CNLF and BDF2-AB2, for uncoupling systems of evolution equations

Stability of two IMEX methods, CNLF and BDF2-AB2, for uncoupling systems of evolution equations Stability of two IMEX methods, CNLF and BDF-AB, for uncoupling systems of evolution equations W. Layton a,,, C. Trenchea a,3, a Department of Mathematics, University of Pittsburgh, Pittsburgh, PA 56, USA

More information

2 D.D. Joseph To make things simple, consider flow in two dimensions over a body obeying the equations ρ ρ v = 0;

2 D.D. Joseph To make things simple, consider flow in two dimensions over a body obeying the equations ρ ρ   v  = 0; Accepted for publication in J. Fluid Mech. 1 Viscous Potential Flow By D.D. Joseph Department of Aerospace Engineering and Mechanics, University of Minnesota, MN 55455 USA Email: joseph@aem.umn.edu (Received

More information

Global well-posedness of the primitive equations of oceanic and atmospheric dynamics

Global well-posedness of the primitive equations of oceanic and atmospheric dynamics Global well-posedness of the primitive equations of oceanic and atmospheric dynamics Jinkai Li Department of Mathematics The Chinese University of Hong Kong Dynamics of Small Scales in Fluids ICERM, Feb

More information

Universität des Saarlandes. Fachrichtung 6.1 Mathematik

Universität des Saarlandes. Fachrichtung 6.1 Mathematik Universität des Saarlandes U N I V E R S I T A S S A R A V I E N I S S Fachrichtung 6. Mathematik Preprint Nr. 228 A Variational Multiscale Method for Turbulent Flow Simulation with Adaptive Large Scale

More information

In honor of Prof. Hokee Minn

In honor of Prof. Hokee Minn In honor of Prof. Hokee Minn It is my greatest honor to be here today to deliver the nd Minn Hokee memorial lecture. I would like to thank the Prof. Ha for the nomination and the selecting committee for

More information

Validation of an Entropy-Viscosity Model for Large Eddy Simulation

Validation of an Entropy-Viscosity Model for Large Eddy Simulation Validation of an Entropy-Viscosity Model for Large Eddy Simulation J.-L. Guermond, A. Larios and T. Thompson 1 Introduction A primary mainstay of difficulty when working with problems of very high Reynolds

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

NumAn2014 Conference Proceedings

NumAn2014 Conference Proceedings OpenAccess Proceedings of the 6th International Conference on Numerical Analysis, pp 198-03 Contents lists available at AMCL s Digital Library. NumAn014 Conference Proceedings Digital Library Triton :

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Analysis and Computation of Navier-Stokes equation in bounded domains

Analysis and Computation of Navier-Stokes equation in bounded domains 1 Analysis and Computation of Navier-Stokes equation in bounded domains Jian-Guo Liu Department of Physics and Department of Mathematics Duke University with Jie Liu (National University of Singapore)

More information

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Interaction and Multiscale Mechanics, Vol. 5, No. 1 (2012) 27-40 27 Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Ling Zhang and Jie Ouyang* Department of

More information

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS

ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION PROJECTION METHODS MATHEMATICS OF COMPUTATION Volume 73, Number 248, Pages 1719 1737 S 0025-5718(03)01621-1 Article electronically published on December 19, 2003 ON THE ERROR ESTIMATES FOR THE ROTATIONAL PRESSURE-CORRECTION

More information

A Pressure-Correction Scheme for Rotational Navier-Stokes Equations and Its Application to Rotating Turbulent Flows

A Pressure-Correction Scheme for Rotational Navier-Stokes Equations and Its Application to Rotating Turbulent Flows Commun. Comput. Phys. doi: 10.4208/cicp.301109.040310s Vol. 9, No. 3, pp. 740-755 March 2011 A Pressure-Correction Scheme for Rotational Navier-Stoes Equations and Its Application to Rotating Turbulent

More information

Global regularity of a modified Navier-Stokes equation

Global regularity of a modified Navier-Stokes equation Global regularity of a modified Navier-Stokes equation Tobias Grafke, Rainer Grauer and Thomas C. Sideris Institut für Theoretische Physik I, Ruhr-Universität Bochum, Germany Department of Mathematics,

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Finite Element Decompositions for Stable Time Integration of Flow Equations

Finite Element Decompositions for Stable Time Integration of Flow Equations MAX PLANCK INSTITUT August 13, 2015 Finite Element Decompositions for Stable Time Integration of Flow Equations Jan Heiland, Robert Altmann (TU Berlin) ICIAM 2015 Beijing DYNAMIK KOMPLEXER TECHNISCHER

More information

Convergence of the MAC scheme for incompressible flows

Convergence of the MAC scheme for incompressible flows Convergence of the MAC scheme for incompressible flows T. Galloue t?, R. Herbin?, J.-C. Latche??, K. Mallem????????? Aix-Marseille Universite I.R.S.N. Cadarache Universite d Annaba Calanque de Cortiou

More information

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany,

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany, Volker John On the numerical simulation of population balance systems Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, 10117 Berlin, Germany, Free University of Berlin, Department

More information

UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH 2 IMPLICIT-EXPLICIT NUMERICAL METHOD

UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH 2 IMPLICIT-EXPLICIT NUMERICAL METHOD UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH IMPLICIT-EXPLICIT NUMERICAL METHOD ANDREW JORGENSON Abstract. Systems of nonlinear partial differential equations modeling turbulent fluid flow

More information

PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID

PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID MATHEMATICS OF COMPUTATION Volume 71, Number 237, Pages 27 47 S 0025-5718(01)01313-8 Article electronically published on May 14, 2001 PROJECTION METHOD III: SPATIAL DISCRETIZATION ON THE STAGGERED GRID

More information

A Projection FEM for Variable Density Incompressible Flows

A Projection FEM for Variable Density Incompressible Flows Journal of Computational Physics 65, 67 88 (000) doi:0.006/jcph.000.6609, available online at http://www.idealibrary.com on A Projection FEM for Variable Density Incompressible Flows J.-L. Guermond and

More information

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow Fourth Order Convergence of Compact Finite Difference Solver for D Incompressible Flow Cheng Wang 1 Institute for Scientific Computing and Applied Mathematics and Department of Mathematics, Indiana University,

More information

MATHEMATICAL ARCHITECTURE FOR MODELS OF FLUID FLOW PHENOMENA. by Alexandr Labovschii

MATHEMATICAL ARCHITECTURE FOR MODELS OF FLUID FLOW PHENOMENA. by Alexandr Labovschii MATHEMATICAL ARCHITECTURE FOR MODELS OF FLUID FLOW PHENOMENA by Alexandr Labovschii B.S. in Applied Mathematics and Computer Science, Moscow State University, 00 Submitted to the Graduate Faculty of the

More information

PARTITIONED TIMESTEPPING FOR A PARABOLIC TWO DOMAIN PROBLEM

PARTITIONED TIMESTEPPING FOR A PARABOLIC TWO DOMAIN PROBLEM PARTTONED TMESTEPPNG FOR A PARABOLC TWO DOMAN PROBLEM JEFFREY M. CONNORS, JASON S. HOWELL, AND WLLAM J. LAYTON Abstract. There have been many numerical simulations but few analytical results of stability

More information

Decay in Time of Incompressible Flows

Decay in Time of Incompressible Flows J. math. fluid mech. 5 (23) 231 244 1422-6928/3/3231-14 c 23 Birkhäuser Verlag, Basel DOI 1.17/s21-3-79-1 Journal of Mathematical Fluid Mechanics Decay in Time of Incompressible Flows Heinz-Otto Kreiss,

More information

arxiv: v1 [math.na] 12 Mar 2018

arxiv: v1 [math.na] 12 Mar 2018 ON PRESSURE ESTIMATES FOR THE NAVIER-STOKES EQUATIONS J A FIORDILINO arxiv:180304366v1 [matna 12 Mar 2018 Abstract Tis paper presents a simple, general tecnique to prove finite element metod (FEM) pressure

More information

Computation of Incompressible Flows: SIMPLE and related Algorithms

Computation of Incompressible Flows: SIMPLE and related Algorithms Computation of Incompressible Flows: SIMPLE and related Algorithms Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de SIMPLE-Algorithm I - - - Consider

More information

[N175] Development of Combined CAA-CFD Algorithm for the Efficient Simulation of Aerodynamic Noise Generation and Propagation

[N175] Development of Combined CAA-CFD Algorithm for the Efficient Simulation of Aerodynamic Noise Generation and Propagation The 32nd International Congress and Exposition on Noise Control Engineering Jeju International Convention Center, Seogwipo, Korea, August 25-28, 2003 [N175] Development of Combined CAA-CFD Algorithm for

More information

ERROR ANALYSIS OF STABILIZED SEMI-IMPLICIT METHOD OF ALLEN-CAHN EQUATION. Xiaofeng Yang. (Communicated by Jie Shen)

ERROR ANALYSIS OF STABILIZED SEMI-IMPLICIT METHOD OF ALLEN-CAHN EQUATION. Xiaofeng Yang. (Communicated by Jie Shen) DISCRETE AND CONTINUOUS doi:1.3934/dcdsb.29.11.157 DYNAMICAL SYSTEMS SERIES B Volume 11, Number 4, June 29 pp. 157 17 ERROR ANALYSIS OF STABILIZED SEMI-IMPLICIT METHOD OF ALLEN-CAHN EQUATION Xiaofeng Yang

More information

Downloaded 08/20/14 to Redistribution subject to SIAM license or copyright; see

Downloaded 08/20/14 to Redistribution subject to SIAM license or copyright; see SIAM J. MATH. ANAL. Vol. 37, No. 6, pp. 89 92 c 26 Society for Industrial and Applied Mathematics Downloaded 8/2/4 to 28..64.244. Redistribution subject to SIAM license or copyright; see http://www.siam.org/journals/ojsa.php

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

ANALYSIS OF TIME FILTERS IN MULTISTEP METHODS. by Nicholas Hurl Bachelor of Mathematics, Kent State University, 2008

ANALYSIS OF TIME FILTERS IN MULTISTEP METHODS. by Nicholas Hurl Bachelor of Mathematics, Kent State University, 2008 ANALYSIS OF TIME FILTERS IN MULTISTEP METHODS by Nicholas Hurl Bachelor of Mathematics, Kent State University, 008 Submitted to the Graduate Faculty of the Kenneth P. Dietrich School of Arts and Sciences

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian BULLETIN OF THE GREE MATHEMATICAL SOCIETY Volume 57, 010 (1 7) On an Approximation Result for Piecewise Polynomial Functions O. arakashian Abstract We provide a new approach for proving approximation results

More information

Numerical Analysis and Computational Testing of a high accuracy Leray-deconvolution model of turbulence

Numerical Analysis and Computational Testing of a high accuracy Leray-deconvolution model of turbulence Numerical Analysis and Computational Testing of a high accuracy Leray-deconvolution model of turbulence William Layton,5 Carolina C. Manica,5 Monika Neda 3,5 Leo G. Rebholz,5 Department of Mathematics

More information

UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH 2 NUMERICAL METHOD

UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH 2 NUMERICAL METHOD INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING, SERIES B Volume 5, Number 3, Pages 7 87 c 04 Institute for Scientific Computing and Information UNCONDITIONAL STABILITY OF A CRANK-NICOLSON ADAMS-BASHFORTH

More information

INSTABILITY OF CRANK-NICOLSON LEAP-FROG FOR NONAUTONOMOUS SYSTEMS

INSTABILITY OF CRANK-NICOLSON LEAP-FROG FOR NONAUTONOMOUS SYSTEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING, SERIES B Volume 5, Number 3, Pages 289 298 c 2014 Institute for Scientific Computing and Information INSTABILITY OF CRANK-NICOLSON LEAP-FROG FOR

More information

Low Froude Number Limit of the Rotating Shallow Water and Euler Equations

Low Froude Number Limit of the Rotating Shallow Water and Euler Equations Low Froude Number Limit of the Rotating Shallow Water and Euler Equations Kung-Chien Wu Department of Pure Mathematics and Mathematical Statistics University of Cambridge, Wilberforce Road Cambridge, CB3

More information

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows

Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Chapter 7 The Time-Dependent Navier-Stokes Equations Turbulent Flows Remark 7.1. Turbulent flows. The usually used model for turbulent incompressible flows are the incompressible Navier Stokes equations

More information

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

Convergence of Time Averaged Statistics of Finite Element Approximations of the Navier-Stokes equations

Convergence of Time Averaged Statistics of Finite Element Approximations of the Navier-Stokes equations Convergence of Time Averaged Statistics of Finite Element Approximations of the Navier-Stokes equations V. John W. Layton C. C. Manica Abstract When discussing numerical solutions of the Navier-Stokes

More information

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume LIII, Number 1, March 2008 HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS IOAN TELEAGA AND JENS

More information

arxiv: v1 [math.ap] 28 Apr 2009

arxiv: v1 [math.ap] 28 Apr 2009 ACOUSTIC LIMIT OF THE BOLTZMANN EQUATION: CLASSICAL SOLUTIONS JUHI JANG AND NING JIANG arxiv:0904.4459v [math.ap] 28 Apr 2009 Abstract. We study the acoustic limit from the Boltzmann equation in the framework

More information

ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS. Chun Liu and Jie Shen

ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS. Chun Liu and Jie Shen DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS Volume 7, Number2, April2001 pp. 307 318 ON LIQUID CRYSTAL FLOWS WITH FREE-SLIP BOUNDARY CONDITIONS Chun Liu and Jie Shen Department

More information

Universität des Saarlandes. Fachrichtung 6.1 Mathematik

Universität des Saarlandes. Fachrichtung 6.1 Mathematik Universität des Saarlandes U N I V E R S I T A S S A R A V I E N I S S Fachrichtung 6.1 Mathematik Preprint Nr. 155 A posteriori error estimates for stationary slow flows of power-law fluids Michael Bildhauer,

More information

Turbulence Modeling I!

Turbulence Modeling I! Outline! Turbulence Modeling I! Grétar Tryggvason! Spring 2010! Why turbulence modeling! Reynolds Averaged Numerical Simulations! Zero and One equation models! Two equations models! Model predictions!

More information

Decay rate of the compressible Navier-Stokes equations with density-dependent viscosity coefficients

Decay rate of the compressible Navier-Stokes equations with density-dependent viscosity coefficients South Asian Journal of Mathematics 2012, Vol. 2 2): 148 153 www.sajm-online.com ISSN 2251-1512 RESEARCH ARTICLE Decay rate of the compressible Navier-Stokes equations with density-dependent viscosity coefficients

More information

A similarity theory of approximate deconvolution models of turbulence

A similarity theory of approximate deconvolution models of turbulence J. Math. Anal. Appl. 333 (007) 416 49 www.elsevier.com/locate/jmaa A similarity theory of approximate deconvolution models of turbulence William Layton 1, Monika Neda,1 Department of Mathematics, University

More information

Control of Interface Evolution in Multi-Phase Fluid Flows

Control of Interface Evolution in Multi-Phase Fluid Flows Control of Interface Evolution in Multi-Phase Fluid Flows Markus Klein Department of Mathematics University of Tübingen Workshop on Numerical Methods for Optimal Control and Inverse Problems Garching,

More information

Glowinski Pironneau method for the 3D ω-ψ equations

Glowinski Pironneau method for the 3D ω-ψ equations 280 GUERMOND AND QUARTAPELLE Glowinski Pironneau method for the 3D ω-ψ equations Jean-Luc Guermond and Luigi Quartapelle 1 LIMSI CNRS, Orsay, France, and Dipartimento di Fisica, Politecnico di Milano,

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

More information

Termination criteria for inexact fixed point methods

Termination criteria for inexact fixed point methods Termination criteria for inexact fixed point methods Philipp Birken 1 October 1, 2013 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany Department of Mathematics/Computer

More information

The inviscid limit to a contact discontinuity for the compressible Navier-Stokes-Fourier system using the relative entropy method

The inviscid limit to a contact discontinuity for the compressible Navier-Stokes-Fourier system using the relative entropy method The inviscid limit to a contact discontinuity for the compressible Navier-Stokes-Fourier system using the relative entropy method Alexis Vasseur, and Yi Wang Department of Mathematics, University of Texas

More information

Several forms of the equations of motion

Several forms of the equations of motion Chapter 6 Several forms of the equations of motion 6.1 The Navier-Stokes equations Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Journal of Computational Physics 157, (2000) doi: /jcph , available online at

Journal of Computational Physics 157, (2000) doi: /jcph , available online at Journal of Computational Physics 157, 796 800 000) doi:10.1006/jcph.1999.639, available online at http://www.idealibrary.com on NOTE A Simple Method for Computing Far-Field Sound in Aeroacoustic Computations

More information

MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER EQUATION. Thomas Y. Hou. Danping Yang. Hongyu Ran

MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER EQUATION. Thomas Y. Hou. Danping Yang. Hongyu Ran DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS Volume 13, Number 5, December 2005 pp. 1153 1186 MULTISCALE ANALYSIS IN LAGRANGIAN FORMULATION FOR THE 2-D INCOMPRESSIBLE EULER

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

On the parameter choice in grad-div stabilization for the Stokes equations

On the parameter choice in grad-div stabilization for the Stokes equations Noname manuscript No. (will be inserted by the editor) On the parameter choice in grad-div stabilization for the Stokes equations Eleanor W. Jenkins Volker John Alexander Linke Leo G. Rebholz Abstract

More information

Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations

Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations Numerical Simulations on Two Nonlinear Biharmonic Evolution Equations Ming-Jun Lai, Chun Liu, and Paul Wenston Abstract We numerically simulate the following two nonlinear evolution equations with a fourth

More information