A stable and dual consistent boundary treatment using ... - DiVA portal

3 downloads 0 Views 269KB Size Report
[7] Michael B. Giles and Niles A. Pierce. Adjoint equations in CFD: duality, ... [12] Jason E. Hicken and David W. Zingg. Summation-by-parts operators and high- ...
A stable and dual consistent boundary treatment using finite differences on summation-by-parts form

Jens Berg and Jan Nordström

Linköping University Post Print

N.B.: When citing this work, cite the original article.

Original Publication: Jens Berg and Jan Nordström, A stable and dual consistent boundary treatment using finite differences on summation-by-parts form, 2012, European Congress on Computational Methods in Applied Sciences and Engineering. Postprint available at: Linköping University Electronic Press http://urn.kb.se/resolve?urn=urn:nbn:se:liu:diva-81890

European Congress on Computational Methods in Applied Sciences and Engineering (ECCOMAS 2012) J. Eberhardsteiner et.al. (eds.) Vienna, Austria, September 10-14, 2012

A STABLE AND DUAL CONSISTENT BOUNDARY TREATMENT USING FINITE DIFFERENCES ON SUMMATION-BY-PARTS FORM Jens Berg1 and Jan Nordstr¨om2 1 Uppsala

University, Department of Information Technology SE-751 05, Uppsala, Sweden e-mail: [email protected]

2 Link¨ oping

University, Department of Mathematics SE-581 83, Link¨oping, Sweden e-mail: [email protected]

Keywords: Superconvergence, functionals, summation-by-parts, weak boundary conditions, stability, dual consistency Abstract. This paper is concerned with computing very high order accurate linear functionals from a numerical solution of a time-dependent partial differential equation (PDE). Based on finite differences on summation-by-parts form, together with a weak implementation of the boundary conditions, we show how to construct suitable boundary conditions for the PDE such that the continuous problem is well-posed and the discrete problem is stable and spatially dual consistent. These two features result in a superconvergent functional, in the sense that the order of accuracy of the functional is provably higher than that of the solution.

Jens Berg and Jan Nordstr¨om

1

Introduction

Functionals can represent the lift or drag on an aircraft, energy or any other scalar quantity computed from the solution to a partial differential equation (PDE). In many engineering applications, high order accurate functionals are often of greater interest than accurate solutions of the equations themselves. Whenever there is a functional involved, the concept of duality becomes important. The solution of a PDE resides in some function space, and the set of all bounded linear functionals on that space is called its dual space. Knowledge of the functional of interest can thus be obtained by studying the dual space. This is the main topic in functional analysis and references can be found in any standard textbook. In numerical analysis, and in particular for computational fluid dynamics problems, duality have been exploited for optimal control problems [14, 8], error estimation [23, 11, 6] and convergence acceleration [9, 22, 13, 2]. An extensive summary of the use of adjoint problems can be found in [10], and more recently in [5] with focus on error estimation and adaptive mesh refinement. In [2], the theory of functional superconvergence was established for time-dependent problems using a finite difference method on summation-by-parts (SBP) form with boundary conditions imposed weakly by the simultaneous approximation term (SAT). In order to avoid additional theoretical difficulties, Dirichlet boundary conditions for both the primal and dual problem were used. The Dirichlet boundary conditions ensured that both problems were well-posed without additional efforts. In an Euler or Navier-Stokes calculation, however, Dirichlet boundary conditions are rarely used. Unless exact boundary data is known, Dirichlet boundary conditions cause reflections which pollute the solution. Other kind of boundary conditions are well-known to increase both the accuracy and stability properties of the scheme [19, 20, 21]. In this paper, we will consider time-dependent partial differential equations of the form ut + L(u) = f, J(u) = (g, u)

(1)

where J(u) is a functional output of interest, L can be either linear or non-linear and u can represent either a scalar or vector valued function. In [2], the concept of spatial dual consistency was introduced to avoid treating the full time-dependent dual equations when discretizing using a method of lines. The concept is motivated by the following. To find the dual problem, we follow the notation in [2, 13], and seek a function θ in some appropriate function space, such that ZT ZT J(u)dt = (θ, f )dt. (2) 0

0

A formal computation (assume L linear and u, θ to have compact support in space) gives ZT

ZT J(u)dt −

J(u)dt = 0

ZT

0

ZT =

(θ, ut + Lu − f )dt 0

(θt − L∗ θ + g, u)dt +

0

Z Ω

[θu]T0 dΩ +

(3)

ZT (θ, f )dt, 0

where L∗ is the formal adjoint, or dual, operator associated with L under the inner product such that (θ, Lu) = (L∗ θ, u). By having homogeneous initial conditions for the primal problem, we 2

Jens Berg and Jan Nordstr¨om

obtain the time-dependent dual problem as −θt + L∗ θ = g

(4)

where we have to put an initial condition for the dual problem at time t = T . Usually one introduces the time transformation τ =T −t (5) which transforms (4) to θτ + L∗ θ = g

(6)

with an initial condition at τ = 0. Note that it is only the spatial part of (6) which have to be discretized differently compared to a discretization of the primal problem (1). A discretization which simultaneously approximates the spatial primal and dual operator consistently, is called spatially dual consistent and produces superconvergent time-dependent linear functionals if the scheme for the primal problem is stable [2]. A discretization of the primal problem (1) can be written as d uh + Lh uh = f, dt

(7)

where uh is the discrete approximation of u and Lh is a discrete approximation of L, including the boundary conditions. It is thus required that (7) is both stable and that the discrete dual operator, L∗h , is a consistent approximation of L∗ , including the dual boundary conditions. A difference operator for the first derivative is said to be on SBP form if it can be written as D1 = P −1 Q

(8)

||u||2 = uT P u

(9)

Q + QT = EN − E0 ,

(10)

EN = diag[0, . . . , 0, 1], E0 = diag[1, 0, . . . , 0].

(11)

where P defines a norm by and Q satisfies the SBP property

where The second derivative operator can be constructed either by applying the first derivative twice, i.e. D2 = (P −1 Q)2 (12) which results in a wide operator, or a compact operator with minimal bandwidth of the form D2 = P −1 (−H + (EN − E0 )S)

(13)

as described in [3, 17, 16]. In this paper, we consider only diagonal norms [25]. A first derivative SBP operator is essentially a 2s-order accurate central finite difference operator which have been modified close to the boundaries such that it becomes one-sided. Together with the diagonal norm, the boundary closure is accurate of order s making the SBP operator accurate of order s + 1 in general [25]. For problems with second derivatives, the compact operator can be modified with higher order accurate boundary closures to gain one extra order of accuracy [17, 26]. 3

Jens Berg and Jan Nordstr¨om

The discrete inner product in an SBP setting is defined by (uh , vh )h = uTh P vh

(14)

and hence the discrete adjoint operator can be computed, according to the definition (vh , Lh uh )h = (L∗h vh , uh )h ,

(15)

L∗h = P −1 LTh P.

(16)

as The proof that a stable and spatially dual consistent SBP scheme produces superconvergent linear functionals is presented in [2]. The proof is based on the fact that the mass matrix, P , in the norm is a high order accurate integration operator [12, 13]. The procedure for constructing stable schemes which superconvergent linear functionals can now be summarized as follows; 1. Determine boundary conditions such that both the primal and dual problems are wellposed 2. Discretize the primal problem and ensure stability 3. Compute L∗h and chose the remaining parameters (if any) such that the continuous adjoint L∗ is consistently approximated with the dual boundary conditions While the procedure seems somewhat abstract, we will show using representative equations that the computations are straight forward. Note that a stable and consistent discretization of the primal problem does not imply that the dual problem is consistently approximated. In fact, that is rarely the case. Note also that spatial dual consistency, and hence superconvergence, is merely a choice of coefficients. Superconvergence is thus obtained at no extra computational cost. In [2, 13] it was necessary to reduce the equations, which contained second derivatives, to first order form (often called the local discontinuous Galerkin, LDG, form). For systems in higher dimension, the LDG form quickly becomes tedious due to the extra variables that has to be introduced, and it is desirable that it can be avoided. The LDG form was a result of the Dirichlet boundary conditions imposed for the primal equations. Other kind of boundary conditions will improve both the stability and accuracy of the numerical scheme [20, 21], and at the same time, as we shall see, remove the need of the LDG form. 2

Linear incompletely parabolic system Consider the linear incompletely parabolic system of equations on 0 ≤ x ≤ 1 given by Ut + AUx = BUxx ,

(17)

where U = [p, u]T and  A=

u¯ c¯ c¯ u¯



 , B=

0 0 0 ε

 ,

(18)

together with a linear functional of interest, Z1 J(U ) = 0

4

GT U dx.

(19)

Jens Berg and Jan Nordstr¨om

Equation (17) can be viewed as the symmetrized [1], one-dimensional Navier-Stokes equations, linearized around a flow field with constant velocity u¯ > 0 and speed of sound c¯ > 0. In this case, we assume u¯ < c¯ and hence (17) requires two boundary conditions at the inflow boundary, x = 0, and one at the outflow boundary at x = 1. The boundary conditions we consider are of the form HL,R U ∓ BUx = GL,R (20) where HL,R are to be determined for well-posedness of both the primal and dual problems. There are many different forms of the matrices HL,R in (20) available which give wellposed inflow or outflow boundary conditions. The typical way to determine the structure of HL,R is to diagonalize the hyperbolic part of the equation and consider the ingoing or outgoing characteristics. This method will provide an energy estimate with optimal damping properties [20]. However, the dual problem associated with the linear functional (19) will most likely be ill-posed. Well-posedness of the primal problem does not imply well-posedness of the dual problem. For other than homogeneous Dirichlet boundary conditions, the choice of boundary conditions such that both the primal and dual problems are well-posed, is a non-trivial task. Since we are only interested in the spatial dual operator, it is sufficient to consider the steady, inhomogeneous, problem AUx − BUxx = F. (21) In this case, the differential operator L is given by L=A

∂2 ∂ −B 2 ∂x ∂x

(22)

and we seek θ = [φ, ψ]T such that J(U ) = (θ, F ).

(23)

Integration by parts gives J(U ) = (G, U ) − (θ, LU − F ) = (G − L∗ θ, U ) − [θT AU − θT BUx + θxT BU ]10 + (θ, F ),

(24)

where L∗ θ = −Aθx − Bθxx

(25)

and hence the dual operator is given by L∗ = −A

∂ ∂2 − B 2. ∂x ∂x

(26)

To determine the boundary conditions for the dual problem, we have to find a minimal set of conditions such that [θT AU − θT BUx + θxT BU ]10 = 0 (27) after the homogeneous boundary conditions for the primal problem have been applied. This is what put restrictions on the matrices HL,R in (20). Not only does the boundary terms have to vanish, they will also have to satisfy the number and form for the dual equation. Wrong choice of boundary conditions for the primal problem will cause the dual problem to be ill-posed since too many, or too few, boundary conditions are placed on the dual equations and hence existence or uniqueness is lost [7]. 5

Jens Berg and Jan Nordstr¨om

2.1

Left boundary conditions

By considering only the terms at x = 0, we can write (27) as θT (AU − BUx ) + θxT BU = U T ((A − HLT )θ + Bθx )

(28)

after having applied the homogeneous boundary conditions for the primal equation. The boundary conditions for the dual equation are thus given by (A − HLT )θ + Bθx = 0.

(29)

The form of the matrix HL can now be determined. Since the left boundary is an inflow boundary for the primal equation, but an outflow boundary for the dual equation, only one boundary condition is allowed for the dual equation. The boundary condition (29) hence have to be of rank one and thus it is required that   0 0 T A − HL = (30) αL βL or equivalently 

 u¯ c¯ − αL HL = . (31) c¯ u¯ − βL Any other form of HL would impose too many boundary conditions for the dual equation and it would not be well-posed. The coefficients αL , βL have to be chosen such that we obtain an energy estimate for both the time-dependent primal and dual problems. We can now turn our attention back to the primal equation to determine the coefficients αL , βL . By applying the energy method to (17) and considering only the left boundary terms, we get ||U ||2t = U T AU − U T BUx − UxT BU. (32) By assuming homogeneous boundary conditions, HL U − BUx = 0,

(33)

||U ||2t = −U T ML U

(34)

we can write (32) as where



u¯ c¯ − αL ML = −A + HL + = c¯ − αL u¯ − 2βL and we have to chose the coefficients αL , βL such that HLT



ML ≥ 0. Since ML has a rather easy structure, the eigenvalues can be directly computed as p (L) u − βL )2 − u¯(¯ u − 2βL ) + (¯ c − αL )2 µ1,2 = u¯ − βL ± (¯ and it is easy to see that both eigenvalues are positive if u¯ αL = c¯, βL ≤ . 2 Since ML is symmetric, the choices in (38) ensures that ||U ||2t ≤ 0 and hence the boundary conditions for the primal equation are well-posed. 6

(35)

(36)

(37)

(38)

(39)

Jens Berg and Jan Nordstr¨om

Remark 1. Note that the choices of αL , βL in (38) are not unique. Any choice such that (¯ c − αL )2 − u¯(¯ u − 2βL ) ≤ 0

(40)

is sufficient to obtain an energy estimate and hence a well-posed problem. It is, however, not only the primal equation which has to be well-posed. The time-dependent dual equation with its dual boundary conditions need also be well-posed with the conditions given by (38). By introducing the time transformation, τ = T − t,

(41)

we can write the time-dependent dual equation as θτ − Aθx = Bθxx .

(42)

The well-posedness of the dual problem is proven in Proposition 1. The time-dependent dual problem (42) is well-posed with the dual boundary conditions (29) and the parameters given in (38). Proof. By applying the energy method to (42), and only considering the terms at x = 0, we obtain ||θ||2τ = −θT Aθ − θT Bθx − θxT Bθ = −θT (−A + HL + HLT )θ

(43)

= −θT ML θ after applying the boundary conditions (29). The positiveness of ML , with the choices (38), were already proven in the energy estimate of the primal equation. To summarize, the left homogeneous boundary conditions for the primal problem are given by HL U − BUx = 0

(44)

(A − HLT )θ + Bθx = 0

(45)

and for the dual problem by where HL are given by (31) with the coefficients defined in (38). 2.2

Right boundary conditions

The right boundary, x = 1, is an outflow boundary for the primal problem and hence only one boundary condition can be used, while we have two variables in the system. This immediately puts restrictions on the boundary condition HR U + BUx = GR in such a way that HR is required to have the form   0 0 HR = . αR βR 7

(46)

(47)

Jens Berg and Jan Nordstr¨om

For any other form of HR , too many boundary conditions are placed at the outflow boundary and the primal problem is ill-posed. The coefficients αR , βR has to be determined such that both the time-dependent primal and dual problems are well-posed. The energy method applied to the time-dependent primal problem results, as before, in ||U ||2t = −U T MR U where MR = A + HR +

HRT

 =

u¯ c¯ + α c¯ + α u¯ + 2β

(48)  .

We can directly compute the eigenvalues of the symmetric matrix MR as p (R) u + βR )2 − u¯(¯ u + 2βR ) + (¯ c + αR )2 µ1,2 = u¯ + βR ± (¯

(49)

(50)

and see that they are both positive if we chose u¯ αR = −¯ c, βR ≥ − . 2

(51)

With the choices of αR , βR given in (51), the boundary conditions lead to a well-posed primal problem. Remark 2. Note that the choices of αR , βR in (51) are not unique. Any choice such that (¯ c + αR )2 − u¯(¯ u + 2βR ) ≤ 0

(52)

is sufficient to obtain an energy estimate and hence a well-posed problem. To determine the boundary conditions for the dual problem, we restrict (27) to the terms at x = 1. After applying the homogeneous primal boundary conditions, we obtain θT (AU − BUx ) + θxT BU = U T ((A + HRT )θ + Bθx )

(53)

and hence the boundary conditions for the dual problem are given by (A + HRT )θ + Bθx = 0.

(54)

Morever, it is required that the top row of A + HRT is non-zero since two boundary conditions are required for the dual equation. This is fulfilled by (51) since   u¯ 0 T A + HR = . (55) c¯ u¯ + βR The well-posedness of the dual boundary conditions for the time-dependent dual problem is given in Proposition 2. The time-dependent dual problem (42) is well-posed with the dual boundary conditions (54) and the parameters given in (51). Proof. As before, the energy method applied to the time-dependent dual problem gives ||θ||2τ = −θT (A + HR + HRT )θ = −θT MR θ,

(56)

where positiveness of MR is already proven from the energy estimate of the primal equation.

8

Jens Berg and Jan Nordstr¨om

To summarize, the right homogeneous boundary conditions for the primal problem are given by HR U + BUx = 0

(57)

(A + HRT )θ + Bθx = 0

(58)

and for the dual problem by where HR are given by (47) with the coefficients defined in (51). Remark 3. Note how it is the problem which requires the least number of boundary conditions which sets restrictions on the form of the boundary conditions. When also considering wellposedness of the dual problem, it can be used to reduce the number of unknown parameters in the boundary conditions of the primal problem. 2.3

Discretization, stability and spatial dual consistency

To discretize systems of equations, it is convenient to introduce the Kronecker product which is defined for arbitrary matrices C, D as   C11 D C1,2 D · · · C1n D  C21 D C22 D · · · C2n D    C ⊗ D =  .. (59) . .. . . . .  .  . . . Cn1 D Cn2 D · · · Cnn D For the matrix inverse and transpose we have (C ⊗ D)−1,T = C −1,T ⊗ D−1,T

(60)

if the usual matrix inverses are defined. Furthermore, a useful property which will be extensively used, is the mixed product property, ˜ = C C˜ ⊗ DD, ˜ (C ⊗ D)(C˜ ⊗ D)

(61)

if the usual matrix products are defined. Using the Kronecker product, equation (17) with the boundary conditions (20) can be discretized using the SBP-SAT technique as Ut + (D1 ⊗ A)U = (D2 ⊗ B)U + (P −1 E0 ⊗ ΣL )((IN +1 ⊗ HL )U − (D1 ⊗ B)U − GL ) + (P −1 EN ⊗ ΣR )((IN +1 ⊗ HR )U + (D1 ⊗ B)U − GR )

(62)

where ΣL,R are 2 × 2 matrices which have to be determined for stability. The second derivative is approximated using the wide operator, D2 = D1 D1 = (P −1 Q)2 . The matrices ΣL,R are given in Proposition 3. The scheme (62) is energy stable by choosing ΣL = ΣR = −I.

9

(63)

Jens Berg and Jan Nordstr¨om

Proof. We let GL = GR = 0 and apply the energy method to (62). By using the SBP properties of the operators, we obtain ||U ||2t = U T (E0 ⊗ A + ΣL HL + HLT ΣTL )U − U T (EN ⊗ A − ΣR HR − HRT ΣTR )U − 2U T (E0 D1 ⊗ B + ΣL B)U + 2U T (EN D1 ⊗ B + ΣR B)U

(64)

T

− 2 ((D1 ⊗ I2 )U ) (P ⊗ B) ((D1 ⊗ I2 )U ) where the last term is purely dissipative. By chosing ΣL = ΣR = −I,

(65)

||U ||2t ≤ −U T (E0 ⊗ −A + HL + HLT )U − U T (EN ⊗ A + HR + HRT )U

(66)

equation (64) simplifies to

where, by construction, −A + HL + HLT ≥ 0, A + HR + HRT ≥ 0.

(67)

Since the Kronecker product preserves positive (semi) definiteness, we have ||U ||2t ≤ 0

(68)

and the scheme is energy stable. The unique choice (63) of penalty matrices renders the scheme not only energy stable, but also spatially dual consistent. To prove this we must show that the discrete adjoint operator L∗h consistently approximates the discrete adjoint L∗ , including the dual boundary conditions (29) and (54). This is done in Proposition 4. The scheme (62) is spatially dual consistent with the choices of ΣL,R given in (63). Proof. For GL,R = 0, we can write the scheme (62) as d Uh + Lh Uh = 0 dt

(69)

Lh = (D1 ⊗ A) − (D2 ⊗ B) + (P −1 E0 ⊗ I2 )((IN +1 ⊗ HL ) − (D1 ⊗ B)) + (P −1 EN ⊗ I2 )((IN +1 ⊗ HR ) + (D1 ⊗ B)).

(70)

where

The discrete dual operator is defined by L∗h = (P ⊗ I2 )−1 LTh (P ⊗ I2 ).

(71)

A somewhat tedious calculation shows that L∗h = −(D1 ⊗ A) − (D2 ⊗ B) − (P −1 E0 ⊗ I2 )((IN +1 ⊗ A − HLT ) + (D1 ⊗ B))

(72)

+ (P −1 EN ⊗ I2 )((IN +1 ⊗ A + HRT ) + (D1 ⊗ B)) which is a consistent approximation of (26) including the dual boundary conditions (29) and (54). The scheme is hence spatially dual consistent. 10

Jens Berg and Jan Nordstr¨om

2.4

Numerical results

A forcing function have been chosen such that an analytical solution is known, and the rates of convergence are computed with respect to the analytical solution. This is known as the method of manufactured solutions [24, 15]. The solution in this case is given by p(x, t) = (arctan(x) − δ cos(αx − t) + 1)e−x u(x, t) = (arctan(x) + δ sin(αx − t) + 1)e−x

2

(73)

2

and the weight functions in the functionals are chosen such that π log(2) δ(sin(t − α) − sin(t)) − + 4 2 α π log(2) δ(cos(t) − cos(t − α)) J(u) = 1 + − + . 4 2 α J(p) = 1 +

(74) (75)

In (62), the second derivative is approximated using the first derivative operator twice, which results in a wide operator. There are compact second derivative operators with better accuracy [17, 16]. When considering the discrete dual problem, however, spatial dual consistency can only be obtained if the second derivative operator can be factorized into the product of two consistent first derivative operators. Indeed, the scheme (62) is dual inconsistent when the second derivative is compactly discretized. In Table 1 we present the numerical results regarding the order of convergence of the solution and functionals using both a wide and compact second derivative operator. The time integration is performed until time t = 0.2 with the classical 4th-order Runge-Kutta method using 1000 time steps. Artificial dissipation has been added as described in [18, 4]. Wide operator 96 128

N

64

p u J(p) J(u)

3.0530 2.8870 2.5584 4.2536

3.0426 2.9740 3.9209 4.2841

3.0377 2.9973 4.2617 4.3698

p u J(p) J(u)

3.9528 5.1102 2.8420 4.4917

4.2587 4.8158 4.6607 5.6177

4.4108 4.6828 5.5723 5.9905

p u J(p) J(u)

4.8682 4.2438 5.0355 6.5365

4.7599 5.1204 7.7071 7.3625

4.7595 5.2586 8.1376 8.0564

160 s=2 3.0345 3.0061 4.4285 4.4192 s=3 4.4797 4.5782 5.9361 6.1948 s=4 4.7499 5.2981 8.5775 8.5796

64

Compact operator 96 128

160

3.2055 3.8368 2.3289 3.3403

3.2539 4.0364 3.2762 3.5314

3.1971 4.0903 3.6065 3.7163

3.1560 4.1204 3.7740 3.8343

4.7882 6.0147 5.8846 5.9529

4.3370 6.7091 4.3321 2.0560

4.0411 6.8642 2.9507 3.9205

4.0424 6.5443 4.3215 4.6030

3.6345 4.8689 3.7680 5.0693

4.4454 6.4603 6.0404 5.8672

4.6180 7.2947 6.5043 6.4344

4.6752 7.7447 6.8383 6.8063

Table 1: Convergence rates for the variables and functionals using both the wide and compact second derivative operator

As can be seen from Table 1, the spatially dual consistent scheme with the wide second derivative operator results in superconvergent functionals. The same scheme with a compact 11

Jens Berg and Jan Nordstr¨om

operator has no functional superconvergence due to its dual inconsistency. Note, however, that the variable u has higher order of convergence than that of p in the inconsistent discretization. A possible explanation for this is that the boundary closure of the compact second derivative operator has higher order of accuracy, and hence u gain accuracy when compactly discretized [17]. 3

Conclusions

We have presented a stable and spatially dual consistent boundary treatment of an incompletely parabolic system of equations in one space dimension. It was shown how to construct well-posed boundary conditions such that superconvergent functionals were obtained. Another benefit compared to having Dirichlet boundary conditions is that a reduction to a first order system can be avoided. The choice of parameters for energy stability is unique due to the form of the boundary conditions. The unique choice of parameters also lead to a spatially dual consistent scheme which produced superconvergent linear functionals. Spatial dual consistency is merely a choice of parameters in the scheme, and hence the superconvergence was obtained without additional computational cost compared to a standard scheme. Acknowledgements This work has partly been carried out within the IDIHOM project which is supported by the European Commission under contract No. ACP0-GA-2010-265780. REFERENCES [1] Saul Abarbanel and David Gottlieb. Optimal time splitting for two- and three-dimensional Navier-Stokes equations with mixed derivatives. Journal of Computational Physics, 41(1):1 – 33, 1981. [2] Jens Berg and Jan Nordstr¨om. Superconvergent functional output for time-dependent problems using finite differences on summation-by-parts form. Technical Report 2012004, Department of Information Technology, Uppsala University, February 2012. [3] Mark H. Carpenter, Jan Nordstr¨om, and David Gottlieb. A stable and conservative interface treatment of arbitrary spatial accuracy. Journal of Computational Physics, 148(2):341 – 365, 1999. [4] Peter Diener, Ernst Nils Dorband, Erik Schnetter, and Manuel Tiglio. Optimized highorder derivative and dissipation operators satisfying summation by parts, and applications in three-dimensional multi-block evolutions. Journal of Scientific Computing, 32(1):109– 145, July 2007. [5] Krzysztof J. Fidkowski and David L. Darmofal. Review of output-based error estimation and mesh adaptation in computational fluid dynamics. AIAA Journal, 49(4):673–694, 2011. [6] Michael B. Giles, Mats G. Larson, J. M˚arten Levenstam, and Endre S¨uli. Adaptive error control for finite element approximations of the lift and drag coefficients in viscous flow. Technical report, Report NA-97/06, Oxford University Computing Laboratory, 1997. 12

Jens Berg and Jan Nordstr¨om

[7] Michael B. Giles and Niles A. Pierce. Adjoint equations in CFD: duality, boundary conditions and solution behaviour. In AIAA Paper 97-1850, 1997. [8] Michael B. Giles and Niles A. Pierce. An introduction to the adjoint approach to design. Flow, Turbulence and Combustion, 65:393–415, 2000. [9] Michael B. Giles and Niles A. Pierce. Superconvergent lift estimates through adjoint error analysis. Innovative Methods for Numerical Solutions of Partial Differential Equations, 2001. [10] Michael B. Giles and Endre S¨uli. Adjoint methods for PDEs: a posteriori error analysis and postprocessing by duality. Acta Numerica, 11:145–236, 2002. [11] Jason E. Hicken. Output error estimation for summation-by-parts finite-difference schemes. Journal of Computational Physics, 231(9):3828 – 3848, 2012. [12] Jason E. Hicken and David W. Zingg. Summation-by-parts operators and high-order quadrature. ArXiv e-prints, March 2011. [13] Jason E. Hicken and David W. Zingg. Superconvergent functional estimates from summation-by-parts finite-difference discretizations. SIAM Journal on Scientific Computing, 33(2):893–922, 2011. [14] Antony Jameson. Aerodynamic design via control theory. Journal of Scientific Computing, 3:233–260, September 1988. [15] Jens Lindstr¨om and Jan Nordstr¨om. A stable and high-order accurate conjugate heat transfer problem. Journal of Computational Physics, 229(14):5440–5456, 2010. [16] Ken Mattsson. Summation by parts operators for finite difference approximations of second-derivatives with variable coefficients. Journal of Scientific Computing, pages 1–33, 2011. [17] Ken Mattsson and Jan Nordstr¨om. Summation by parts operators for finite difference approximations of second derivatives. Journal of Computational Physics, 199(2):503– 540, 2004. [18] Ken Mattsson, Magnus Sv¨ard, and Jan Nordstr¨om. Stable and accurate artificial dissipation. Journal of Scientific Computing, 21(1):57–79, 2004. [19] Jan Nordstr¨om. The influence of open boundary conditions on the convergence to steady state for the Navier-Stokes equations. Journal of Computational Physics, 85(1):210 – 244, 1989. [20] Jan Nordstr¨om. The use of characteristic boundary conditions for the Navier-Stokes equations. Computers & Fluids, 24(5):609 – 623, 1995. [21] Jan Nordstr¨om, Sofia Eriksson, and Peter Eliasson. Weak and strong wall boundary procedures and convergence to steady-state of the Navier-Stokes equations. Journal of Computational Physics, 231(14):4867 – 4884, 2012.

13

Jens Berg and Jan Nordstr¨om

[22] Niles A. Pierce and Michael B. Giles. Adjoint recovery of superconvergent functionals from PDE approximations. SIAM Review, 42(2):247–264, 2000. [23] Niles A. Pierce and Michael B. Giles. Adjoint and defect error bounding and correction for functional estimates. Journal of Computational Physics, 200:769–794, November 2004. [24] Lee Shunn, Frank Ham, and Parviz Moin. Verification of variable-density flow solvers using manufactured solutions. Journal of Computational Physics, 231(9):3801 – 3827, 2012. [25] Bo Strand. Summation by parts for finite difference approximations for d/dx. Journal of Computational Physics, 110(1):47 – 67, 1994. [26] Magnus Sv¨ard and Jan Nordstr¨om. On the order of accuracy for difference approximations of initial-boundary value problems. Journal of Computational Physics, 218(1):333–352, 2006.

14

Suggest Documents