• Nie Znaleziono Wyników

isoGeometric Residual Minimization Method (iGRM)

N/A
N/A
Protected

Academic year: 2021

Share "isoGeometric Residual Minimization Method (iGRM)"

Copied!
45
0
0

Pełen tekst

(1)

isoGeometric Residual Minimization Method (iGRM)

Maciej Paszyński1

M. Łoś1 I. Muga2 Q. Deng3 V. M. Calo3

1Department of Computer Science

AGH University of Science and Technology, Kraków, Poland home.agh.edu.pl/paszynsk

2The University of Basque Country, Bilbao, Spain

3Curtin University, Perth, Western Australia

National Science Centre, Poland grant HARMONIA 2017/26/M/ST1/00281

1 / 45

(2)

Outline

Unstable problems

Factorization of Kronecker product matrices Residual minimization method

Factorization of residual minimization problem matrix Iterative solver

isoGeometric Residual Minimization method (iGRM) Numerical results: Manufactured solution problem, Eriksson-Johnson model problem

Conclusions

2 / 45

(3)

Eriksson-Johnson problem

Given Ω = (0, 1)2, β = (1, 0)T, we seek the solution of the advection-diffusion problem

∂u

∂x −  2u

∂x2 +2u

∂y2

!

= 0 (1)

with Dirichlet boundary conditions

u = 0 for x ∈ (0, 1), y ∈ {0, 1} u = sin(Πy ) for x = 0

The problem is driven by the inflow Dirichlet boundary condition.

It develops a boundary layer of width  at the outflow x = 1.

3 / 45

(4)

Eriksson-Johnson problem

Figure:Galerkin FEM solution to Erikkson-Johnson problem, Pe = 106

Figure:Cross-section and zoom

4 / 45

(5)

Higher continuity of isogeometric analysis

Figure:Isogeometric analysis provided smooth approximations with lower number of degrees of freedom

5 / 45

(6)

Higher continuity of isogeometric analysis

Figure:Recursive definition of B-splines

6 / 45

(7)

Higher continuity of isogeometric analysis

Figure:Tensor product structure of the 3D mesh

Isogeometric basis functions:

1D B-splines basis along x axis B1,px (x ), . . . , BNx

x,p(x ) 1D B-splines basis along y axis B1,py (y ), . . . , BNyy,p(y ) 1D B-splines basis along z axis B1,pz (z), . . . , BzNz,p(z) In 2D we take tensor product basis

{Bi ,px (x )Bj,py (y )}i =1,...,Nx;j=1,...,Ny In 3D we take tensor product basis

{Bi ,px (x )Bj,py (y )Bk,pz (z)}i =1,...,Nx;j=1,...,Ny;1,...,Nz

7 / 45

(8)

Mass and stiffness matrices over 2D domain Ω = Ω

x

× Ω

y

M= (Bij, Bkl)L2 = Z

BijBkldΩ =

Z

Bxi(x )Bjy(y )Bkx(x )Bly(y ) dΩ = Z

(BiBk)(x ) (BjBl)(y ) dΩ

=

Z

x

BiBkdx

 Z

y

BjBldy

!

=Mx⊗ My

S= (∇Bij, ∇Bkl)L2 = Z

∇Bij· ∇BkldΩ =

Z

∂(Bix(x )Bjy(y ))

∂x

∂(Bkx(x )Bly(y ))

∂x +∂(Bix(x )Bjy(y ))

∂y

∂(Bxk(x )Bly(y ))

∂y dΩ

= Z

∂Bix(x )

∂x Byj(y )∂Bkx(x )

∂x Bly(y ) + Bix(x )∂Bjy(y )

∂y Bkx(x )∂Bly(y ))

∂y dΩ

= Z

x

∂Bi

∂x

∂Bk

∂x dx Z

y

BjBldy + Z

x

BiBkdx Z

y

∂Bj

∂y

∂Bl

∂y dy

=Sx⊗ My+ Mx⊗ Sy

8 / 45

(9)

Derivation of Spatial Direction Splitting

Idea exploit Kronecker product structure of Mx = b

with M = A ⊗ B, where A is n × n, B is m × m Definition of Kronecker (tensor) product:

M = A ⊗ B =

A B11 A B12 · · · A B1m

A B21 A B22 · · · A B2m ... ... . .. ... A Bm1 A Bm2 · · · A Bmm

9 / 45

(10)

Derivation of Spatial Direction Splitting

RHS and solution are partitioned into m blocks of size n each xi = (xi 1, . . . , xin)T

bi = (bi 1, . . . , bin)T

We can rewrite the system as a block matrix equation:

AB11x1+ AB12x2 + · · · + AB1mxm = b1 AB21x1+ AB22x2 + · · · + AB2mxm = b2

... ... ... ... ABm1x1+ ABm2x2+ · · · + ABmmxm= bm

10 / 45

(11)

Derivation of Spatial Direction Splitting

Factor out A:

A B11x1+ B12x2 + · · · + B1mxm

= b1

A B21x1+ B22x2 + · · · + B2mxm = b2 ... ... ... ... A Bm1x1+ Bm2x2+ · · · + Bmmxm

= bm

Wy multiply by A−1 and define yi = A−1bi

(we have one 1D problem here A yi = bi with multiple RHS)

B11x1+ B12x2 + · · · + B1mxm = y1 B21x1+ B22x2 + · · · + B2mxm = y2

... ... ... ... Bm1x1+ Bm2x2+ · · · + Bmmxm = ym

11 / 45

(12)

Derivation of Spatial Direction Splitting

Consider each component of xi and yi ⇒ family of linear systems

B11x1i + B12x2i + · · · + B1mxmi = y1i B21x1i + B22x2i + · · · + B2mxmi = y2i

... ... ... ... Bm1x1i + Bm2x2i+ · · · + Bmmxmi = ymi for each i = 1, . . . , n

⇒ linear systems with matrix B (We have another 1D problem here with multiple RHS B xi = yi )

12 / 45

(13)

Residual minimization method

b(u, v ) = l (v ) ∀v ∈ V (2)

For our weak problem (2) we define the operator B : U → V0 such as < Bu, v >V0×V= b (u, v ).

B : U → V0 (3)

such that

hBu, v iV0×V = b(u, v ) (4) so we can reformulate the problem as

Bu − l = 0 (5)

We wish to minimize the residual uh= argminwh∈Uh

1

2kBwh− lk2V0 (6)

13 / 45

(14)

Residual minimization method

We introduce the Riesz operator being the isometric isomorphism RV: V 3 v → (v , .) ∈ V0 (7) We can project the problem back to V

uh= argminwh∈Uh

1

2kRV−1(Bwh− l)k2V (8) The minimum is attained at uh when the Gâteaux derivative is equal to 0 in all directions:

hRV−1(Buh− l), RV−1(B wh)iV = 0 ∀ wh∈ Uh (9) We define the residual r = RV−1(Buh− l) and we get

hr , RV−1(B wh)i = 0 ∀ wh∈ Uh (10) which is equivalent to

hBwh, r i = 0 ∀wh∈ Uh. (11) From the definition of the residual we have

(r , v )V = hBuh− l, v i ∀v ∈ V . (12)

14 / 45

(15)

Residual minimization method with semi-infinite problem

Find (r , uh)V ×Uh such as

(r , v )V − hBuh− l, v i = 0 ∀v ∈ V

hBwh, r i = 0 ∀wh∈ Uh (13) We discretize the test space Vm ∈ V to get the discrete problem:

Find (rm, uh)Vm×Uh such as

(rm, vm)Vm− hBuh− l, vmi = 0 ∀vm ∈ Vm

hBwh, rmi = 0 ∀wh∈ Uh (14) where (∗, ∗)Vm is an inner product in Vm, hBuh, vmi = b (uh, vm), hBwh, rmi = b (wh, rm).

Remark

We define the discrete test space Vm in such a way that it is as close as possible to the abstract V space, to ensure stability, in a sense that the discrete inf-sup condition is satisfied. In our method it is possible to gain stability enriching the test space Vm without changing the trial space Uh.

15 / 45

(16)

Discretization of the residual minimization method

We approximate the solution with tensor product of one dimensional B-splines basis functions of order p

uh=X

i ,j

ui ,jBi ;px (x )Bj;py (y ). (15) We test with tensor product of one dimensional B-splines basis functions, where we enrich the order in the direction of the x axis from p to r (r ≥ p, and we enrich the space only in the direction of the alternating splitting)

vm← Bi ;rx (x )Bj;py (y ). (16) We approximate the residual with tensor product of one dimensional B-splines basis functions of order p

rm =X

s,t

rs,tBs;rx (x )Bt;py (y ), (17) and we test again with tensor product of 1D B-spline basis functions of order r and p, in the corresponding directions

wh← Bk;px (x )Bl ;py (y ). (18) Remark

We perform the enrichment of the test space also in the alternating directions manner. In this way, when we solve the problem with derivatives along the x direction, we enrich the test space by increasing the B-splines order in the x direction, but we keep the B-splines order along y constant (same as in the trial space). By doing that, we preserve the Kronecker product structure of the matrix, to ensure that we can apply the alternating direction solver.

16 / 45

(17)

Decomposition into Kronecker product structure

A = Ay⊗ Ax; B = Bx ⊗ By; BT = ByT⊗ BTx; Ay = By (19)

A B

BT 0

!

= Ay 0

0 ATy

! Ax Bx

BxT 0

!

= AxAy BxAy

BxTATy 0

! . (20) Both matrices Ay 0

0 ATy

!

and Ax Bx

BxT 0

!

can be factorized in a linear O(N) computational cost.

Figure:Factorization of second block. 17 / 45

(18)

Towards iterative solver

"

A B

BT 0

# "

r u

#

=

"

F 0

#

(21) A = M + ηK

M = Mx ⊗ My,

K = Kx⊗ My+ Mx⊗ Ky. A= M + ηK

= (Mx + ηKx) ⊗ (My + ηKy) − η2Kx ⊗ Ky =A − ˜˜ K

"

A˜ B BT 0

# "

r u

#

=

"

F +K˜r 0 ∗ u

#

(22) so we iterate

"

rk+1 uk+1

#

=

"

A˜ B BT 0

#−1"

F +K˜rk 0 ∗ uk

#

(23)

18 / 45

(19)

Towards iterative solver

Firstly, consider the residual error

rk = F − Awk − Buk = F + ˜K wk− ˜Awk− Buk,

sk = −BTwk. (24)

To minimize these residual-type error, we build a dual problem, which resembles the features of preconditioner.

"

A˜ B BT 0

# "

dk ck

#

=

"

rk sk

#

, (25)

Using (24), solving these equations gives

dk = ˜A−1(F + ˜K wk − Buk) − wk− ˜A−1Bck := ˜dk − wk− ˜A−1Bck,

BTA˜−1Bck = −BTd˜k + BTwk+ sk = −BT˜dk,

(26)

where the first equation is a primal update and the second equation is to be solved by a Conjugate-Gradient (CG) type method.

19 / 45

(20)

Inner loop

Initialize {q(0) = p(0) = ˜ck; u(0) = uk} for j = 1 until convergence

θ(j)= Bp(j); δ(j)= ˜A−1θ(j); α(j)= p(j), q(j)

θ(j), δ(j); u(j+1)= u(j)+ α(j)p(j); q(j+1)= q(j)− α(j)BTδ(j); β(j+1)= q(j+1), q(j+1)

q(j), q(j) ; p(j+1)= q(j+1)+ β(j+1)p(j);

Algorithm 1: Inner CG

20 / 45

(21)

Iterative solver

To determine the convergence, for the inner loop,

we iterate until α(j+1) ≤ tolerance. We denote this j as jc. The outer iteration calculates

ck = u(jc)− u(0); uk+1= u(jc);

wk+1= ˜dk+ ˜A−1Bck.

(27)

The outer iteration stops at ck+1 ≤ tolerance.

21 / 45

(22)

Towards iterative solver

Initialize {u(0) = 0; w(0)= 0}

for k = 1, ..., N until convergence Inner loop

ck = u(Nk)− u(0); uk+1= u(Nk);

wk+1= ˜dk+ ˜A−1Bck; k = k + 1;

d˜k+1=A˜−1(F + ˜K wk+1− Buk+1);

˜

ck+1= −BTd˜k+1.

Algorithm 2: Inner-Outer CG

22 / 45

(23)

isogeometric Residual Minimization Method

isoGeometric Residual Minimization Method (iGRM) Residual minimization

(unconditional stability in space)

Discretization with B-spline basis functions (higher continuity smooth solutions)

Kronecker product structure of the inner product matrix (linear cost O(N) preconditioner for iterative solver) Symmetric positive definite system

(convergence of the conjugated gradient method )

23 / 45

(24)

A manufactured solution problem: strong form

We focus on a model problem with a manufactured solution. For a unitary square domain Ω = (0, 1)2, the advection vector

β = (1, 1)T, and Pe = 100,  = 1/Pe we seek the solution of the advection-diffusion equation

∂u

∂x + ∂u

∂y −  2u

∂x2 +2u

∂y2

!

= f (28)

with Dirichlet boundary conditions u = g on the whole of Γ = ∂Ω.

We utilize a manufactured solution u(x , y ) = (x + ePe∗x − 1

1 − ePe )(y + ePe∗y − 1 1 − ePe )

enforced by the right-hand side, and we use homogeneous Dirichlet boundary conditions on ∂Ω.

24 / 45

(25)

A manufactured solution problem: weak form

b(u, v ) = l (v ) ∀v ∈ V (29) b(u, v ) =

∂u

∂x, v



+

∂u

∂y, v



+ 

∂u

∂x,∂v

∂x



+ 

∂u

∂y,∂v

∂y





∂u

∂xnx, v



Γ



∂u

∂yny, v



Γ

− (u, ∇v · n)Γ− (u, β · nv )Γu, 3p2/hv

Γ

n = (nx, ny) is versor normal to Γ, and h is element diameter, l (v ) = (f , v )− (g , ∇v · n)Γ− (g , β · nv )Γg , 3p2/hv

Γ (30) redterms correspond to weak imposition of the Dirichlet b.c. on Γ with g = 0, f is the manufactured solution, blueterms are the integration by parts,grayterms the penalty terms. We seek the solution in space U = V = H1(Ω). The inner product in V is

(u, v )V = (u, v )L

2+

∂u

∂x,∂v

∂x



L2

+

∂u

∂y,∂v

∂y



L2

(31)

25 / 45

(26)

A manufactured solution results

n trial(2,1) trial(3,2) trial(4,3) trial(5,4)

test(2,0) test(2,0) test(2,0) test(2,0)

#DOF 389 410 433 458

L2 192 151 78 28

H1 101 74 44 32

8 × 8

#DOF 1413 1450 1489 1530

L2 80 16 3.29 1.48

H1 59 29 18 10

16 × 16

#DOF 5381 5450 5521 5594

L2 32 1.33 0.27 0.056

H1 31 9.77 3.16 0.82

32 × 32

#DOF 20997 21130 21265 21402

L2 7.66 0.07 0.01 0.003

H1 9.86 1.67 0.26 0.068

64 × 64 26 / 45

(27)

Eriksson-Johnson problem strong form

Given Ω = (0, 1)2, β = (1, 0)T, we seek the solution of the advection-diffusion problem

∂u

∂x −  2u

∂x2 +2u

∂y2

!

= 0 (32)

with Dirichlet boundary conditions

u = 0 for x ∈ (0, 1), y ∈ {0, 1} u = sin(Πy ) for x = 0

The problem is driven by the inflow Dirichlet boundary condition.

It develops a boundary layer of width  at the outflow x = 1.

27 / 45

(28)

Eriksson-Johnson problem weak form

We introduce first the weak formulation for the Eriksson-Johnson problem

b(u, v ) = l (v ) ∀v ∈ V (33) b(u, v ) =

∂u

∂x, v

 + 

∂u

∂x,∂v

∂x

 + 

∂u

∂y,∂v

∂y





∂u

∂xnx, v



Γ



∂u

∂yny, v



Γ

− (u, ∇v · n)Γ− (u, β · nv )Γu, 3p2/hv

Γ

where theblue,red, andgrayterms correspond to the weak

imposition of the Dirichlet b.c. on the boundary Γ, and n = (nx, ny) is the versor normal to the boundary,

l (v ) =− (g , ∇v · n)Γ− (g , β · nv )Γg , 3p2/hv

Γ (34) where thered andgrayterms correspond to the weak introduction of the Dirichlet b.c. on the boundary Γ.

We plug the weak form and the inner product into the iGRM setup and we use the preconditioned CG solver. 28 / 45

(29)

Residual minimization method for Eriksson-Johnson problem

Find (rm, uh)Vm×Uh such as (rm, vm)Vm

∂uh

∂x , vm



− 

∂uh

∂x ,∂vm

∂x +∂uh

∂y ,∂vm

∂y



= (f , vm)

∀vm∈ Vm

∂wh

∂x , rm

 + 

∂wh

∂x ,∂rm

∂x +∂wh

∂y ,∂rm

∂y



= 0

∀wh∈ Uh where (rm, vm)Vm= (rm, vm) + (∂r∂xm,∂v∂xm) + (∂r∂ym,∂v∂ym)

is the H1 norm induced inner product.

Remark

We will use trial space Uh as quadratic B-splines with C1 continuity and test space Vh as cubic B-splines with C2 continuity

29 / 45

(30)

Numerical results for the Eriksson-Johnson problem

Figure:Left panel: Solution to the Erikkson-Johnsson problem with Galerkin method with = 10−2, with trial = test = quadratic B-splines on a uniform mesh of 20 × 20 elements. Right panel: Cross-section at y = 0.5.

30 / 45

(31)

Numerical results for the Eriksson-Johnson problem

Figure:Solution to the Erikkson-Johnsson problem withresidual minimization methodwith = 10−2, with trial = quadratic B-splines, test = cubic B-splines on a uniform mesh of 20 × 20 elements.

31 / 45

(32)

Numerical results for the Eriksson-Johnson problem

Figure:Cross-section at y = 0.5 of the solution to the Erikkson-Johnsson problem withresidual minimization methodwith = 10−2, with trial = quadratic B-splines, test = cubic B-splines

on a uniform mesh of 20 × 20 elements.

32 / 45

(33)

Numerical results for the Eriksson-Johnson problem

Figure:Zoom of the cross-section at y = 0.5 of the solution at (0.99,1.0) of the Erikkson-Johnsson problem withresidual minimization methodwith

 = 10−2, with trial = quadratic B-splines, test = cubic B-splines on a uniform mesh of 20 × 20 elements.

33 / 45

(34)

Eriksson-Johnson problem weak form, SUPG method

b(u, v ) +(R(u), τ β · ∇v )= l (v ) ∀v ∈ V (35) where R(u) = ∂u∂x + ∆u, andβhx

x +βhy

y

+ 3h21 x+h2y,

and in our case diffusion term  = 10−6, and convection term β = (1, 0), and hx and hy are dimensions of an element.

bSUPG(u, v ) = l (v ) ∀v ∈ V (36)

bSUPG(u, v ) =

∂u

∂x, v

 + 

∂u

∂x,∂v

∂x

 + 

∂u

∂y,∂v

∂y





∂u

∂xnx, v



Γ



∂u

∂yny, v



Γ

− (u, ∇v · n)Γ− (u, β · nv )Γu, 3p2/hv

Γ

+

∂u

∂x + ∆u, 1 hx

+ 3 1 h2x + hy2

!2

∂v

∂x

34 / 45

(35)

Numerical results for the Eriksson-Johnson problem

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(a)iGRM (2,1), (3,0) (b)iGRM

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(c)iGRM zoom

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(d)SUPG trial (3,2) (e)SUPG

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(f)SUPG zoom Figure:Comparison of solutions of the Erikkson-Johnsson by using iGRM and SUPG methods for Pe=1,000,000 on 2x2 mesh,

using (2,1) for trial and (3,0) for testing.

35 / 45

(36)

Numerical results for the Eriksson-Johnson problem

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(a)iGRM (2,1), (3,0) (b)iGRM

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(c)iGRM zoom

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(d)SUPG trial (3,2) (e)SUPG

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(f)SUPG zoom Figure:Comparison of solutions of the Erikkson-Johnsson by using iGRM and SUPG methods for Pe=10000 on 4x4 mesh,

using (2,1) for trial and (3,0) for testing.

36 / 45

(37)

Numerical results for the Eriksson-Johnson problem

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(a)iGRM (2,1), (3,0) (b)iGRM

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(c)iGRM zoom

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(d)SUPG trial (3,2) (e)SUPG

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(f)SUPG zoom Figure:Comparison of solutions of the Erikkson-Johnsson by using iGRM and SUPG methods for Pe=1,000,000 on 8x8 mesh,

using (2,1) for trial and (3,0) for testing.

37 / 45

(38)

Numerical results for the Eriksson-Johnson problem

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(a)iGRM (2,1), (3,0) (b)iGRM

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(c)iGRM zoom

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(d)SUPG trial (3,2) (e)SUPG

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(f)SUPG zoom Figure:Comparison of solutions of the Erikkson-Johnsson by using iGRM and SUPG methods for Pe=1,000,000 on 16x16 mesh,

using (2,1) for trial and (3,0) for testing.

38 / 45

(39)

Numerical results for the Eriksson-Johnson problem

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(a)iGRM (2,1), (3,0) (b)iGRM

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(c)iGRM zoom

0 0.2 0.4 0.6 0.8 1 1.2

0 0.2 0.4 0.6 0.8 1

(d)SUPG trial (3,2) (e)SUPG crossection

0 0.2 0.4 0.6 0.8 1 1.2

0.999990 0.999995 1

(f)SUPG crossection zoom

Figure:Comparison of solutions of the Erikkson-Johnsson by using iGRM and SUPG methods for Pe=1,000,000 on 32x32 mesh,

using (2,1) for trial and (3,0) for testing.

39 / 45

(40)

Erikkson-Johnson iterations

2 4 8 16 32

n 0

5 10 15 20

#ofouteriterations

2 4 8 16 32

n 0

50 100 150 200

#ofCGiterations

Figure:Left panel: Number of iterations of outer loop for. Right panel:

Number of iterations of inner loop (CG).

2 4 8 16 32

n 0.0

0.5 1.0 1.5 2.0 2.5 3.0

#ofouteriterations

Figure:Number of iterations of outer loop, with inner loop treated by

MUMPS solver. 40 / 45

(41)

Circular wind problem

βx∂u

∂x + βy∂u

∂y −  2u

∂x2 +2u

∂y2

!

= 0

over the rectangular domain Ω = (0, 1) × (−1, 1), with zero right-hand side f = 0, Pe = 1, 000, 000, the advection vector β(x , y ) = (βx(x , y ), βy(x , y )) = ψ( −y

(x2+y2)12, x

(x2+y2)12) modeling the circular wind, where ψ is the wind force coefficient.

Γ1 = {(x , y ) : x = 0, 0.5 ≤ y ≤ 1.0}, Γ2 = {(x , y ) : x = 0, 0.0 ≤ y ≤ 0.5}, Γ3 = {(x , y ) : x = 0, −0.5 ≤ y ≤ 0.0}, Γ4 = {(x , y ) : x = 0, −1.0 ≤ y ≤ −0.5},

We utilize the Dirichlet boundary conditions u = g on Γ = ∂Ω where g = 1

2

 tanh



(|y | − 0.35)b



 + 1



, for x ∈ Γ2∪ Γ3

g = 1 2



0.65 − tanh

 (|y |)b



 + 1



, for x ∈ Γ1∪ Γ4

g = 0, for x ∈ Γ \ Γ1∪ Γ2∪ Γ3∪ Γ4 41 / 45

(42)

Circular wind problem

The weak formulation

b(u, v ) = l (v ) ∀v ∈ V

b(u, v ) =

 βx∂u

∂x, v



+

 βy∂u

∂y, v



+ 

∂u

∂x,∂v

∂x



+ 

∂u

∂y,∂v

∂y





∂u

∂xnx, v



Γ



∂u

∂yny, v



Γ

− (u, ∇v · n)Γ− (u, β · nv )Γu, 3p2/hv

Γ

where n = (nx, ny) is the versor normal to Γ,

l (v ) =− (g , ∇v · n)Γ− (g , β · nv )Γg , 3p2/hv

Γ

n = (nx, ny) is the versor normal to the boundary, and the right-hand side forcing is equal to 0.

42 / 45

(43)

Circular wind problem

Figure:Solution to the circular wind problem on the mesh of 128 × 128 elements with trial(2,1),test(2,0), for Pecklet number Pe = 1, 000, 000, wind force b = 1. Horizontal cross-section at x = 0.

43 / 45

(44)

Conclusions and open questions

Conclusions

We use B-spline basis functions on tensor product patches of elements and we do not break the test spaces

We employ the residual minimization method with fixed trial space, and we enrich the test space to improve the stability To preserve the Kronecker product structure of the residual minimization system, we enrich the test space in the alternating direction manner (e.g. (3,2) for x direction, and (2, 3) for y direction) to preserve the Kronecker product structure of the matrix, and linear cost O(N) factorization For a linear cost O(N) Kronecker product precondtioner we can enrich the test space in arbitrary way, since we only need a Kronecker product structure of the Gramm matrix

Future work

Stokes, Oseen, Navier-Stokes and Maxwell equations This work is supported by National Science Centre, Poland grant

HARMONIA 2017/26/M/ST1/00281. 44 / 45

(45)

Papers

M. Los, Q.Deng, I. Muga, V.M.Calo, M. Paszynski, Isogeometric Residual Minimization Method (iGRM) with Direction Splitting Preconditoner for Stationary Advection-Diffusion Problems, submitted to Computer Methods in Applied Mechanics and Engineering (2019) IF: 4.441

Code based on:

M. Los, M. Wozniak, M. Paszynski, A. Lenharth, K. Pingali, IGA-ADS : Isogeometric Analysis FEM using ADS solver, Computer

& Physics Communications, 217 (2017), pp. 99-116 IF: 3.748

45 / 45

Cytaty

Powiązane dokumenty

A smaller time step or a higher polynomial degree is not always better for the overall error. The best solution, in

Once all u’s are determined, the regression-based selection method proposed in Khan, Katzoff and Kedem (2014) and Kedem (2016) is used to select significant terms within the

Ponieważ Paryż nie jest dla nich wyłącznie stoli- cą światowej przestrzeni literackiej, jaką historycznie rzecz biorąc, był dla wszystkich innych pisarzy, lecz pełni

The new approach to linear regression with multivariate splines results in a powerful new method for parameter estimation and system identification of complex time-variant

dują się trzy papierowe kodeksy z drugiej połowy XV wieku i „Sermones quadragesi- males&#34; Jakuba ze Śremu z pierwszej połowy XVI wieku, zawierające liczne glosy i zapiski

Po krótkiej przerwie rozpoczęto część drugą obrad, dotyczącą zarysu działalności instytutów świeckich w Kościele (w tym Instytutu Miłosierdzia Bożego),

Rocznik Towarzystwa Literackiego imienia Adama Mickiewicza 41,

Sesja odbyła się 30 IV 1998 г., a jej zadaniem było w świetle teologii religii omówienie podstawowych tema­ tów dokumentu „Chrześcijaństwo a religie&#34;.. Z kolei tenże