DarcyLite: A Matlab Toolbox for Darcy Flow Computation

Size: px
Start display at page:

Download "DarcyLite: A Matlab Toolbox for Darcy Flow Computation"

Transcription

1 Procedia Computer Science Volume 8, 216, Pages ICCS 216. Te International Conference on Computational Science DarcyLite: A Matlab Toolbox for Darcy Flow Computation Jiangguo Liu 1, Farra Sadre-Marandi 2, and Zuoran Wang 3 1 Department of Matematics, Colorado State University (USA), liu@mat.colostate.edu 2 Matematical Biosciences Institute, Oio State University (USA), sadre.1@mbi.osu.edu 3 Department of Matematics, Colorado State University (USA), wangz@mat.colostate.edu Abstract DarcyLite is a Matlab toolbox for numerical simulations of flow and transport in 2-dim porous media. Tis paper focuses on te finite element (F) metods and te corresponding code modules in DarcyLite for solving te Darcy equation. Specifically, four major types of finite element solvers, te continuous Galerkin (CG), te discontinuous Galerkin (DG), te weak Galerkin (WG), and te mixed finite element metods (MFM), are examined. Furtermore, overall design and implementation strategies in DarcyLite are discussed. Numerical results are included to demonstrate te usage and performance of tis toolbox. Keywords: Darcy flow, Flow in porous media, Mixed finite element metods, Weak Galerkin 1 Introduction Te Darcy s law is a fundamental equation for modeling flow in porous media. It is usually furter coupled wit transport equations. Two examples amongst te vast applications in tis regard are oil recovery in petroleum reservoirs [4, 1, 13] and drug delivery to tumors. fficient and robust Darcy solvers are needed for transport simulators [6]. Tere exist many finite element solvers for te Darcy equation, or more generally second order elliptic boundary value problems, e.g., te continuous Galerkin finite element metods [5], te discontinuous Galerkin finite element metods [2], te enanced Galerkin (G) finite element metods [13], te mixed finite element metods [7], and te newly developed weak Galerkin finite element metods [1, 16]. Tese types of finite element metods ave distinctive features in addition to certain common features. Different finite element solvers migt be favored by different users and/or applications. Teir implementations sare some common strategies but also need different treatments [11]. Based on tese considerations, we ave developed DarcyLite, a Matlab toolbox tat contains solvers for te Darcy equation and concentration transport equations. Matlab is cosen as te programming language, due to its popularity, easiness for coding, and integrated All tree autors were partially supported by US National Science Foundation Grant DMS Selection and peer-review under responsibility of te Scientific Programme Committee of ICCS 216 c Te Autors. Publised by lsevier B.V. 131 doi:116/j.procs

2 grapics functionalities. Tis toolbox is easy to use and efficiently solves medium-size 2-dim flow and transport problems. It is expandable. Tis allows incorporation of oter (new) types of solvers for flow and transport problems. But tis paper focuses on te Darcy solvers. In tis paper, we discuss mainly four finite element solvers (CG, DG, WG, MFM) and teir Matlab implementations in DarcyLite. Tis includes details on mes data structure, quadratures, finite element mass and stiffness matrices, andling of boundary conditions, assembly of global discrete linear systems, computation of numerical velocity and normal fluxes on edges, examination of local mass conservation, and presentation of numerical pressure and velocity. A numerical example is included to demonstrate te use and efficiency of tis toolbox. We consider 2-dim elliptic boundary value problems (Darcy problems) formulated as { ( K p) u = f, x Ω, p = p D, x Γ D, u n = u N, x Γ N (1), were Ω R 2 is a bounded polygonal domain, p is te primal unknown (pressure), K is a ydraulic conductivity (permeability) tensor tat is uniformly symmetric positive-definite, f is a source term, p D,u N are respectively Diriclet and Neumann boundary data, n te unit outward normal vector on Ω, wic as a nonoverlapping decomposition Γ D Γ N. We define a subspace and a manifold respectively for scalar-valued functions as follows H D, (Ω) = {p H 1 (Ω) : p Γ D =}, H D,pD (Ω) = {p H 1 (Ω) : p Γ D = p D }. Te variational form for te primal variable pressure reads as: Seek p HD,p 1 D (Ω) suc tat K p q = fq u N q, q HD,(Ω). 1 (2) Ω Ω Γ N Te Darcy equation can also be rewritten as a system of two first-order equations by considering te primal variable (pressure) and flux (velocity u = K p) as follows K 1 u + p =, u = f. (3) We define a subspace and a manifold respectively for vector-valued functions as follows H N, (div, Ω) = {v L 2 (Ω) 2 :divv L 2 (Ω), v Γ N = }, H N,uN (div, Ω) = {v L 2 (Ω) 2 :divv L 2 (Ω), v Γ N n = u N }. Te mixed variational formulation reads as: Seek u H N,uN (div, Ω) and p L 2 (Ω) suc tat (K 1 u) v p( v) = p D v n, v H N, (div, Ω), Ω Ω Γ D (4) ( u)q = fq, q L 2 (Ω). 132 Ω Ω For Darcy F solvers, two desired properties are (assuming u is te numerical velocity): Local mass conservation: For any element wit n being te outward unit normal vector on its boundary, tere olds u n = f. (5)

3 Normal flux continuity (in te integral form): For an interior edge sared by two elements i tat ave respectively outward unit normal vectors n i (i =1, 2), tere olds u 1 n 1 + u 2 n 2 =. (6) Tese important quantities are set as standard outputs of te F solvers in tis toolbox: (1) Numerical pressure average over eac element; (2) Numerical velocity at eac element center (and if needed, coefficients in te basis of te elementwise approximation subspace, e.g., RT or RT [] ); (3) Outward normal fluxes on all edges of eac element; (4) Local-mass-conservation residual on eac element if a F solver is not locally conservative; (5) Normal flux discrepancy across eac interior edge if te normal fluxes are not continuous. 2 F Solvers for Darcy quation: CG, DG, WG, MFM 2.1 Continuous Galerkin (CG) Te CG solvers for te Darcy equation are based on discretizations of te primal variational formulation (2). CG P 1 on triangular meses and CG Q 1 on rectangular meses are most frequently used. For a triangular mes T wit no anging nodes, let V be te space of all continuous piecewise linear polynomials on T.LetV = V H D, (Ω) and VD = V H D,pD (Ω) (after Lagrangian interpolation of Diriclet boundary data being performed). A finite element sceme using CG P 1 for te pressure is establised as: Seek p VD suc tat K p q = fq u N q, q V. (7) T T T T T After te numerical pressure p is obtained, te numerical velocity is calculated ad oc [4]. Te CG P 1 basis functions are actually barycentric coordinates. Computation and assembly of element stiffness matrices are relatively easy. CG P 1 or Q 1 scemesaveteleastnumbers of unknowns. But CG scemes are not locally mass-conservative and do not ave continuous normal fluxes across edges [8]. Post-processing is needed [5] to render a numerical velocity te above two properties. 2.2 Discontinuous Galerkin (DG) Let be a rectangular or triangular mes, define V k as te space of (discontinuous) piecewise polynomials wit a total degree k on. A DG sceme seeks p V k suc tat [13] A (p,q)=f(q), q V k, (8) were A (p,q)= + β Γ I ΓD K p q Γ N Γ I ΓD {K q n}[p ] + {K p n}[q] Γ I ΓD α [p ][q], (9) 133

4 F(q) = fq Γ N u N q + β Γ D K q np D + Γ D α p D q. (1) Here α > is a penalty factor for any edge Γ and β is a formulation parameter [13]. Depending on te coice of β, one ends up wit te symmetric interior penalty Galerkin (SIPG) for β = 1, te nonsymmetric interior penalty Galerkin (NIPG) for β = 1, and te incomplete interior penalty Galerkin (IIPG) for β =. Stability of te above DG sceme for a numerical pressure relies on te penalty factor. DG numerical velocity can be calculated ad oc. Te DG velocity is locally mass-conservative, but its normal component is not continuous across element boundaries. As pointed out in [2], tis leads to nonpysical oscillations, if te DG velocity is coupled to a DG transport solver in a straigtforward manner. Tis could make particle tracking difficult or impossible, if te DG velocity is used in a caracteristic-based transport solver. Te features and usefulness of te H(div) finite elements, especially, te BDM finite element spaces motivate post-processing of te DG velocity via projection [2]. Te post-processed velocity as te following properties [2]: (i) Te new numerical velocity as continuous normal components on element interfaces; (ii) Te new numerical velocity reproduces te averaged normal flux of te DG velocity; (iii) It as te same accuracy and convergence order as te original DG velocity. Details on implementation of te DG scemes and teir post-processing can be found in [2, 11]. 2.3 Weak Galerkin (WG) Te WG finite element metods are developed based on te innovative concepts of weak gradients and discrete weak gradients [16]. Instead of using te ad oc gradient of sape functions, discrete weak gradients are establised at te element level to provide nice approximations of te classical gradient in partial differential equations. Te WG approac considers a discrete sape function in two pieces: v = {v,v },te interior part v could be a polynomial of degree l inteinterior of an element, te boundary part v on could be a polynomial of degree m, its discrete weak gradient w,n v is specified in V (,n) P n () 2 (n ) via integration by parts: ( w,n v) w = v (w n) v ( w), w V (,n). For example, for a triangle T, WG(P,P,RT ) uses a constant basis function on T,aconstant basis function on eac edge on T, and specifies te discrete weak gradients of tese 4 basis functions in RT. Normalized basis functions for RT facilitate computation of tese discrete weak gradients [8, 1, 11], altoug small-size linear systems need to be solved in general. Te WG scemes for te Darcy equation rely on discretizations of (2). Let be a triangular or rectangular mes, l, m, n nonnegative integers, S (l, m) te space of discrete sape functions on tat ave polynomial degree l in element interior and degree m on edges, S (l, m) te subspace of functions in S (l, m) tatvanisonγ D. Seek p = {p,p } S (l, m) suc tat p Γ D = Q p D (projection of Diriclet boundary data) and 134 A (p,q)=f(q), q = {q,q } S (l, m), (11)

5 A (p,q):= K w,n p w,n q, F(q) := fq Γ N u N q. (12) After obtaining te numerical pressure p, one computes te WG numerical velocity by u = R ( K w,n p ), (13) were R is te local L 2 -projection onto V (,n).butitcanbeskippedwenk is a constant scalar on te element. Te normal fluxes are computed accordingly. Te WG scemes are locally conservative and produce continuous normal fluxes (in te integral form) [1, 11, 16]. 2.4 Mixed Finite lement Metods (MFM) Te mixed finite element scemes for te Darcy equation are based on discretizations of te mixed variational form (4). A pair of finite element spaces (V,W ) are cosen suc tat V H(div, Ω) for approximating velocity and W L 2 (Ω) for approximating pressure and togeter tey satisfy te inc-sup condition. Among te popular coices are (RT,P ), (BDM 1,P )for triangular meses and (RT [],Q ) for rectangular meses [1, 11]. For a rectangular or triangular mes, denote U = V H un,n (div; Ω) and V = V H,N (div; Ω). A mixed F sceme can be stated as: Seek u U and p W suc tat K 1 u v p ( v) = p D (v n), v V, Γ D ( u )q = (14) fq, q W. For implementation of (RT,P ), te edge-based basis functions for V can be used in computation and assembly of element matrices [1, 11]. A symmetric indefinite linear system is solved. Tis is taken care by Matlab backslas, altoug it is nontrivial beind te scene. An obvious advantage of te MFM scemes is te automatic local mass conservation (obtained by taking test function q = 1 in (14) 2nd equation) and normal flux continuity (built in te construction of H(div) finite element spaces). It is interesting to observe certain equivalence between te MFM scemes and te WG finite element scemes [1]. 3 Design and Implementation of DarcyLite DarcyLite is implemented in Matlab, wic is a popular interpretative language. Altoug it is different tan compilation languages like C/C++ or Fortran, Matlab is very efficient in matrix or array operations, since its core was implemented mainly in Fortran. Tis also means tat Matlab arrays are stored columnwise. Te integrated development environment and grapics functionalities offered by Matlab are very elpful for educational purposes. Te above observations guide our overall design of DarcyLite: Code modules and separation of tasks; Minimization of function calls; Columnwise storage and access for full matrices or arrays; 135

6 Utilizing Matlab (i, j, s)-format for sparse matrices; Performing operations on a mes for all elements simultaneously. Tis section furter elaborates on tese ideas troug a list of selected topics. Some data structures and implementation tecniques in DarcyLite sare te same spirit as tose in [1, 3]. 3.1 Mes Data Structure Mes information can be categorized as geometric (node coordinates, positions of element centers, etc.), topological (an element vs its nodes, adjacent edges of a given edge, etc.), and combinatorial (te number of neigboring nodes of a given node, etc.). Some basic mes data are used by all types of finite element solvers, even toug tey use some derived mes info in different ways. Mes data can be organized as (i) Primary info suc as te numbers of nodes/elements, node coordinates, an element vs its nodes: NumNds, Numms, node, elem (ii) Secondary info suc as an edge vs its vertices, an edge vs its neigboring element(s), an element vs its all edges: Numgs, edge, edge2elem, elem2edge, Leng, area, mcntr (iii) Tertiary info are more specific to particular finite element solvers. For instance, DG needs to know wat are te neigboring elements for a give element, MFM and WG need specific info on weter an edge is te 2nd edge of a given element. Te info on te (unit) normal vector of a given edge is also used by MFM and WG. For example, te geometric info about mes node coordinates is organized as an array of size NumNds*2, te topological info about triangular elements vs teir vertices is organized as an array of size Numms*3. Sown below is a code fragment for computing all triangle areas based on te columnwise storage in Matlab. k1 = TriMes.elem(:,1); k2 = TriMes.elem(:,2); k3 = TriMes.elem(:,3); x1 = TriMes.node(k1,1); x2 = TriMes.node(k2,1); x3 = TriMes.node(k3,1); y1 = TriMes.node(k1,2); y2 = TriMes.node(k2,2); y3 = TriMes.node(k3,2); TriMes.area = *abs((x2-x1).*(y3-y1)-(x3-x1).*(y2-y1)); Based on tese tree levels of mes info, DarcyLite organizes mes data as a structure tat as several dynamic fields. Te fields can be easily added or removed. Code modules are provided for mes info enricment (adding data fields at a iger level), see code modules TriMes_nric1.m, TriMes_nric3.m, RectMes_nric1.m, RectMes_nric3.m 3.2 Implementation of Quadratures Integrals on elements and element interfaces comprise a major portion of computation in finite element metods. Altoug tis looks like a simple issue, but code efficiency can be improved wen we adopt an unconventional approac. For example, in te WG(P,P,RT )scemefor te Darcy equation, one needs to compute te integrals f over all triangular elements. If a T K-point Gaussian quadrature is applied, ten te conventional approac would be K fdt T f(α k P 1 + β k P 2 + k P 3 )w k, T T, 136 T k=1

7 were (α k,β k, k ),w k (k =1,...,N) are respectively te barycentric coordinates and weigts of te quadrature points. Te order of summation and loop can be reversed: GlbRHS = zeros(dofs,1); NumQuadPts = size(gaussquad.trig,1); for k=1:numquadpts qp = GAUSSQUAD.TRIG(k,1) * TriMes.node(TriMes.elem(:,1),:)... + GAUSSQUAD.TRIG(k,2) * TriMes.node(TriMes.elem(:,2),:)... + GAUSSQUAD.TRIG(k,3) * TriMes.node(TriMes.elem(:,3),:); GlbRHS(1:Numms) = GlbRHS(1:Numms) + GAUSSQUAD.TRIG(k,4) * qnbc.fxnf(qp); end GlbRHS(1:Numms) = GlbRHS(1:Numms).* TriMes.area; 3.3 lement-level Small Matrices and Mes-level Sparse Matrices Finite element scemes involve computation of element-level small-size full matrices, e.g., mass matrices and stiffness matrices, and mes-level large-size sparse matrices, e.g., te global stiffness matrix. In general, we avoid using cell arrays of usual matrices, since tey may be inefficient. Instead we use 3-dim arrays. For example, in te WG(P,P,RT ) sceme for te Darcy equation, eac triangle involves one WG basis function for element interior and tree WG basis functions for te edges. Te discrete weak gradient of eac of te four WG basis functions is a linear combination of te tree RT normalized basis functions [1]. We organize tese coefficients as a tree-dimensional array CDWGB = zeros(trimes.numms, 4, 3); Te interaction of te discrete weak gradients of te 3 basis functions results in a 3-dim array ArrayGG = zeros(trimes.numms, 3, 3); Tese element-level small full matrices are assembled into te sparse global stiffness matrix DOFs = TriMes.Numms + TriMes.Numgs; GlbMat = sparse(dofs,dofs); Instead of using a loop over all elements, we utilize te (i, j, s)-structure in Matlab and te mes topological info: for i=1:3 II = TriMes.Numms + TriMes.elem2edge(:,i); for j=i:3 % Utilizing symmetry JJ = TriMes.Numms + TriMes.elem2edge(:,j); if (j==i) GlbMat = GlbMat + sparse(ii,ii,arraygg(:,i,i),dofs,dofs); else GlbMat = GlbMat + sparse(ii,jj,arraygg(:,i,j),dofs,dofs); GlbMat = GlbMat + sparse(jj,ii,arraygg(:,i,j),dofs,dofs); end end end See te following code modules for more details: Darcy_WG_TriPPRT_AsmSlv.m, Darcy_WG_RectQPRT_AsmSlv.m 137

8 3.4 nforcement of ssential Boundary Conditions For CG and WG, Diriclet boundary conditions are essential, but Neumann boundary conditions are natural, see quations (7,11). For MFM, Neumann conditions are essential but Diriclet conditions are natural, see quation (14). For DG, Diriclet conditions are enforced weakly [13] in te bilinear and linear forms, see quations (8,9,1). Teoretically, a zero essential boundary condition corresponds to a nice subspace for te numerical solution in te finite element sceme. For a non-zero essential condition, owever, we usually use te terminology manifold to accommodate te numerical solution. From te implementation viewpoint, to enforce essential boundary conditions, we need to modify te global sparse linear system obtained from a finite element sceme. Tere are basically two approaces, ard ( brutal ) and soft ( gentle ). We illustrate te latter using a simple linear system. Let {x 1,x 2 } be unknowns tat satisfy a linear system as follows [ ][ ] A11 A 12 x1 = A 21 A 22 x 2 [ b1 b 2 ]. Assume x 2 = c is te essential boundary condition. A brutal way is to modify te system to [ ][ ] [ ] A11 A 12 x1 b1 =. I x 2 c But tis usually damages te symmetry in te original linear system. An alternative is to consider solving A 11 x 1 = b 1 A 12 c, wic is a linear system wit a smaller size and maintains te symmetry of A 11 sown in te original system. Note tat [ ] [ ] [ ][ ] b1 A 12 c b1 A11 A = 12 b 2 A 21 A 22 c involves a simple matrix-vector multiplication (using te original global coefficient matrix) and we just need to take te first block in te final result vector. See te following code modules for more details: Darcy_CG_RectQ1t_AsmSlv.m, Darcy_WG_TriPPRT_AsmSlv.m, Darcy_WG_RectQPRT_AsmSlv.m 3.5 Interface wit Oter Software Packages DarcyLite focuses on solving flow and transport problems in te environment provided by Matlab. It can import triangular meses generated by oter packages, e.g., PD Toolbox and DistMes [12], wic also run on Matlab. DarcyLite provides functions for triangular mes conversion from te aforementioned two packages. Triangle is a popular triangular mes generator developed in C. DarcyLite can read in te mes data files generated by Triangle in te so-called flat file transfer (FFT) approac. 3.6 Grapical User Interface (GUI) of DarcyLite A grapical user interface (GUI) is provided wit DarcyLite for demonstration and education purposes. It was developed using Matlab built-in guide (grapical user interface development environment). Te GUI is based on te event-driven design principle and some tecniques in SNSAI [14] are adopted. Te GUI as tree parts as sown in Figure 1: Preparation, Numerical metod, and Presentation. 138

9 Figure 1: A screen snapsot of te Grapical User Interface (GUI) for DarcyLite I. Preparation. Tis part allows te user to specify details for a problem to be solved. (A) A domain is defined, including te endpoints along te x- and y-axis. Te default settings suggest a rectangular domain wit bot axes starting at and ending at 1. (B) Specify te Darcy equation tru a ydraulic conductivity K and a source term f. (C) Diriclet and Neumann boundary conditions are specified. Te two built-in options for K, f, and boundary conditions are defined according to two popular test examples. (D) A mes is to be generated. Te user can coose between a rectangular or triangular mes by specifying te numbers of uniform partitions nx, ny for te x, y-directions, respectively. Default settings suggest nx =2,ny = 2. Te Sow Mes button pops up a figure window for te user to ceck weter a correct mes as been generated. () Gaussian type quadratures (for edges, rectangles, and triangles) are cosen. Te default coices (5,25,13) are sufficient for most cases. II. Numerical Metod. Tis part of te GUI lists te four major types of finite element solvers. Te user can coose among Continuous Galerkin, Discontinuous Galerkin, Weak Galerkin, or Mixed Finite lement Metod. Ten te user must click te Run Code button. A popup will confirm tat te inputs from Part I are correct for te cosen finite element solver. Oterwise, an error message will pop up. III. Presentation. Te ceckboxes in tis part allow te user to display any combination of te numerical pressure and velocity profiles, local mass-conservation residual (LMCR), and flux discrepancy across edges. 139

10 4 A Transport Solver: Implicit uler + Weak Galerkin DarcyLite contains also finite element solvers for transport problems in 2-dim prototyped as c t + (vc D c) =f(x, y, t), (x, y) Ω,t (,T), c(x, y, t) =, (x, y) Ω,t (,T), (15) c(x, y, ) = c (x, y), (x, y) Ω. Here c(x, y, t) is te unknown (solute) concentration, v te Darcy velocity, D>adiffusion constant, f a source/sink term. Tere exist various types of finite element metods for transport problems. Here we briefly discuss a numerical sceme tat utilizes te implicit uler for timemarcing and weak Galerkin for spatial approximation. For simplicity, we assume Ω is a rectangular domain equipped wit a rectangular mes and a numerical velocity u as been obtained from applying a finite element solver tat is locally mass-conservative and as continuous normal fluxes. Te unknown concentration is approximated using te lowest order finite element space WG(Q,P,RT [] ). Let C (n) (n 1) be suc an approximation at discrete time t n, ten tere olds for n 1, (C (n),w) Δt (u C (n), w,dw) +ΔtD ( w,d C (n), w,dw) = (C (n 1),w) +Δt (16) (f,w). An initial approximant C () can be obtained via local L 2 -projection of c (x, y) intotewg finite element space. Te Implicit uler + Weak Galerkin sceme as two nice properties: (i) C (n) represents intuitively te cell average of concentration on any element. (ii)tescemeislocally and ence globally conservative. Tis is verified by taking a test function w tat as value 1 in one element interior but in all oters and on all edges. Te 2nd term on te left side of te above equation caracterizes interaction of te flow (Darcy velocity) and te concentration (discrete weak) gradient. Te 3rd term is a symmetric term similar to tat in any elliptic problem. Te 1st term on te rigt side represents te mass at te previous time moment, wereas te last term depicts te source/sink contribution during te time period [t n 1,t n ]. 5 Numerical xperiments Tis section presents numerical results to demonstrate te use of DarcyLite. We consider an example of coupled flow and transport. A numerical Darcy velocity is fed into te transport solver discussed in te previous section. For te Darcy equation, Ω = (, 1) 2, te ydraulic conductivity profile is taken from [7] (alsousedin[1, 11]). Tere is no source. A Diriclet condition p = 1 is specified for te left boundary and p = for te rigt boundary. A zero Neumann condition is set for te lower and upper boundaries. Te Darcy solver WG(Q,P,RT [] ) is used on a uniform 1 1 rectangular mes (but for grapics clarity, Figure 2 Panel (a) sows results of 4 4 mes). 131

11 For te transport problem (15), T =, D =1 3, tere is no source. An initial constant concentration is placed in [, ] [, ]. Te RT [] numerical velocity from te Darcy solver is used in te I+WG sceme (16) wit a 1 1 rectangular mes and Δt = Figure 2 Panel (b)(c)(d) present numerical concentration profiles for time moments t =, 5,, respectively. It can be observed tat te transport pattern reflects well te flow features: (i) Te upper part of te domain as stronger flow and ence te concentration front in te upper part advances faster tan tat in te lower part. (ii) In Panel (d), in te middle of te domain, an almost vertical transport pat can be observed. Tis clearly reflects te strong flow in te domain from position (, ) downward to position (, ), see Panel (a) also. Note tat te mass flux on te domain boundary is zero. It can be cecked numerically tat te total mass in te domain C (n) remains at for all discrete time moments (t =trougt = witincrement.5). Tis verifies te mass conservation property (ii) discussed in Section 4. However, tere are small negative concentrations. liminating oscillations in numerical concentrations of convection-dominated transport problems is a nontrivial issue [9]. Particular treatments for te Implicit uler + Weak Galerkin transport solver are currently under our investigation. WG: Numerical pressure and velocity Projected initial concentration.8 1 (a) (b) time t = Numerical concentration Numerical concentration.8 1 (c) time t =5 (d) time t = 1.8 Figure 2: xample: Coupled Darcy flow and transport. (a) Numerical pressure and velocity. (b) Initial concentration. (c) Concentration at time t =5. (d) Concentration at time t =. Results for (c)(d) are obtained using WG(Q,P,RT [] )( =1 2 ) and implicit uler Δt =

12 6 Concluding Remarks DarcyLite is a small-size code package developed in Matlab for solving 2-dim flow and transport equations. It will be extended to include 3-dim solvers and test cases. For te flow equation, DarcyLite provides four major types of F solvers (CG, DG, WG, MFM) on triangular and rectangular meses. CG post-processing [5] and te enanced Galerkin (G) [13] will be included later. For te transport equation, DarcyLite provides solvers for bot steady-state and transient problems. For te latter, it offers solvers of ulerian type and ulerian-lagrangian type [15]. For coupled flow and transport problems, solvers for a 2-pase model [8] are provided. DarcyLite is being extended to include more solvers tat are efficient, robust, and respect pysical properties, e.g., local conservation, positivity-preserving. Besides applications like petroleum reservoir and groundwater simulations, DarcyLite is being extended to include flow and transport problems in biological media, e.g., drug delivery. TeURLfortiscodepackageis ttp:// References [1] J. Alberty, C. Carstensen, and S. Funken. Remarks around 5 lines of matlab: sort finite element implementation. Numer. Algor., 2: , [2] P. Bastian and B. Riviere. Superconvergence and (div) projection for discontinuous galerkin metods. Int. J. Numer. Met. Fluids, 42: , 23. [3] L. Cen. ifem: an integrated finite element metods package in matlab. Tec. Report, Mat Dept., Univ. of California at Irvine (29), 29. [4] Z. Cen, G. Huan, and Y. Ma. Computational metods for multipase flows in porous media. SIAM, 26. [5] B. Cockburn, J. Gopalakrisnan, and H. Wang. Locally conservative fluxes for te continuous galerkin metod. SIAM J. Numer. Anal., 45: , 27. [6] C. Dawson, S. Sun, and M. Weeler. Compatible algoritms for coupled flow and transport. Comput. Met. Appl. Mec. ngrg., 193: , 24. [7] L. Durlofsky. Accuracy of mixed and control volume finite element approximations to darcy velocity and related quantities. Water Resour. Res., 3: , [8] V. Ginting, G. Lin, and J. Liu. On application of te weak galerkin finite element metod to a two-pase model for subsurface flow. J. Sci. Comput., 66: , 216. [9] V. Jon and. Scmeyer. Finite element metods for time-dependent convection diffusion reaction equations wit small diffusion. Comput. Met. Appl. Mec. ngrg., 198: , 28. [1] G. Lin, J. Liu, L. Mu, and X. Ye. Weak galerkin finite element metdos for darcy flow: Anistropy and eterogeneity. J. Comput. Pys., 276: , 214. [11] G. Lin, J. Liu, and F. Sadre-Marandi. A comparative study on te weak galerkin, discontinuous galerkin, and mixed finite element metods. J. Comput. Appl. Mat., 273: , 215. [12] P. Persson and G. Strang. A simple mes generator in matlab. SIAM Review, 46: , 24. [13] S. Sun and J. Liu. A locally conservative finite element metod based on piecewise constant enricment of te continuous galerkin metod. SIAM J. Sci. Comput., 31: , 29. [14] S. Tavener and M. Mikucki. Sensai: A matlab package for sensitivity analysis. ttp:// tavener/fscu/snsai/sensai.stml. [15] H. Wang, H.K. Dale, R.. wing, M.S. spedal, R.C. Sarpley, and S. Man. An ellam sceme for advection-diffusion equations in two dimensions. SIAM J. Sci. Comput., 2: , [16] J. Wang and X. Ye. A weak galerkin finite element metod for second order elliptic problems. J. Comput. Appl. Mat., 241:13 115,

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

More information

A Two-field Finite Element Solver for Poroelasticity on Quadrilateral Meshes

A Two-field Finite Element Solver for Poroelasticity on Quadrilateral Meshes A Two-field Finite Element Solver for Poroelasticity on Quadrilateral Meses Graam Harper 1, Jiangguo Liu 1, Simon Tavener 1, and Zuoran Wang 1 Colorado State University, Fort Collins, CO 80523, USA {arper,liu,tavener,wangz}@mat.colostate.edu

More information

A Two-Field Finite Element Solver for Poroelasticity on Quadrilateral Meshes

A Two-Field Finite Element Solver for Poroelasticity on Quadrilateral Meshes A Two-Field Finite Element Solver for Poroelasticity on Quadrilateral Meses Graam Harper, Jiangguo Liu, Simon Tavener, and Zuoran Wang (B) Colorado State University, Fort Collins, CO 80523, USA {arper,liu,tavener,wangz}@mat.colostate.edu

More information

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801 RESEARCH SUMMARY AND PERSPECTIVES KOFFI B. FADIMBA Department of Matematical Sciences University of Sout Carolina Aiken Aiken, SC 29801 Email: KoffiF@usca.edu 1. Introduction My researc program as focused

More information

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods

Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Methods DOI 0.007/s095-07-048- Fourier Type Super Convergence Study on DDGIC and Symmetric DDG Metods Mengping Zang Jue Yan Received: 7 December 06 / Revised: 7 April 07 / Accepted: April 07 Springer Science+Business

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

More information

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems J Sci Comput (07 7:95 8 DOI 0.007/s095-06-096-4 A Weak Galerkin Metod wit an Over-Relaxed Stabilization for Low Regularity Elliptic Problems Lunji Song, Kaifang Liu San Zao Received: April 06 / Revised:

More information

Efficient algorithms for for clone items detection

Efficient algorithms for for clone items detection Efficient algoritms for for clone items detection Raoul Medina, Caroline Noyer, and Olivier Raynaud Raoul Medina, Caroline Noyer and Olivier Raynaud LIMOS - Université Blaise Pascal, Campus universitaire

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

Preconditioning in H(div) and Applications

Preconditioning in H(div) and Applications 1 Preconditioning in H(div) and Applications Douglas N. Arnold 1, Ricard S. Falk 2 and Ragnar Winter 3 4 Abstract. Summarizing te work of [AFW97], we sow ow to construct preconditioners using domain decomposition

More information

EXTENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS WITH APPLICATION TO AN AEROACOUSTIC PROBLEM

EXTENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS WITH APPLICATION TO AN AEROACOUSTIC PROBLEM SIAM J. SCI. COMPUT. Vol. 26, No. 3, pp. 821 843 c 2005 Society for Industrial and Applied Matematics ETENSION OF A POSTPROCESSING TECHNIQUE FOR THE DISCONTINUOUS GALERKIN METHOD FOR HYPERBOLIC EQUATIONS

More information

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Mixed-Hybrid-Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS BERNARDO COCKBURN, JOHNNY GUZMÁN, SEE-CHEW SOON, AND HENRYK K. STOLARSKI Abstract. Te embedded discontinuous

More information

A = h w (1) Error Analysis Physics 141

A = h w (1) Error Analysis Physics 141 Introduction In all brances of pysical science and engineering one deals constantly wit numbers wic results more or less directly from experimental observations. Experimental observations always ave inaccuracies.

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

FEM solution of the ψ-ω equations with explicit viscous diffusion 1

FEM solution of the ψ-ω equations with explicit viscous diffusion 1 FEM solution of te ψ-ω equations wit explicit viscous diffusion J.-L. Guermond and L. Quartapelle 3 Abstract. Tis paper describes a variational formulation for solving te D time-dependent incompressible

More information

Solving Poisson s equations by the Discrete Least Square meshless method

Solving Poisson s equations by the Discrete Least Square meshless method Boundary Elements and Oter Mes eduction Metods XXV 3 Solving Poisson s equations by te Discrete Least Square mesless metod H. Arzani & M. H. Afsar Said aaee University, Lavizan, eran, ran Department of

More information

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp MIXED DISCONTINUOUS GALERIN APPROXIMATION OF THE MAXWELL OPERATOR PAUL HOUSTON, ILARIA PERUGIA, AND DOMINI SCHÖTZAU SIAM J. Numer. Anal., Vol. 4 (004), pp. 434 459 Abstract. We introduce and analyze a

More information

Part VIII, Chapter 39. Fluctuation-based stabilization Model problem

Part VIII, Chapter 39. Fluctuation-based stabilization Model problem Part VIII, Capter 39 Fluctuation-based stabilization Tis capter presents a unified analysis of recent stabilization tecniques for te standard Galerkin approximation of first-order PDEs using H 1 - conforming

More information

Journal of Computational and Applied Mathematics

Journal of Computational and Applied Mathematics Journal of Computational and Applied Matematics 94 (6) 75 96 Contents lists available at ScienceDirect Journal of Computational and Applied Matematics journal omepage: www.elsevier.com/locate/cam Smootness-Increasing

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

arxiv: v1 [math.na] 17 Jul 2014

arxiv: v1 [math.na] 17 Jul 2014 Div First-Order System LL* FOSLL* for Second-Order Elliptic Partial Differential Equations Ziqiang Cai Rob Falgout Sun Zang arxiv:1407.4558v1 [mat.na] 17 Jul 2014 February 13, 2018 Abstract. Te first-order

More information

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method WDS'10 Proceedings of Contributed Papers, Part I, 151 156, 2010. ISBN 978-80-7378-139-2 MATFYZPRESS Different Approaces to a Posteriori Error Analysis of te Discontinuous Galerkin Metod I. Šebestová Carles

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract Superconvergence of energy-conserving discontinuous Galerkin metods for linear yperbolic equations Yong Liu, Ci-Wang Su and Mengping Zang 3 Abstract In tis paper, we study superconvergence properties of

More information

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System

Discontinuous Galerkin Methods for Relativistic Vlasov-Maxwell System Discontinuous Galerkin Metods for Relativistic Vlasov-Maxwell System He Yang and Fengyan Li December 1, 16 Abstract e relativistic Vlasov-Maxwell (RVM) system is a kinetic model tat describes te dynamics

More information

Jian-Guo Liu 1 and Chi-Wang Shu 2

Jian-Guo Liu 1 and Chi-Wang Shu 2 Journal of Computational Pysics 60, 577 596 (000) doi:0.006/jcp.000.6475, available online at ttp://www.idealibrary.com on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department

More information

Numerical Differentiation

Numerical Differentiation Numerical Differentiation Finite Difference Formulas for te first derivative (Using Taylor Expansion tecnique) (section 8.3.) Suppose tat f() = g() is a function of te variable, and tat as 0 te function

More information

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations

Arbitrary order exactly divergence-free central discontinuous Galerkin methods for ideal MHD equations Arbitrary order exactly divergence-free central discontinuous Galerkin metods for ideal MHD equations Fengyan Li, Liwei Xu Department of Matematical Sciences, Rensselaer Polytecnic Institute, Troy, NY

More information

Introduction to Derivatives

Introduction to Derivatives Introduction to Derivatives 5-Minute Review: Instantaneous Rates and Tangent Slope Recall te analogy tat we developed earlier First we saw tat te secant slope of te line troug te two points (a, f (a))

More information

Variational Localizations of the Dual Weighted Residual Estimator

Variational Localizations of the Dual Weighted Residual Estimator Publised in Journal for Computational and Applied Matematics, pp. 192-208, 2015 Variational Localizations of te Dual Weigted Residual Estimator Tomas Ricter Tomas Wick Te dual weigted residual metod (DWR)

More information

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines Lecture 5 Interpolation II Introduction In te previous lecture we focused primarily on polynomial interpolation of a set of n points. A difficulty we observed is tat wen n is large, our polynomial as to

More information

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations

Computers and Mathematics with Applications. A nonlinear weighted least-squares finite element method for Stokes equations Computers Matematics wit Applications 59 () 5 4 Contents lists available at ScienceDirect Computers Matematics wit Applications journal omepage: www.elsevier.com/locate/camwa A nonlinear weigted least-squares

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

HOMEWORK HELP 2 FOR MATH 151

HOMEWORK HELP 2 FOR MATH 151 HOMEWORK HELP 2 FOR MATH 151 Here we go; te second round of omework elp. If tere are oters you would like to see, let me know! 2.4, 43 and 44 At wat points are te functions f(x) and g(x) = xf(x)continuous,

More information

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY (Section 3.2: Derivative Functions and Differentiability) 3.2.1 SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY LEARNING OBJECTIVES Know, understand, and apply te Limit Definition of te Derivative

More information

Robotic manipulation project

Robotic manipulation project Robotic manipulation project Bin Nguyen December 5, 2006 Abstract Tis is te draft report for Robotic Manipulation s class project. Te cosen project aims to understand and implement Kevin Egan s non-convex

More information

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator Simulation and verification of a plate eat excanger wit a built-in tap water accumulator Anders Eriksson Abstract In order to test and verify a compact brazed eat excanger (CBE wit a built-in accumulation

More information

arxiv: v1 [math.na] 20 Jul 2009

arxiv: v1 [math.na] 20 Jul 2009 STABILITY OF LAGRANGE ELEMENTS FOR THE MIXED LAPLACIAN DOUGLAS N. ARNOLD AND MARIE E. ROGNES arxiv:0907.3438v1 [mat.na] 20 Jul 2009 Abstract. Te stability properties of simple element coices for te mixed

More information

A MONTE CARLO ANALYSIS OF THE EFFECTS OF COVARIANCE ON PROPAGATED UNCERTAINTIES

A MONTE CARLO ANALYSIS OF THE EFFECTS OF COVARIANCE ON PROPAGATED UNCERTAINTIES A MONTE CARLO ANALYSIS OF THE EFFECTS OF COVARIANCE ON PROPAGATED UNCERTAINTIES Ronald Ainswort Hart Scientific, American Fork UT, USA ABSTRACT Reports of calibration typically provide total combined uncertainties

More information

A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION

A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION A SYMMETRIC NODAL CONSERVATIVE FINITE ELEMENT METHOD FOR THE DARCY EQUATION GABRIEL R. BARRENECHEA, LEOPOLDO P. FRANCA 1 2, AND FRÉDÉRIC VALENTIN Abstract. Tis work introduces and analyzes novel stable

More information

arxiv: v1 [math.na] 9 Mar 2018

arxiv: v1 [math.na] 9 Mar 2018 A simple embedded discrete fracture-matrix model for a coupled flow and transport problem in porous media Lars H. Odsæter a,, Trond Kvamsdal a, Mats G. Larson b a Department of Matematical Sciences, NTNU

More information

HYBRIDIZED GLOBALLY DIVERGENCE-FREE LDG METHODS. PART I: THE STOKES PROBLEM

HYBRIDIZED GLOBALLY DIVERGENCE-FREE LDG METHODS. PART I: THE STOKES PROBLEM MATHEMATICS OF COMPUTATION Volume 75, Number 254, Pages 533 563 S 0025-5718(05)01804-1 Article electronically publised on December 16, 2005 HYBRIDIZED GLOBALLY DIVERGENCE-FREE LDG METHODS. PART I: THE

More information

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps A metod of Lagrange Galerkin of second order in time Une métode de Lagrange Galerkin d ordre deux en temps Jocelyn Étienne a a DAMTP, University of Cambridge, Wilberforce Road, Cambridge CB3 0WA, Great-Britain.

More information

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds.

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds. Numerical solvers for large systems of ordinary differential equations based on te stocastic direct simulation metod improved by te and Runge Kutta principles Flavius Guiaş Abstract We present a numerical

More information

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach Numerical Solution to arabolic DE Using Implicit Finite Difference Approac Jon Amoa-Mensa, Francis Oene Boateng, Kwame Bonsu Department of Matematics and Statistics, Sunyani Tecnical University, Sunyani,

More information

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes

A First-Order System Approach for Diffusion Equation. I. Second-Order Residual-Distribution Schemes A First-Order System Approac for Diffusion Equation. I. Second-Order Residual-Distribution Scemes Hiroaki Nisikawa W. M. Keck Foundation Laboratory for Computational Fluid Dynamics, Department of Aerospace

More information

High-Order Extended Finite Element Methods for Solving Interface Problems

High-Order Extended Finite Element Methods for Solving Interface Problems Hig-Order Extended Finite Element Metods for Solving Interface Problems arxiv:1604.06171v1 [mat.na] 21 Apr 2016 Fei Wang Yuanming Xiao Jincao Xu ey words. Elliptic interface problems, unfitted mes, extended

More information

Convergence of Multi Point Flux Approximations on Quadrilateral Grids

Convergence of Multi Point Flux Approximations on Quadrilateral Grids Convergence of Multi Point Flux Approximations on Quadrilateral Grids Runild A. Klausen and Ragnar Winter Centre of Matematics for Applications, University of Oslo, Norway Tis paper presents a convergence

More information

arxiv: v1 [math.na] 19 Mar 2018

arxiv: v1 [math.na] 19 Mar 2018 A primal discontinuous Galerkin metod wit static condensation on very general meses arxiv:1803.06846v1 [mat.na] 19 Mar 018 Alexei Lozinski Laboratoire de Matématiques de Besançon, CNRS UMR 663, Univ. Bourgogne

More information

arxiv: v2 [math.na] 5 Jul 2017

arxiv: v2 [math.na] 5 Jul 2017 Trace Finite Element Metods for PDEs on Surfaces Maxim A. Olsanskii and Arnold Reusken arxiv:1612.00054v2 [mat.na] 5 Jul 2017 Abstract In tis paper we consider a class of unfitted finite element metods

More information

Continuity and Differentiability Worksheet

Continuity and Differentiability Worksheet Continuity and Differentiability Workseet (Be sure tat you can also do te grapical eercises from te tet- Tese were not included below! Typical problems are like problems -3, p. 6; -3, p. 7; 33-34, p. 7;

More information

A Hybridizable Discontinuous Galerkin Method for the Compressible Euler and Navier-Stokes Equations

A Hybridizable Discontinuous Galerkin Method for the Compressible Euler and Navier-Stokes Equations A Hybridizable Discontinuous Galerkin Metod for te Compressible Euler and Navier-Stokes Equations J. Peraire and N. C. Nguyen Massacusetts Institute of Tecnology, Cambridge, MA 02139, USA B. Cockburn University

More information

One-Sided Position-Dependent Smoothness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meshes

One-Sided Position-Dependent Smoothness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meshes DOI 10.1007/s10915-014-9946-6 One-Sided Position-Dependent Smootness-Increasing Accuracy-Conserving (SIAC) Filtering Over Uniform and Non-uniform Meses JenniferK.Ryan Xiaozou Li Robert M. Kirby Kees Vuik

More information

Adaptive Finite Element Method

Adaptive Finite Element Method 39 Capter 3 Adaptive inite Element Metod 31 Introduction As already pointed out in capter 2, singularities occur in interface problems Wen discretizing te problem (221) wit inite Elements, te singularities

More information

arxiv: v1 [math.na] 28 Apr 2017

arxiv: v1 [math.na] 28 Apr 2017 THE SCOTT-VOGELIUS FINITE ELEMENTS REVISITED JOHNNY GUZMÁN AND L RIDGWAY SCOTT arxiv:170500020v1 [matna] 28 Apr 2017 Abstract We prove tat te Scott-Vogelius finite elements are inf-sup stable on sape-regular

More information

CLEMSON U N I V E R S I T Y

CLEMSON U N I V E R S I T Y A Fractional Step θ-metod for Convection-Diffusion Equations Jon Crispell December, 006 Advisors: Dr. Lea Jenkins and Dr. Vincent Ervin Fractional Step θ-metod Outline Crispell,Ervin,Jenkins Motivation

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

Inf sup testing of upwind methods

Inf sup testing of upwind methods INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Met. Engng 000; 48:745 760 Inf sup testing of upwind metods Klaus-Jurgen Bate 1; ;, Dena Hendriana 1, Franco Brezzi and Giancarlo

More information

Differentiation. Area of study Unit 2 Calculus

Differentiation. Area of study Unit 2 Calculus Differentiation 8VCE VCEco Area of stud Unit Calculus coverage In tis ca 8A 8B 8C 8D 8E 8F capter Introduction to limits Limits of discontinuous, rational and brid functions Differentiation using first

More information

On Application of the Weak Galerkin Finite Element Method to a Two-Phase Model for Subsurface Flow

On Application of the Weak Galerkin Finite Element Method to a Two-Phase Model for Subsurface Flow J Sci Comput (2016) 66:225 239 DOI 10.1007/s10915-015-0021-8 On Application of the Weak Galerkin Finite lement Method to a Two-Phase Model for Subsurface Flow Victor Ginting 1 Guang Lin 2 Jiangguo Liu

More information

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial Applied Matematics Vol. 35, No., pp. 393 405, February 998 00 LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS YANZHAO CAO

More information

Solving Continuous Linear Least-Squares Problems by Iterated Projection

Solving Continuous Linear Least-Squares Problems by Iterated Projection Solving Continuous Linear Least-Squares Problems by Iterated Projection by Ral Juengling Department o Computer Science, Portland State University PO Box 75 Portland, OR 977 USA Email: juenglin@cs.pdx.edu

More information

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem Analysis of A Continuous inite Element Metod for Hcurl, div)-elliptic Interface Problem Huoyuan Duan, Ping Lin, and Roger C. E. Tan Abstract In tis paper, we develop a continuous finite element metod for

More information

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point MA00 Capter 6 Calculus and Basic Linear Algebra I Limits, Continuity and Differentiability Te concept of its (p.7 p.9, p.4 p.49, p.55 p.56). Limits Consider te function determined by te formula f Note

More information

Finite Difference Methods Assignments

Finite Difference Methods Assignments Finite Difference Metods Assignments Anders Söberg and Aay Saxena, Micael Tuné, and Maria Westermarck Revised: Jarmo Rantakokko June 6, 1999 Teknisk databeandling Assignment 1: A one-dimensional eat equation

More information

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

arxiv: v1 [math.na] 3 Nov 2011

arxiv: v1 [math.na] 3 Nov 2011 arxiv:.983v [mat.na] 3 Nov 2 A Finite Difference Gost-cell Multigrid approac for Poisson Equation wit mixed Boundary Conditions in Arbitrary Domain Armando Coco, Giovanni Russo November 7, 2 Abstract In

More information

SMAI-JCM SMAI Journal of Computational Mathematics

SMAI-JCM SMAI Journal of Computational Mathematics SMAI-JCM SMAI Journal of Computational Matematics Compatible Maxwell solvers wit particles II: conforming and non-conforming 2D scemes wit a strong Faraday law Martin Campos Pinto & Eric Sonnendrücker

More information

Derivatives of Exponentials

Derivatives of Exponentials mat 0 more on derivatives: day 0 Derivatives of Eponentials Recall tat DEFINITION... An eponential function as te form f () =a, were te base is a real number a > 0. Te domain of an eponential function

More information

Chemnitz Scientific Computing Preprints

Chemnitz Scientific Computing Preprints G. Of G. J. Rodin O. Steinbac M. Taus Coupling Metods for Interior Penalty Discontinuous Galerkin Finite Element Metods and Boundary Element Metods CSC/11-02 Cemnitz Scientific Computing Preprints Impressum:

More information

Exercises for numerical differentiation. Øyvind Ryan

Exercises for numerical differentiation. Øyvind Ryan Exercises for numerical differentiation Øyvind Ryan February 25, 2013 1. Mark eac of te following statements as true or false. a. Wen we use te approximation f (a) (f (a +) f (a))/ on a computer, we can

More information

MVT and Rolle s Theorem

MVT and Rolle s Theorem AP Calculus CHAPTER 4 WORKSHEET APPLICATIONS OF DIFFERENTIATION MVT and Rolle s Teorem Name Seat # Date UNLESS INDICATED, DO NOT USE YOUR CALCULATOR FOR ANY OF THESE QUESTIONS In problems 1 and, state

More information

Numerical Analysis of the Double Porosity Consolidation Model

Numerical Analysis of the Double Porosity Consolidation Model XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real 21-25 septiembre 2009 (pp. 1 8) Numerical Analysis of te Double Porosity Consolidation Model N. Boal

More information

Digital Filter Structures

Digital Filter Structures Digital Filter Structures Te convolution sum description of an LTI discrete-time system can, in principle, be used to implement te system For an IIR finite-dimensional system tis approac is not practical

More information

2009 Elsevier Science. Reprinted with permission from Elsevier.

2009 Elsevier Science. Reprinted with permission from Elsevier. P. Hansbo and M. Juntunen. 009. Weakly imposed Diriclet boundary conditions for te Brinkman model of porous media flow. Applied Numerical Matematics, volume 59, number 6, pages 174 189. doi:10.1016/j.apnum.008.07.003.

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximating a function f(x, wose values at a set of distinct points x, x, x 2,,x n are known, by a polynomial P (x

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems

A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems A-posteriori error estimates for Discontinuous Galerkin approximations of second order elliptic problems Carlo Lovadina, and L. Donatella Marini Abstract Using te weigted residual formulation we derive

More information

Nonconforming Immersed Finite Element Methods for Interface Problems

Nonconforming Immersed Finite Element Methods for Interface Problems Nonconforming Immersed Finite Element Metods for Interface Problems Xu Zang Dissertation submitted to te Faculty of te Virginia Polytecnic Institute and State University in partial fulfillment of te requirements

More information

Finite Element Methods for Linear Elasticity

Finite Element Methods for Linear Elasticity Finite Element Metods for Linear Elasticity Ricard S. Falk Department of Matematics - Hill Center Rutgers, Te State University of New Jersey 110 Frelinguysen Rd., Piscataway, NJ 08854-8019 falk@mat.rutgers.edu

More information

APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS. Introduction

APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS. Introduction Acta Mat. Univ. Comenianae Vol. LXVII, 1(1998), pp. 57 68 57 APPROXIMATION OF CRYSTALLINE DENDRITE GROWTH IN TWO SPACE DIMENSIONS A. SCHMIDT Abstract. Te pase transition between solid and liquid in an

More information

Click here to see an animation of the derivative

Click here to see an animation of the derivative Differentiation Massoud Malek Derivative Te concept of derivative is at te core of Calculus; It is a very powerful tool for understanding te beavior of matematical functions. It allows us to optimize functions,

More information

HOW TO DEAL WITH FFT SAMPLING INFLUENCES ON ADEV CALCULATIONS

HOW TO DEAL WITH FFT SAMPLING INFLUENCES ON ADEV CALCULATIONS HOW TO DEAL WITH FFT SAMPLING INFLUENCES ON ADEV CALCULATIONS Po-Ceng Cang National Standard Time & Frequency Lab., TL, Taiwan 1, Lane 551, Min-Tsu Road, Sec. 5, Yang-Mei, Taoyuan, Taiwan 36 Tel: 886 3

More information

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT LIMITS AND DERIVATIVES Te limit of a function is defined as te value of y tat te curve approaces, as x approaces a particular value. Te limit of f (x) as x approaces a is written as f (x) approaces, as

More information

Comment on Experimental observations of saltwater up-coning

Comment on Experimental observations of saltwater up-coning 1 Comment on Experimental observations of saltwater up-coning H. Zang 1,, D.A. Barry 2 and G.C. Hocking 3 1 Griffit Scool of Engineering, Griffit University, Gold Coast Campus, QLD 4222, Australia. Tel.:

More information

3.4 Worksheet: Proof of the Chain Rule NAME

3.4 Worksheet: Proof of the Chain Rule NAME Mat 1170 3.4 Workseet: Proof of te Cain Rule NAME Te Cain Rule So far we are able to differentiate all types of functions. For example: polynomials, rational, root, and trigonometric functions. We are

More information

Lecture 21. Numerical differentiation. f ( x+h) f ( x) h h

Lecture 21. Numerical differentiation. f ( x+h) f ( x) h h Lecture Numerical differentiation Introduction We can analytically calculate te derivative of any elementary function, so tere migt seem to be no motivation for calculating derivatives numerically. However

More information

The derivative function

The derivative function Roberto s Notes on Differential Calculus Capter : Definition of derivative Section Te derivative function Wat you need to know already: f is at a point on its grap and ow to compute it. Wat te derivative

More information

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows

A Polynomial Adaptive LCP Scheme for Viscous Compressible Flows A Polynomial Adaptive LCP Sceme for Viscous Compressible Flows J.S. Cagnone, B.C. Vermeire, and S.. Nadaraja Department of Mecanical Engineering, McGill University, Montreal, Canada, H3A 2S6 Email: jean-sebastien.cagnone@mail.mcgill.ca

More information

A SPLITTING LEAST-SQUARES MIXED FINITE ELEMENT METHOD FOR ELLIPTIC OPTIMAL CONTROL PROBLEMS

A SPLITTING LEAST-SQUARES MIXED FINITE ELEMENT METHOD FOR ELLIPTIC OPTIMAL CONTROL PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALSIS AND MODELING Volume 3, Number 4, Pages 6 626 c 26 Institute for Scientific Computing and Information A SPLITTING LEAST-SQUARES MIED FINITE ELEMENT METHOD FOR

More information

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000 Revised April 2000

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000 Revised April 2000 ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD JAN MANDEL AND RADEK TEZAUR January 2000 Revised April 2000 Abstract In te Dual-Primal FETI metod, introduced by Farat et al [5], te domain is

More information

lim 1 lim 4 Precalculus Notes: Unit 10 Concepts of Calculus

lim 1 lim 4 Precalculus Notes: Unit 10 Concepts of Calculus Syllabus Objectives: 1.1 Te student will understand and apply te concept of te limit of a function at given values of te domain. 1. Te student will find te limit of a function at given values of te domain.

More information

arxiv: v1 [math.na] 6 Dec 2010

arxiv: v1 [math.na] 6 Dec 2010 MULTILEVEL PRECONDITIONERS FOR DISCONTINUOUS GALERKIN APPROXIMATIONS OF ELLIPTIC PROBLEMS WITH JUMP COEFFICIENTS BLANCA AYUSO DE DIOS, MICHAEL HOLST, YUNRONG ZHU, AND LUDMIL ZIKATANOV arxiv:1012.1287v1

More information