Xingye Yue. Soochow University, Suzhou, China.

Size: px
Start display at page:

Download "Xingye Yue. Soochow University, Suzhou, China."

Transcription

1 Relations between the multiscale methods p. 1/30 Relationships beteween multiscale methods for elliptic homogenization problems Xingye Yue Soochow University, Suzhou, China

2 Relations between the multiscale methods p. 2/30 Outline 1. A short Overview of Numerical Methods for Elliptic Homogenization Problems Generalized Finite Element Method (GFEM) by Babuska and Osborn 83 Residual Free Bubble Method (RFB) by F. Brezzi et al 94 Variational Multiscale Methods (VMS) by T. Hughes 95, 98 Multiscale Finite Element Method(MsFEM) by T. Hou et al 97 Heterogenous Multiscale Methods (HMM) by W. E and B. Engquist Intrinsic links between these multiscale methods

3 Relations between the multiscale methods p. 3/30 Model Problem Transport in strongly heterogeneous media Lu ε (k ε (x) u ε (x)) = f(x), x Ω. (1) u ε = 0 on Ω Assume that 0 < ε 1 and k ε (x) = k(x, x ) microscopic structure, ε oscillated everywhere.

4 Relations between the multiscale methods p. 4/30 Model Problem -2 For standard piecewise linear finite element method (FEM), the following error estimate holds u ε U FEM 1 Ch u ε 2 C h ε. If h ε, everything is OK. If we can not afford or do not want to afford h ε,? We maybe only care about the macro behavior. e.g. We care about the total production of oil. Don t care how the oil flows in the pore. So we need a multiscale algorithm. We only want to work on a coarse mesh h ε.

5 Relations between the multiscale methods p. 5/30 GFEM by Babuska and Osborn 83 Standard FEM variational form piecewise polynomial Generalized adapting the finite element space to the particular small scale features of the problem For one-dimensional problem, Find uε V = H 1 0 (0,1), a(u ε,v) (k ε u ε,v ) = (f,v), v V Standard FEM, Find uh S h = {v H 1 0 (0,1) v P 1(I j ),j = 1,2,...,N}, s.t. a(u h,v h ) = (f,v h ), v h S h GFEM: Find uh S h, s.t. a(au h, Av h ) = (f, Av h ), v h S h. For v h S h, w = Av h S h = A(S h ) is the solution of the local problems w H 1 0(0,1), Lw Ij = 0, w(x j ) = v h (x j ), w(x j+1 ) = v h (x j+1 ), j = 0,1,2,. A: reconstruction operator from coarse scale to micro scale.

6 Relations between the multiscale methods p. 6/30 GFEM by Babuska and Osborn 83 2 Standard FEM, Find uh S h = {v H 1 0 (0,1) v P 1(I j ),j = 1,2,...,N}, s.t. a(u h,v h ) = (f,v h ), v h S h GFEM: Find uh S h = A(S h ), s.t. a(u h,v h ) = (f,v h ), v h S h. Theorem For GFEM, if 0 < k0 k ε k 2, u ǫ u h 1 Ch f 0, no matter whether the solution u ε is smooth or not! But this is not true for multi-dimensional problems. Remark 1 : GFEM is equivalent to standard FEM, if k ε constant or piecewise constant. Remark 2 : Parallel implementation of local reconstruction.

7 Relations between the multiscale methods p. 7/30 MsFEM by Hou et al 97, 99, 00 Key idea : Construct the multiscale finite element basis instead of piecewise linear basis. For each triangle element T T h, the standard linear finite element space VL T = span{ϕ 1,ϕ 2,ϕ 3 } is replaced by VMS T = span{ψ 1,ψ 2,ψ 3 }: (k( x ε ) ψ j(x)) = 0, x T; (2) ψ j = ϕ j on x T Reconstruction operator: ψ j = R(ϕ j ). MsFEM (Simplest version) Find u ε h V MS = R(V h L ) s.t. a(uε h,v) (kε u ε h, v h) = (f,v h ) v h V MS Error estimate for periodic meida: u ε u ε h 1 C(h+ ε+ ε/h) First attempt for multi-dimension homogenization problems. Other versions of MsFEM, Over-sampling MsFEM A extension of GFEM from one-d to higher dimensional problem

8 Relations between the multiscale methods p. 8/30 Variational multiscale method (VMS) by Hughes 95 Scale Splitting: u = ū+u (Space splitting: H 1 0 (Ω) = V V ). where ū V coarse scale part and u V fine scale part. Weak form: Find u = ū+u such that a(u,v) (k ε u, v) = (f,v) v = v +v V V Split into two problems: Coarse Scale: a(ū+u, v) = (f, v) v V (3) Fine Scale: a(ū+u,v ) = (f,v ) v V (4) (4) yields the adjustment for the residual f Lū: (Lu,v ) = (f Lū,v ) v V Solve it to obtain u = M (f Lū). Substitute it into (3):

9 Relations between the multiscale methods p. 9/30 VMS 2nd The right model at the coarse scale: Find ū V, a(ū, v)+a(m (f Lū), v) = (f, v) v V Compare with the standard Galerkin model. Find ū V, a(ū, v) = (f, v) v V The operator M is global and needs to be approximated (localized) to obtain a practical coarse model. Bubble FEM is one of the choices.

10 Relations between the multiscale methods p. 10/30 Residaul-free bubble (RFB) FEM by Brezzi et al 94 Let Th be a triangulation of Ω: Ω = T T h T. Coarse space: VL h the conforming piecewise linear finite element space on T h. Bubble space : V B = T V b T, with V b T = H0 1(T). RFB FEM scheme (Fully analyzed at 99, 00 for convection-dominated problem) Find u h = u L +u b V h = V h L VB such that a(u h,v h ) = (f,v h ) v h = v L +v b V h = V h L VB Split into two problems: Coarse Scale: a(u L +u b,v L ) = (f,v L ) v L V h L (5) Fine Scale: a(u b,v b ) = (f Lu L,v b ) v b V b (6) For each element T T h, (6) is exactly the problem (parallel computing): Lu b = f Lu L, in T, u b = 0, on T Residual Free L(u L +u b ) f = 0, in T.

11 Relations between the multiscale methods p. 11/30 Heterogeneous Multiscale Methods (HMM) by W. E and B. Engquist 03 There are two main components in the heterogeneous multiscale method: An overall macroscopic scheme for the macro-scale variables on a macroscale grid Estimating the missing macroscopic data from the microscopic model. A simple version HMM scheme (E, Ming & Zhang 05): Find ul VL h such that a HMM (u L,v L ) T T T h K HMM u L v L dx = (f,v L ), v L V h L, (K HMM ) u L v L T = 1 I δ I δ k ε R(u L ) R(v L )dx, (7) where for any T T h, I δ T is the sampling window with size of δ, and for each v L V h L, the reconstruction operator R(v L) is defined by LR(v L ) (k ε R(v L )) = 0, in I δ, R(v L ) = v L, on I δ. (8)

12 Relations between the multiscale methods p. 12/30 HMM 2nd Adaptive sampling The size of δ can be chosen adaptively to take the full advantage of the scale separation (if it exists). It is possible that ε δ h. Almost Equivalent to MsFEM if one chooses Iδ = T. Find u L V h L such that T T T h k ε R(u L ) R(v L )dx = (f,v L ), v L V h L, Other choices of the reconstruction operator R. (E, Yue 07) Dirichlet Form, Neumann Form, Periodic Form, Multiscale principle: Information exchanges between macro and micro scales reconstruction vs compression

13 Relations between the multiscale methods p. 13/30 Classification of these multiscale methods 1. GFEM, MsFEM : modifying the finite element space to make the information in micro scale be involved. 2. VMS, RFB : scale splitting, V = V V 3. HMM : choosing proper macro model and macro solver, estimating the missing data from local micro solver. - The philosophy is very general and totally different. Relations between them??

14 Relations between the multiscale methods p. 14/30 Relations between these multiscle methods Generalized FEM (GFEM) 83 vs Multiscale FEM (MsFEM) 97 GFEM: Find uh S h, s.t. a(u h,v h ) = (f,v h ), v h S h. where S h = A(S h ),S h is the standard FEM space. A reconstruction operator: for v h S h, LA(v h ) Ij = 0, A(v h )(x j ) = v h (x j ), A(v h )(x j+1 ) = v h (x j+1 ), j = 0,1,2,,. MsFEM (Simplest version) Find u ε h V MS s.t. a(u ε h,v) (kε u ε h, v h) = (f,v h ) v h V MS We can also write V MS = A(S h ). MsFEM is a extension of GFEM from one-d to higher dimensional preblem.

15 Relations between the multiscale methods p. 15/30 VMS 95 vs RFB 94 Variational multiscale methods (VMS): Find u = ū+u H 1 0 (Ω) = V V such that a(u,v) (k ε u, v) = (f,v) v = v +v V V Residual-free bubble (RFB) FEM: Find uh = u L +u b V h = V h L VB such that a(u h,v h ) = (f,v h ) v h = v L +v b V h = V h L VB Bubble space : V B = T V T b, with V T b = H 1 0 (T). RFB is a localization strategy for VMS.

16 Relations between the multiscale methods p. 16/30 RFB vs MsFEM For MsFEM solution u ε h V MS, Lu ε h = 0, in T. For RFB solution uh = u L +u b, L(u L +u b ) = f, in T. There is a clear difference!! But for u ε h V MS, u ε h = u L +(u ε h u L), and u ε h u L V B = T V b T, with V b T = H0 1 (T) is exactly a local bubble. Split the bubble into two parts ub = M 0 (u L )+M(f), such that intrinsic part: M 0 (u L ) V B, L(u L +M 0 (u L )) = 0, in T T h. external part: M(f) V B, L(M(f)) = f, in T T h. Key point: The effect of M(f) can be canceled in the coarse scale model.

17 Relations between the multiscale methods p. 17/30 RFB vs MsFEM 2nd Recall RFB FEM scheme a(u L +M 0 (u L )+M(f),v L ) = (f,v L ) v L V h L a(u L +M 0 (u L )+M(f),v b ) = (f,v b ) v b V b (9) Setting v b = M 0 (v L ) in the second formula, then taking the summation, a(u L +M 0 (u L )+M(f),v L +M 0 (v L )) = (f,v L +M 0 (v L )) v L V h L Noting that if the coefficient tensor k( x ) is symmetric, ε a(m(f),v L +M 0 (v L )) = a(v L +M 0 (v L ),M(f)) = 0. The coarse scale model is (Nolen, Papanicolaou, Pironneau 07) a(u L +M 0 (u L ),v L +M 0 (v L )) = (f,v L +M 0 (v L )) v L V h L.

18 Relations between the multiscale methods p. 18/30 RFB vs MsFEM 3nd The reconstruction operator is now : R(vL ) v L +M 0 (v L ). And the multiscale basis functions such that ψ i = R(φ i ) = φ i +M 0 (φ i ). Then the coarse scale model of RFB: Find u L VL h such that T T T h k ε R(u L ) R(v L )dx = (f,r(v L )), v L V h L, The coarse scale model of RFB is equivalent to MsFEM (simplest version). In another form: Find ũh R(VL h ) such that T T T h k ε ũ h v h dx = (f,v h ), v h R(V h L ), The solution of RFB uh satisfies that u h = u L +M 0 (u L )+M(f) = u ε h +M(f), where u ε h is the solution of MsFEM.

19 Relations between the multiscale methods p. 19/30 RFB vs MsFEM 4nd Local reconstruction: Lu h = f, in T, u h = u ε h, on T. Proposition. Under the assumption that the coefficient k ε is symmetric, let u h = u C +M 0 (u C )+M(f) be the RFB solution and u ε h be the MsFEM solution. Then we have u ε h = u C +M 0 (u C ), and the induced coarse scale model of RFB scheme is equivalent to the MsFEM scheme. Furthermore, the RFB solution u h can be obtained from the MsFEM solution u ε h by the local reconstruction. Remark. Local reconstruction is a common strategy for multiscale simulation: one first solves the macro model on the coarse scale mesh, then solves the original problems locally on the fine scale, over some local regions where the details in fine scale are interesting, using the coarse scale solution as the boundary condition (Oden, Vemaganti 00).

20 Relations between the multiscale methods p. 20/30 Adaptive sampling RFB vs HMM Revisit the Bubble FEM Set R(u L ) = u L +M 0 (u L ). The coarse scale model of RFB is as : Find u L V h L, a(r(u L),R(v L )) = (f,r(v L )) v L V h L. i.e. T T K h u L v L dx = Ω f R(v L )dx, v L V h L where (K h ) ij T = 1 T T k ε R(x i ) R(x j )dx. Remark: G. Sangalli (MMS 03) obtained this result under the assumption that the source term f is piecewise constant. This means to take the whole element T as the sampling window. If there exists scale separation, instead of the whole element, can we take a smaller region as the sampling window?

21 Relations between the multiscale methods p. 21/30 Adaptive sampling 2 Let s reformulate the RFB FEM scheme First set the bubble space as: V B = T V T b, with V T b = H 1 0 (I δ) (I δ T with size of δ) for each element T. For v L V h L, M0 (v L ) is defined now as M 0 (v L ) V B, a(v L +M 0 (v L ),v) = 0, v H 1 0(I δ ), T T h, then extending to the whole element T by 0. Denote by the reconstruction operator R(v L ) = v L +M 0 (v L ) for all v L VL h. Then define a new RFB Scheme as: Find ul VL h such that a(r(u L ),R(v L )) = (f,r(v L )) v L V h L The coarse scale equation can be rewritten now as: Find ul V h L such that a (u L,v L ): = T T H T K h u L v L dx = (f,r(v L )) v L V h L, with (K h ) ij T = 1 T T k ε R(x i ) R(x j )dx.

22 Relations between the multiscale methods p. 22/30 Adaptive sampling 3 Does this still give a right macro-scale model? First let s go back to original RFB (or MsFEM) scheme and standard Galerkin scheme. RFB (or MsFEM) scheme : Iδ = T. It does work. a(u L +M 0 (u L ),v L ) = (f,v L +M 0 (v L )) v L V h L. If we neglect the effect of M 0 (u L ) and M 0 (v L ), we get the standard Galerkin finite element scheme on the coarse scale of h(> ε). Standard Galerkin : Iδ = φ It fails. a(u L,v L ) = (f,v L ) v L V h L. This is a wrong coarse scale model. In fact, in this case the effective coefficient is defined as K T =< k ε > T = 1 k ε (x)dx. T T

23 Relations between the multiscale methods p. 23/30 Adaptive sampling 4 The reason is that although the fine scale bubble M 0 (u L ) is negligible when compared to the coarse scale function u L, this is not the case for M 0 (u L ), which is comparable to u L. On the other hand, we denote by a(u L +M 0 (u L ),v L ) = (k ε u L +k ε M 0 (u L ))dx v L T T T (q L +q F )dx v L T. T T The macro mass or energy flux q L and micro flux q F are comparable. Neglecting of the micro mass flux q F will lead to the failure of mass balance. For an effective media with coefficient K, we must have the balance: K < u ε > T =< k ε u ε > T for any proper micro state u ε.

24 Relations between the multiscale methods p. 24/30 Adaptive sampling 5 From these points of view, we will see that in the new scheme, only part of micro mass flux on I δ is included. So we can not expect the balance of mass. We should modify the bubble function to meet the balance. If the size of the sample I δ is properly chosen, the average flux (or flux density ) < q F > δ = 1 I δ I k ε M 0 δ δ (u L)dx would be accurate enough. Therefore the modified bubble function M 0 δ (u L) should satisfy that 1 T T k ε M 0 δ (u L)dx = 1 I δ I δ k ε M 0 δ (u L)dx. A simplest choice is M 0 δ (v L) = T I δ M0 δ (v L), for any v L V h L. (10) Then the coarse scale model for adaptive RFB scheme reads: Find u L VL h, such that a(u L + M 0 δ (u L),v L ) = (f,v L + M 0 δ (v L)), v L V h L. (11)

25 Relations between the multiscale methods p. 25/30 Adaptive sampling 6 Equivalently, we rewritten (11) as : Find ul VL h, such that a (u L,v L ) T T H T K h u L v L dx = (f, R(v L )), v L V h L,(12) with (K h ) ij T = 1 T where in each element T, R(vL ) = v L V h L. T k ε R(x i ) x j dx, (13) v L, x I δ, v L + M 0 δ (v L), x I δ, for any

26 Relations between the multiscale methods p. 26/30 Adaptive sampling 7 Modeling error for periodic media between this scheme and the HMM K h K HMM = < kε > T < k ε > Iδ C(ε/h+ε/δ) Modeling error for HMM (E,Ming, Zhang 05) K KHMM C(ε/δ +δ), where K is the homogenized coefficient. Remark The scheme is slightly different with the HMM: they test the right hand side in different ways. Precisely, in the right hand side of HMM scheme, only coarse scale test functions are used, while in adaptive RFB scheme, multiscale test functions are used. If the right hand side term f does contain micro information: to which I mean that we only have f f 0 weakly in H 1, as ε 0, for example f = f ε (x) with f ε = f(x/ε) R n and f(y) be periodic, the multiscale test functions at the right hand side will play a key role to capture the micro scale information. (Yu, Yue 2011)

27 Relations between the multiscale methods p. 27/30 HMM vs VMS Nordbotten 09 HMM (original form. E, Engquist 03) Variational problem : minv V J(v) = 1 2 a(v,v) (f,v). HMM components: Selecting a macro model and a macro solver, estimating the missing data from micro model. Macro solver: min v D V D J D (v D ), V D is the coarse scale FEM space. If we solve directly min v D V D J(v D ), that is the standard Ritz FEM equivalent to Galerkin FEM. It doss not work on coarse scale. How to define the macroscopic energy density JD (v D ) for any macro displacement v D V D?

28 Relations between the multiscale methods p. 28/30 HMM vs VMS 2 Let Q : V VD to be the compression operator, then the coarse scale energy functional: J D (v D ) = min v:qv=v D J(v), its solution (the minimizer) is denoted by Rv D reconstruction operator. RuD is the exact solution, if u D is the minimizer of J D (v D ). So, HMM scheme is Or, min v V min v D V D J D (v D ) = J(Rv D ). J(v) = min v D V D min v:qv=v D J(v).

29 Relations between the multiscale methods p. 29/30 HMM vs VMS 3 Recall the VMS scheme. Scale Splitting: u = ū+u (Space splitting: V = V V ). Original weak form: Find u = ū+u such that Coarse Scale: a(ū+u, v) = (f, v) v V (14) Fine Scale: a(ū+u,v ) = (f,v ) v V (15) Reconstruction operator : R1 ū = ū+u, then equivalently, Coarse Scale: Fine Scale: min v V J(R 1 v), (16) R 1 v = arg min J(v), (17) v:pv= v P : V V is the projection operator. If we set VD = V, Q = P, then R = R 1. VMS is a special case of HMM.

30 Relations between the multiscale methods p. 30/30 Thank you! Thank you!

ON A PRIORI ERROR ANALYSIS OF FULLY DISCRETE HETEROGENEOUS MULTISCALE FEM

ON A PRIORI ERROR ANALYSIS OF FULLY DISCRETE HETEROGENEOUS MULTISCALE FEM MULTISCALE MODEL. SIMUL. Vol. 4, No. 2, pp. 447 459 c 2005 Society for Industrial and Applied Mathematics ON A PRIORI ERROR ANALYSIS OF FULLY DISCRETE HETEROGENEOUS MULTISCALE FEM ASSYR ABDULLE Abstract.

More information

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Part IV Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

More information

HETEROGENEOUS MULTISCALE METHOD IN EDDY CURRENTS MODELING

HETEROGENEOUS MULTISCALE METHOD IN EDDY CURRENTS MODELING Proceedings of ALGORITMY 2009 pp. 219 225 HETEROGENEOUS MULTISCALE METHOD IN EDDY CURRENTS MODELING JÁN BUŠA, JR. AND VALDEMAR MELICHER Abstract. The induction of eddy currents in a conductive piece is

More information

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems Basic Concepts of Adaptive Finite lement Methods for lliptic Boundary Value Problems Ronald H.W. Hoppe 1,2 1 Department of Mathematics, University of Houston 2 Institute of Mathematics, University of Augsburg

More information

Multiscale Computation for Incompressible Flow and Transport Problems

Multiscale Computation for Incompressible Flow and Transport Problems Multiscale Computation for Incompressible Flow and Transport Problems Thomas Y. Hou Applied Mathematics, Caltech Collaborators: Y. Efenidev (TAMU), V. Ginting (Colorado), T. Strinopolous (Caltech), Danping

More information

FINITE ELEMENT HETEROGENEOUS MULTISCALE METHODS WITH NEAR OPTIMAL COMPUTATIONAL COMPLEXITY

FINITE ELEMENT HETEROGENEOUS MULTISCALE METHODS WITH NEAR OPTIMAL COMPUTATIONAL COMPLEXITY FINITE ELEMENT HETEROGENEOUS MULTISCALE METHODS WITH NEAR OPTIMAL COMPUTATIONAL COMPLEXITY ASSYR ABDULLE AND BJORN ENGQUIST Abstract. This paper is concerned with a numerical method for multiscale elliptic

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

More information

NUMERICAL METHODS FOR MULTISCALE ELLIPTIC PROBLEMS

NUMERICAL METHODS FOR MULTISCALE ELLIPTIC PROBLEMS NUMERICAL METODS FOR MULTISCALE ELLIPTIC PROBLEMS PINGBING MING AND XINGYE YUE Abstract. We present an overview of the recent development on numerical methods for elliptic problems with multiscale coefficients.

More information

On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations

On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations Lutz Tobiska Institut für Analysis und Numerik Otto-von-Guericke-Universität

More information

A posteriori error estimation in the FEM

A posteriori error estimation in the FEM A posteriori error estimation in the FEM Plan 1. Introduction 2. Goal-oriented error estimates 3. Residual error estimates 3.1 Explicit 3.2 Subdomain error estimate 3.3 Self-equilibrated residuals 3.4

More information

Numerical Simulation of Flows in Highly Heterogeneous Porous Media

Numerical Simulation of Flows in Highly Heterogeneous Porous Media Numerical Simulation of Flows in Highly Heterogeneous Porous Media R. Lazarov, Y. Efendiev, J. Galvis, K. Shi, J. Willems The Second International Conference on Engineering and Computational Mathematics

More information

The Numerical Accuracy Analysis of Asymptotic Homogenization Method and Multiscale Finite Element Method for Periodic Composite Materials

The Numerical Accuracy Analysis of Asymptotic Homogenization Method and Multiscale Finite Element Method for Periodic Composite Materials Copyright 2016 Tech Science Press CMES, vol.111, no.5, pp.395-419, 2016 The Numerical Accuracy Analysis of Asymptotic Homogenization Method and Multiscale Finite Element Method for Periodic Composite Materials

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

More information

Multiscale Finite Element Methods. Theory and

Multiscale Finite Element Methods. Theory and Yalchin Efendiev and Thomas Y. Hou Multiscale Finite Element Methods. Theory and Applications. Multiscale Finite Element Methods. Theory and Applications. October 14, 2008 Springer Dedicated to my parents,

More information

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Finite Element Methods Michael Bader Technical University of Munich Summer 2016 Part I Looking Back: Discrete Models for Heat Transfer and the Poisson Equation Modelling

More information

ANALYSIS OF THE HETEROGENEOUS MULTISCALE METHOD FOR ELLIPTIC HOMOGENIZATION PROBLEMS

ANALYSIS OF THE HETEROGENEOUS MULTISCALE METHOD FOR ELLIPTIC HOMOGENIZATION PROBLEMS JOURNAL OF THE AMERICAN MATHEMATICAL SOCIETY Volume 00, Number 0, Pages 000 000 S 0894-0347XX0000-0 ANALYSIS OF THE HETEROGENEOUS MULTISCALE METHOD FOR ELLIPTIC HOMOGENIZATION PROBLEMS WEINAN E, PINGBING

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods

More information

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

Multiscale Methods for Multiphase Flow in Porous Media

Multiscale Methods for Multiphase Flow in Porous Media Multiscale Methods for Multiphase Flow in Porous Media Jan M. Nordbotten Department of Mathematics, University of Bergenjan.nordbotten@math.uib.no Department of Civil and Environmental Engineering, Princeton

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

Mixed Multiscale Methods for Heterogeneous Elliptic Problems

Mixed Multiscale Methods for Heterogeneous Elliptic Problems Mixed Multiscale Methods for Heterogeneous Elliptic Problems Todd Arbogast Abstract We consider a second order elliptic problem written in mixed form, i.e., as a system of two first order equations. Such

More information

Operator Upscaling for the Wave Equation

Operator Upscaling for the Wave Equation Operator Upscaling for the Wave Equation Tetyana Vdovina Susan E. Minkoff UMBC), Oksana Korostyshevskaya Department of Computational and Applied Mathematics Rice University, Houston TX vdovina@caam.rice.edu

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

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

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

TRANSPORT IN POROUS MEDIA

TRANSPORT IN POROUS MEDIA 1 TRANSPORT IN POROUS MEDIA G. ALLAIRE CMAP, Ecole Polytechnique 1. Introduction 2. Main result in an unbounded domain 3. Asymptotic expansions with drift 4. Two-scale convergence with drift 5. The case

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow Homogenization and numerical Upscaling Unsaturated flow and two-phase flow Insa Neuweiler Institute of Hydromechanics, University of Stuttgart Outline Block 1: Introduction and Repetition Homogenization

More information

Colloids transport in porous media: analysis and applications.

Colloids transport in porous media: analysis and applications. Colloids transport in porous media: analysis and applications. Oleh Krehel joint work with Adrian Muntean and Peter Knabner CASA, Department of Mathematics and Computer Science. Eindhoven University of

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction The a posteriori error estimation of finite element approximations of elliptic boundary value problems has reached

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis.

Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis. Universal Scalable Robust Solvers from Computational Information Games and fast eigenspace adapted Multiresolution Analysis Houman Owhadi Joint work with Clint Scovel IPAM Apr 3, 2017 DARPA EQUiPS / AFOSR

More information

Hierarchical Modeling of Heterogeneous Plates 1

Hierarchical Modeling of Heterogeneous Plates 1 TEMA Tend. Mat. Apl. Comput., 8, No. 2 (27), 219-228. c Uma Publicação da Sociedade Brasileira de Matemática Aplicada e Computacional. Hierarchical Modeling of Heterogeneous Plates 1 A.C. CARIUS 2, A.L.

More information

Nonparametric density estimation for elliptic problems with random perturbations

Nonparametric density estimation for elliptic problems with random perturbations Nonparametric density estimation for elliptic problems with random perturbations, DqF Workshop, Stockholm, Sweden, 28--2 p. /2 Nonparametric density estimation for elliptic problems with random perturbations

More information

(a ε (x) u ε (x))=f(x) in D R d, (1.1) is assumed to have bounded measurable entries, i.e., a ε ijξ i ξ j

(a ε (x) u ε (x))=f(x) in D R d, (1.1) is assumed to have bounded measurable entries, i.e., a ε ijξ i ξ j HETEROGENEOUS MULTISCALE FINITE ELEMENT METHOD WITH NOVEL NUMERICAL INTEGRATION SCHEMES RUI DU AND PINGBING MING Abstract. In this paper we introduce two novel numerical integration schemes, within the

More information

A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS. 1. Introduction

A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS. 1. Introduction A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS CHRISTOPHER HARDER, DIEGO PAREDES 2, AND FRÉDÉRIC VALENTIN Abstract. We aim at proposing novel

More information

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

More information

arxiv: v2 [math.na] 23 Apr 2016

arxiv: v2 [math.na] 23 Apr 2016 Improved ZZ A Posteriori Error Estimators for Diffusion Problems: Conforming Linear Elements arxiv:508.009v2 [math.na] 23 Apr 206 Zhiqiang Cai Cuiyu He Shun Zhang May 2, 208 Abstract. In [8], we introduced

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS COMM. MATH. SCI. Vol. 2, No. 4, pp. 553 589 c 2004 International Press MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS Y. EFENDIEV, T. HOU, AND V. GINTING Abstract. In this

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

New DPG techniques for designing numerical schemes

New DPG techniques for designing numerical schemes New DPG techniques for designing numerical schemes Jay Gopalakrishnan University of Florida Collaborator: Leszek Demkowicz October 2009 Massachusetts Institute of Technology, Boston Thanks: NSF Jay Gopalakrishnan

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Multiscale methods for time-harmonic acoustic and elastic wave propagation

Multiscale methods for time-harmonic acoustic and elastic wave propagation Multiscale methods for time-harmonic acoustic and elastic wave propagation Dietmar Gallistl (joint work with D. Brown and D. Peterseim) Institut für Angewandte und Numerische Mathematik Karlsruher Institut

More information

A model order reduction technique for speeding up computational homogenisation

A model order reduction technique for speeding up computational homogenisation A model order reduction technique for speeding up computational homogenisation Olivier Goury, Pierre Kerfriden, Wing Kam Liu, Stéphane Bordas Cardiff University Outline Introduction Heterogeneous materials

More information

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation Chapter 12 Partial di erential equations 12.1 Di erential operators in R n The gradient and Jacobian We recall the definition of the gradient of a scalar function f : R n! R, as @f grad f = rf =,..., @f

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

The Mortar Boundary Element Method

The Mortar Boundary Element Method The Mortar Boundary Element Method A Thesis submitted for the degree of Doctor of Philosophy by Martin Healey School of Information Systems, Computing and Mathematics Brunel University March 2010 Abstract

More information

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information

NUMERICAL JUSTIFICATION OF ASYMPTOTIC EDDY CURRENTS MODEL FOR HETEROGENEOUS MATERIALS

NUMERICAL JUSTIFICATION OF ASYMPTOTIC EDDY CURRENTS MODEL FOR HETEROGENEOUS MATERIALS Proceedings of ALGORITMY 2009 pp. 212 218 NUMERICAL JUSTIFICATION OF ASYMPTOTIC EDDY CURRENTS MODEL FOR HETEROGENEOUS MATERIALS V. MELICHER AND J.BUŠA JR. Abstract. We study electromagnetic properties

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

Applications of the periodic unfolding method to multi-scale problems

Applications of the periodic unfolding method to multi-scale problems Applications of the periodic unfolding method to multi-scale problems Doina Cioranescu Université Paris VI Santiago de Compostela December 14, 2009 Periodic unfolding method and multi-scale problems 1/56

More information

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Abstract and Applied Analysis Volume 212, Article ID 391918, 11 pages doi:1.1155/212/391918 Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Chuanjun Chen

More information

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

More information

Heterogeneous Multiscale Methods: A Review

Heterogeneous Multiscale Methods: A Review COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol. 2, No. 3, pp. 367-45 Commun. Comput. Phys. June 27 REVIEW ARTICLE Heterogeneous Multiscale Methods: A Review Weinan E 1,, Bjorn Engquist 2, Xiantao Li 3, Weiqing

More information

Introduction to Multiscale Modeling

Introduction to Multiscale Modeling Introduction to Multiscale Modeling Bjorn Engquist University of Texas at Austin Summer School on Multiscale Modeling and Analysis, University of Texas at Austin, July 21 - August 8, 2008 Outline I Overview

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

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering University of Liège Aerospace & Mechanical Engineering Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE Van Dung NGUYEN Innocent NIYONZIMA Aerospace & Mechanical engineering

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

Multigrid Methods for Maxwell s Equations

Multigrid Methods for Maxwell s Equations Multigrid Methods for Maxwell s Equations Jintao Cui Institute for Mathematics and Its Applications University of Minnesota Outline Nonconforming Finite Element Methods for a Two Dimensional Curl-Curl

More information

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence 1 CONVERGENCE THEOR G. ALLAIRE CMAP, Ecole Polytechnique 1. Maximum principle 2. Oscillating test function 3. Two-scale convergence 4. Application to homogenization 5. General theory H-convergence) 6.

More information

CIMPA Summer School on Current Research in Finite Element Methods

CIMPA Summer School on Current Research in Finite Element Methods CIMPA Summer School on Current Research in Finite Element Methods Local zooming techniques for the finite element method Alexei Lozinski Laboratoire de mathématiques de Besançon Université de Franche-Comté,

More information

c 2014 Society for Industrial and Applied Mathematics

c 2014 Society for Industrial and Applied Mathematics MULTISCALE MODEL. SIMUL. Vol. 12, No. 4, pp. 1424 1457 c 2014 Society for Industrial and Applied Mathematics A COMBINED FINITE ELEMENT AND MULTISCALE FINITE ELEMENT METHOD FOR THE MULTISCALE ELLIPTIC PROBLEMS

More information

Discretization Methods Exercise # 5

Discretization Methods Exercise # 5 Discretization Methods Exercise # 5 Static calculation of a planar truss structure: a a F Six steps: 1. Discretization 2. Element matrices 3. Transformation 4. Assembly 5. Boundary conditions 6. Solution

More information

Approximation in Banach Spaces by Galerkin Methods

Approximation in Banach Spaces by Galerkin Methods 2 Approximation in Banach Spaces by Galerkin Methods In this chapter, we consider an abstract linear problem which serves as a generic model for engineering applications. Our first goal is to specify the

More information

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

On heterogeneous coupling of multiscale methods for problems with and without scale separation

On heterogeneous coupling of multiscale methods for problems with and without scale separation Abdulle and Jecker Res Math Sci (2017)4:28 https://doi.org/10.1186/s40687-017-0118-9 R E S E A R C H Open Access On heterogeneous coupling of multiscale methods for problems with and without scale separation

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER QUADRILATERAL MESHES. Zhong-Ci Shi and Xuejun Xu.

THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER QUADRILATERAL MESHES. Zhong-Ci Shi and Xuejun Xu. DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS SERIES B Volume 9, Number, January 2008 pp. 63 82 THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER

More information

A posteriori error estimation of approximate boundary fluxes

A posteriori error estimation of approximate boundary fluxes COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2008; 24:421 434 Published online 24 May 2007 in Wiley InterScience (www.interscience.wiley.com)..1014 A posteriori error estimation

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

New class of finite element methods: weak Galerkin methods

New class of finite element methods: weak Galerkin methods New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on

More information

A generalized finite element method for linear thermoelasticity

A generalized finite element method for linear thermoelasticity Thesis for the Degree of Licentiate of Philosophy A generalized finite element method for linear thermoelasticity Anna Persson Division of Mathematics Department of Mathematical Sciences Chalmers University

More information

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM A BIVARIAE SPLINE MEHOD FOR SECOND ORDER ELLIPIC EQUAIONS IN NON-DIVERGENCE FORM MING-JUN LAI AND CHUNMEI WANG Abstract. A bivariate spline method is developed to numerically solve second order elliptic

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION A DISCONTINUOUS GALERIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION GRÉGORY GUYOMARC H AND CHANG-OC LEE Abstract. We present a discontinuous Galerkin (DG) method to solve

More information

A stochastic mixed finite element heterogeneous multiscale method for flow in porous media

A stochastic mixed finite element heterogeneous multiscale method for flow in porous media A stochastic mixed finite element heterogeneous multiscale method for flow in porous media Xiang Ma, Nicholas Zabaras Materials Process Design and Control Laboratory, Sibley School of Mechanical and Aerospace

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS CARLO LOVADINA AND ROLF STENBERG Abstract The paper deals with the a-posteriori error analysis of mixed finite element methods

More information

A Multiscale DG Method for Convection Diffusion Problems

A Multiscale DG Method for Convection Diffusion Problems A Multiscale DG Method for Convection Diffusion Problems Annalisa Buffa Istituto di Matematica Applicata e ecnologie Informatiche - Pavia National Research Council Italy Joint project with h. J.R. Hughes,

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics

MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Mathematics Institute of Computational Science and Engineering School of Basic Sciences - Section of Mathematics MATHICSE Technical Report Nr. 19.2011 May 2011 Coupling heterogeneous multiscale

More information

NUMERICAL EVALUATION OF FEM WITH APPLICATION TO THE 1-D ADVECTION DIFFUSION PROBLEM

NUMERICAL EVALUATION OF FEM WITH APPLICATION TO THE 1-D ADVECTION DIFFUSION PROBLEM Mathematical Models and Methods in Applied Sciences Vol. 12, No. 2 (22) 25 228 c World Scientific Publishing Company NUMERICAL EVALUATION OF FEM WITH APPLICATION TO THE 1-D ADVECTION DIFFUSION PROBLEM

More information

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Shiming Yang and Matthias K. Gobbert Abstract. The convergence order of finite elements is related to the polynomial order

More information

Weak Galerkin Finite Element Methods and Applications

Weak Galerkin Finite Element Methods and Applications Weak Galerkin Finite Element Methods and Applications Lin Mu mul1@ornl.gov Computational and Applied Mathematics Computationa Science and Mathematics Division Oak Ridge National Laboratory Georgia Institute

More information

BACKGROUNDS. Two Models of Deformable Body. Distinct Element Method (DEM)

BACKGROUNDS. Two Models of Deformable Body. Distinct Element Method (DEM) BACKGROUNDS Two Models of Deformable Body continuum rigid-body spring deformation expressed in terms of field variables assembly of rigid-bodies connected by spring Distinct Element Method (DEM) simple

More information

Numerical Homogenization of Partial Differential Equations

Numerical Homogenization of Partial Differential Equations Daniel Peterseim Numerical Homogenization of Partial Differential Equations Lecture notes for participants of the Winter School on Numerical Analysis of Multiscale Problems, Hausdorff Insitut of Mathematics

More information

Duality-based adaptivity in finite element discretization of heterogeneous multiscale problems

Duality-based adaptivity in finite element discretization of heterogeneous multiscale problems J. Numer. Math., Vol. 0, No. 0, pp. 1 29 (2016) DOI 10.1515/ JNUM.2016.000 c de Gruyter 2016 Prepared using jnm.sty [Version: 20.02.2007 v1.3] Duality-based adaptivity in finite element discretization

More information

Convergence and optimality of an adaptive FEM for controlling L 2 errors

Convergence and optimality of an adaptive FEM for controlling L 2 errors Convergence and optimality of an adaptive FEM for controlling L 2 errors Alan Demlow (University of Kentucky) joint work with Rob Stevenson (University of Amsterdam) Partially supported by NSF DMS-0713770.

More information