B005 A NEW FAST FOURIER TRANSFORM ALGORITHM FOR FLUID FLOW SIMULATION

Size: px
Start display at page:

Download "B005 A NEW FAST FOURIER TRANSFORM ALGORITHM FOR FLUID FLOW SIMULATION"

Transcription

1 1 B5 A NEW FAST FOURIER TRANSFORM ALGORITHM FOR FLUID FLOW SIMULATION LUDOVIC RICARD, MICAËLE LE RAVALEC-DUPIN, BENOÎT NOETINGER AND YVES GUÉGUEN Institut Français du Pétrole, 1& 4 avenue Bois Préau, Rueil malmaison, France Abstract Fluid flow simulators are usually based upon finite difference, finite volume or also finite element schemes. As these methods can be CPU-time consuming, we develop an alternative approach involving Fast Fourier Transforms to simulate steady-state, single-phase flow. In this paper, two algorithms are envisioned. They apply to heterogeneous porous media submitted to periodic boundary conditions. Basically, the algorithms are designed to solve sequentially the pressure equation in the frequency space. For the first algorithm, the convergence rate is proportional to the permeability contrast. It can be pretty slow for porous media with high permeability contrasts, such as turbidite systems. Then, a variation is introduced leading to the second algorithm. The convergence rate gets proportional to the square root of the permeability contrast, which results in a significant speed up. The performed numerical tests point out the efficiency and accuracy of the developed FFT-based flow solver. Introduction Geologic models of petroleum reservoirs are usually very detailed and discretized over grids with a huge number of grid blocks. As a result, they cannot be provided at once to fluid flow simulators: the required computational times would be prohibitive. The geologic model has to be upscaled, yielding a reservoir model with a reduced number of grid blocks. Except for special cases as stratified media, the numerical upscaling techniques are usually preferred. Among all of these methods, three main types are identified: local, extended local and global techniques. They all call for steady-state, single-phase flow simulations. If we do focus on the global approach, which is believed to be the most accurate, the pressure equation has to be solved for the whole fine geologic model. This step can be tackled only if a fast flow simulator is available. Many flow simulators, mainly based upon finite elements or finite volumes, have been developed. They apply to a wide variety of flow problems. A few years ago, Van Lent and itanidis (1989) introduced a novel FFT-based flow simulator. However, as they solved the pressure equation assuming that the variance of the log-permeability is very small compared to one, their technique was unsuitable for heterogeneous media. Parallely, a fast FFT-based technique was proposed to compute stresses and strains in composite media (Moulinec and Suquet; 1998; Eyre and Milton, 1999). As there is an obvious analogy between Hooke s law, which states that stress is proportional to strain, and Darcy s law, which states that flow is proportional to pressure gradient, we start from this stress-strain solver and extend it to the case of flow. Then, we perform a few numerical experiments in order to grasp the accuracy and the efficiency of the proposed techniques. Framework For steady-state, incompressible, single-phase flow, the continuity equation is: div ( U ) = ( 1 9th European Conference on the Mathematics of Oil Recovery Cannes, France, 3 August - 2 September 24

2 2 where U is the Darcy velocity. It is given by Darcy s law: U = P ( 2 is viscosity, P is pressure. As the porous medium is heterogeneous, permeability is considered as a random space function. For simplicity, it is assumed to be a scalar in each grid macro block. The pressure gradient P is split into two terms: its average P and a perturbation p. A basic scheme for porous media with moderate permeability contrasts The first proposed algorithm derives from the work of Moulinec and Suquet (1998). Auxiliary problem Before going further, we focus on an auxiliary problem, that is fluid flow in a porous homogeneous medium of a given permeability, noticed, submitted to a velocity field τ. We will see in the following sections that the value of is essential. The basic set of equations is given by: These equations are reformulated in the frequency space: Symbol ^ stands for Fourier transform and ξ is the wave vector. This equation reduces to: Γ is the Green operator associated to. General problem U = p + τ ( 3 div( U ) = ˆ U = i ξpˆ + ˆ τ ( 4 iξuˆ = ξ ξ ˆ ) τ ˆ pˆ = Γ with Γ = ξ ξ At this point, we come back to our basic problem, that is flow in a heterogeneous porous medium of permeability submitted to a pressure gradient P. We introduce a homogeneous reference permeability field so that: ( 5 U = P + P P = ( ) = τ P P P ( 6 The τ field is given by τ = P.

3 3 macro As stated above, the pressure gradient is the sum of its average P Thanks to the auxiliary problem, we obtain the following solution: P Pˆ which can be rewritten in the real space as: This expression can be reformulated as: First algorithm ( ξ ) = Γˆ ˆ τ macro = Pˆ ˆ macro ξ and a perturbation p. P = Γ τ + P. ( 8 m macro m 1 m 1 P = P + Γ U + Γ P. ( 9 Equation 5 is the key of the proposed algorithm. FFT stands for fast Fourier transform. ( 7 Initialization: macro P = P and U = P macro using FFT, compute ˆP. ( m) ( m) Iterate m+1: Pˆ and U are known. ( m) 1) using FFT, compute Uˆ ; ( m 2) set ) ( m) ( m Pˆ 1 ( ξ) ˆ ( ξ) Uˆ ˆ + = Γ + Γ ( ξ). Pˆ ) ( ξ) when ξ ( m and ) macro Pˆ + 1 = P ; 3) using the inverse FFT, compute P m+1 ; ( m+1 ) ( m+1) 4) compute U = P ; m+ 1 U ( m+ 1) 5) compute the effective permeability eff = ( m+ 1) P ( m+ ) ( m) 6) set m = m+1 and go back to step 1 until 1 eff eff ε. Because of the use of FFTs, computations are very fast. However, they are restricted to periodic boundary conditions and regular reservoir grids. Convergence The convergence of equation 6 has been analysed in a number of papers (e.g., Eyre and Milton, 1999). In the worst case, the series optimally converges when: ( ) + max. min = ( 1 2 ( m) ( m 1) m macro The rate of convergence is given by P P = γ P where: max( ) + 1 γ = min( ). max ( 11 1 min( ) 9th European Conference on the Mathematics of Oil Recovery Cannes, France, 3 August - 2 September 24

4 4 As γ is lower than 1, the developed algorithm converges whatever the starting guess. However, it can be very slow for media exhibiting high permeability contrasts. A basic scheme for porous media with higher permeability contrasts In order to speed up the first proposed algorithm, we consider another expression of τ (Eyre and Milton, 1999): τ 2 macro ( I γz) = P ( 12 with γ = 2 Γ I and z = rewritten as a sequence: +. Again, following Neumann expansion, this expression can be 2 ( m+ 1) macro ( m) τ = P + τ γ z. ( 13 The heart of the second FFT-based flow solver is described below. Initialization: τ = 2 P macro ( m) Iterate m+1: τ is known. ( m+1) ( m) 1) compute Q = zτ ; 2) using FFT, compute ˆ m+1 Q ; ( m+ 1 3) compute ˆ τ ) ( ξ ) = ˆ γ zˆ, ξ ( m+ 1 and ) ( ˆ τ =τˆ ) ; ( m+1) 4) using the inverse FFT, compute τ ; 5) set m = m+1 and go back to step 1 until τ 6) When done, derive P and U from τ. ( m + 1) ( m ) τ ε. As above, the rate of convergence depends strongly on. Eyre and Milton (1999) states that the proposed iterative scheme converges optimally when = min( ) max( ) and that the ( m) ( m 1) m macro convergence rate is given by P P = γ P with: max( ) + 1 min( ) γ =. ( 14 max( ) 1 min( ) As γ is lower than 1, the developed algorithm converged whatever the starting guess. Numerical tests A few numerical experiences are performed to evidence the potential of the two suggested FFTbased algorithms to solve a steady-state, incompressible, single-phase flow problem. We consider a lognormal permeability field (Figure 1). The mean and the variance of the logarithm of the permeability values are 3 and 1, respectively. The spatial distribution of these values is characterized by an isotropic spherical variogram with a correlation length of 2 grid blocks. The permeability field is discretized over a 5x5 grid, the size of each grid block being 4x4

5 5 meters. The studied flow problem is defined by Equations 1) and 2) with a fluid viscosity of 1 cp. Boundary conditions are assumed to be periodic: the model is repeated infinitely in each direction and a pressure gradient of,3 kpa/m is applied in the X-direction. This flow problem is solved using (1) a common centered finite-difference solver, (2) the first FFT-based algorithm, and (3) the second FFT-based algorithm. Pressures and Darcy velocities are compared in Figure 2, Figure 3 and Figure 4. We check that the computed pressures and velocities look the same, whatever the solver. However, there are tiny differences which can be explained, at least partly, by the distinct natures of the solvers. First, Darcy velocities are not computed at the same locations (Figure 5). Finite-difference solvers provide velocities at the interfaces between adjacent grid blocks, while the described FFT-based algorithms return the velocities at the centers of the grid blocks. Second, to estimate Darcy velocities, the finite-difference solvers call for the preliminary estimation of interblock transmissibilities. In this paper, the term transmissibility refers to the petroleum use (Aziz and Settari, 1979) which differs from the hydrogeological one (Marsily, 1986). In other words, transmissibility between two adjacent grid blocks is a function of their permeabilities. To compute transmissibilities from permeabilities, most finite-difference simulators use the harmonic average rule, which is theoretically justified for one-dimensional flow solely. Other weighting formulas have been proposed, such as the arithmetic mean, the geometric mean, or the more general power average mean, but their justifications remain empirical (Toronyi and Farouq Ali, 1974; Pettersen, 1983). On the contrary, the proposed FFTbased solvers deal with permeabilities at once: they do not introduce any kind of approximated transmissibility. Table 1 shows a more detailed comparison between the first and the second FFT-based algorithms. Again, the studied permeability field is the one depicted in Figure 1. The flow problem is solved for decreasing ε values. We recall that ε controls the stopping criteria of the iterative schemes. The second algorithm is clearly more efficient than the first one. For a given ε, it converges with a smaller number of iterations. In addition, the estimated effective permeability stabilizes for higher ε. For the studied case, the effective permeability is estimated to be md. To reach this value, the first FFT-based algorithm needs 19 iterations, while the second one requires 21 iterations. Table 1. Comparison between the two proposed FFT-based algorithms. ε is a constant used to stop the iterative procedures. eff is the effective permeability computed at the last iteration. ε 1 st FFT-based algorithm 2 nd FFT-based algorithm Number of iterations eff (md) Number of iterations eff (md) th European Conference on the Mathematics of Oil Recovery Cannes, France, 3 August - 2 September 24

6 6 Figure 1. Studied 5x5 permeability field. Figure 2. Pressures computed using a finite-difference solver (DF), the first FFT-based algorithm (FFT1) and the second FFT-based algorithm (FFT2). Figure 3. Darcy velocities along the X axis computed using a finite-difference solver (DF), the first FFT-based algorithm (FFT1) and the second FFT-based algorithm (FFT2). Figure 4. Darcy velocities along the Y axis computed using a finite-difference solver (DF), the first FFT-based algorithm (FFT1) and the second FFT-based algorithm (FFT2).

7 7 Pi U Pi+1 i+1/2 + a) i Pi Ui, b) +i + i+1 Pi+1 Ui+1 + i+1 Figure 5. Discretization scheme for finite-difference computations (a) and for FFT computations (b). A similar comparison study is performed for a 5x5 categorical permeability field. We actually consider a permeability field with three facies of permeability 5 md, 3 md and 5 md (Figure 6). Thus, the permeability contrast equals 25. Again, we estimate pressures and Darcy velocities from a finite-difference scheme and from the second FFT-base algorithm. The first proposed algorithm was disregarded, because it could not deal with such a high permeability contrast. Results are reported in Figure 7. At first glance, we observe a good agreement between the finite-difference simulation and the FFT-based one. However, the finite-difference results, especially the Darcy velocities, seem to be smoother. This behavior is probably due to the use of transmissibilities. Indeed, transmissibilities are defined as a mean (in this case, we use the harmonic mean) of the permeabilities of adjacent grid blocks. Figure 6. 5x5 facies permeability field. 9th European Conference on the Mathematics of Oil Recovery Cannes, France, 3 August - 2 September 24

8 8 Figure 7. Comparison of pressures and Darcy velocities computed from a finite-difference scheme and the second FFT-based algorithm for the facies permeability described in Figure 6. Last, we focus on a permeability field consisting of one million of grid blocks. Its geostatistical properties are similar to those of the continuous permeability field depicted in Figure 1. Setting ε to 1-2 which seems to be enough to get relevant responses (Table 1), the second FFT-based algorithm converges with 11 iterations which is equivalent to 18 seconds of CPU time on a standard PC. For comparison purposes, we solve the same fluid flow problem using 3DSL, the Streamsim s simulator (Batycky et al., 1997) considering only the pressure solver: we disregard the streamline computations. 3DSL is presented as the industry s most advanced streamlinebased reservoir simulator. It involves finite-volume and multigrid techniques. With this solver, the required CPU time to get velocities and pressures is 2 minutes and 3 seconds. Thus, the second FFT-based algorithm contributes to a CPU-time decrease by a factor of about 7. Conclusions The following main conclusions can be drawn from this study: - Two distinct FFT-based algorithms are proposed to solve steady-state, single phase flow in porous heterogeneous media submitted to periodic boundary conditions. - These algorithms, which are presented as alternatives to standard finite volume or element solvers, turn out to be fast and accurate. - They exhibit an additional interesting feature, that is they do not call for any approximated transmissibility. Computations integrate permeabilities at once. - At this point, we intend to take advantage of these fast flow solvers to implement a global upscaling technique. References [1] Aziz,., and Settari, A., 1979, Petroleum reservoir simulation, London, Applied Science. [2] Batycky, R.P., Blunt, M.J., and Thiele, M.R., 1997, A 3D field-scale streamline based reservoir simulator, SPERE, 4, November. [3] Eyre, D.J., and Milton, G.W., 1999, A fast numerical scheme for computing the response of composites using grid refinement, Eur. Phys. J. AP, 6, [4] Marsily, G. de, 1986, Quantitative hydrology, groundwater hydrology for engineers, Diego, Academic Press. [5] Moulinec, H., and Suquet, P., 1998, A numerical method for computing the overall response of nonlinear composites with complex microstructure, Comput. Methods Appl. Mech. Engrg., 157, [6] Pettersen, O., 1983, Finite-difference representation of permeabilities in heterogeneous models, SPE ATCE, SPE [7] Toronyi, R.M., and Farouq Ali, S.M., 1974, Determining interblock transmissibility in reservoir simulators, Journal of Petroleum Technology, 26(1), [8] Van Lent T.J. and itanidis P.., 1989, A numerical spectral approach for the derivation of piezometric head covariance function. Water Resour. Res., 25(11):

B024 RESERVOIR STREAMLINE SIMULATION ACCOUNTING

B024 RESERVOIR STREAMLINE SIMULATION ACCOUNTING 1 B024 RESERVOIR STREAMLINE SIMULATION ACCOUNTING FOR EFFECTS OF CAPILLARITY AND WETTABILITY R.A. BERENBLYUM, A.A. SHAPIRO, E.H. STENBY IVC-SEP, Department of Chemical Engineering, Technical University

More information

Assessment of Hydraulic Conductivity Upscaling Techniques and. Associated Uncertainty

Assessment of Hydraulic Conductivity Upscaling Techniques and. Associated Uncertainty CMWRXVI Assessment of Hydraulic Conductivity Upscaling Techniques and Associated Uncertainty FARAG BOTROS,, 4, AHMED HASSAN 3, 4, AND GREG POHLL Division of Hydrologic Sciences, University of Nevada, Reno

More information

A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS

A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS Ruben Juanes 1 and Knut-Andreas Lie 2 1 Stanford University, Dept. Petroleum Engineering, USA 2 SINTEF IKT, Dept., Norway ECMOR IX, August 30 September

More information

B008 COMPARISON OF METHODS FOR DOWNSCALING OF COARSE SCALE PERMEABILITY ESTIMATES

B008 COMPARISON OF METHODS FOR DOWNSCALING OF COARSE SCALE PERMEABILITY ESTIMATES 1 B8 COMPARISON OF METHODS FOR DOWNSCALING OF COARSE SCALE PERMEABILITY ESTIMATES Alv-Arne Grimstad 1 and Trond Mannseth 1,2 1 RF-Rogaland Research 2 Now with CIPR - Centre for Integrated Petroleum Research,

More information

A010 MULTISCALE RESERVOIR CHARACTERIZATION USING

A010 MULTISCALE RESERVOIR CHARACTERIZATION USING 1 A010 MULTISCALE RESERVOIR CHARACTERIZATION USING RODUCTION AND TIME LASE SEISMIC DATA Mokhles MEZGHANI, Alexandre FORNEL, Valérie LANGLAIS, Nathalie LUCET IF, 1 & 4 av de Bois réau, 92852 RUEIL-MALMAISON

More information

arxiv: v3 [math.na] 24 Jan 2018

arxiv: v3 [math.na] 24 Jan 2018 Convergence of iterative methods based on Neumann series for composite materials: theory and practice. Hervé Moulinec a, Pierre Suquet a,, Graeme W. Milton b arxiv:7.05880v3 [math.na] 24 Jan 208 Abstract

More information

The effect of heterogeneity on unsteady-state displacements

The effect of heterogeneity on unsteady-state displacements The effect of heterogeneity on unsteady-state displacements Abstract Darryl Fenwick, Nicole Doerler, and Roland Lenormand, Institut Français du Pétrole In this paper, we discuss the effect of heterogeneity

More information

Modeling two-phase flow in strongly heterogeneous porous media

Modeling two-phase flow in strongly heterogeneous porous media Presented at the COMSOL Conference 2010 China COMSOL 2010 I«^rc Modeling two-phase flow in strongly heterogeneous porous media Zhaoqin Huang Research Center for Oil & Gas Flow in Reservoir, School of Petroleum

More information

RATE OF FLUID FLOW THROUGH POROUS MEDIA

RATE OF FLUID FLOW THROUGH POROUS MEDIA RATE OF FLUID FLOW THROUGH POROUS MEDIA Submitted by Xu Ming Xin Kiong Min Yi Kimberly Yip Juen Chen Nicole A project presented to the Singapore Mathematical Society Essay Competition 2013 1 Abstract Fluid

More information

Full waveform inversion of shot gathers in terms of poro-elastic parameters

Full waveform inversion of shot gathers in terms of poro-elastic parameters Full waveform inversion of shot gathers in terms of poro-elastic parameters Louis De Barros, M. Dietrich To cite this version: Louis De Barros, M. Dietrich. Full waveform inversion of shot gathers in terms

More information

Reservoir Simulator Compaction Modelling: A Predictor for Accelerated Coupled Rock Mechanics -- Reservoir Simulation

Reservoir Simulator Compaction Modelling: A Predictor for Accelerated Coupled Rock Mechanics -- Reservoir Simulation Reservoir Simulator Compaction Modelling: A Predictor for Accelerated Coupled Rock Mechanics -- Reservoir Simulation by Øystein Pettersen Centre for Integrated Petroleum Research, Bergen, Norway ECMOR

More information

Homogenization Theory

Homogenization Theory Homogenization Theory Sabine Attinger Lecture: Homogenization Tuesday Wednesday Thursday August 15 August 16 August 17 Lecture Block 1 Motivation Basic Ideas Elliptic Equations Calculation of Effective

More information

II. Dealing with Physical Laws: A Stochastic Flowpath Analysis Example

II. Dealing with Physical Laws: A Stochastic Flowpath Analysis Example II. Dealing with Physical Laws: A Stochastic Flowpath Analysis Example In this chapter we will examine a physical problem where the significance of observing the underlying principles will be displayed.

More information

Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf**

Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf** Controlled CO 2 Diversified fuels Fuel-efficient vehicles Clean refining Extended reserves Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf** *: Laboratoire J.L.Lions **:Université

More information

Simulation study of density-driven natural convection mechanism in isotropic and anisotropic brine aquifers using a black oil reservoir simulator

Simulation study of density-driven natural convection mechanism in isotropic and anisotropic brine aquifers using a black oil reservoir simulator Available online at www.sciencedirect.com Energy Procedia 37 (23 ) 5562 5569 GHGT- Simulation study of density-driven natural convection mechanism in isotropic and anisotropic brine aquifers using a black

More information

A008 THE PROBABILITY PERTURBATION METHOD AN ALTERNATIVE TO A TRADITIONAL BAYESIAN APPROACH FOR SOLVING INVERSE PROBLEMS

A008 THE PROBABILITY PERTURBATION METHOD AN ALTERNATIVE TO A TRADITIONAL BAYESIAN APPROACH FOR SOLVING INVERSE PROBLEMS A008 THE PROAILITY PERTURATION METHOD AN ALTERNATIVE TO A TRADITIONAL AYESIAN APPROAH FOR SOLVING INVERSE PROLEMS Jef AERS Stanford University, Petroleum Engineering, Stanford A 94305-2220 USA Abstract

More information

WITHDRAWAL OF LAYERED FLUID THROUGH A LINE SINK IN A POROUS MEDIUM

WITHDRAWAL OF LAYERED FLUID THROUGH A LINE SINK IN A POROUS MEDIUM J. Austral. Math. Soc. Ser. B 38(1996), 240-254 WITHDRAWAL OF LAYERED FLUID THROUGH A LINE SINK IN A POROUS MEDIUM H. ZHANG and G. C. HOCKING 1 (Received 7 July 1994; revised 10 October 1994) Abstract

More information

Non-Newtonian Flows in Porous Media: upscaling problems

Non-Newtonian Flows in Porous Media: upscaling problems 6/26/8 4th Cargèse Summer School, 208 Non-Newtonian Flows in Porous Media: upscaling problems https://www.dropbox.com/s/mcgg0ifpogsznv2/non_newtonian_v00.pdf?dl=0 Davit Y., Zami-Pierre F.,2, de Loubens

More information

TRACER TESTS FOR VARIOUS CARBONATE CORES USING X-RAY CT

TRACER TESTS FOR VARIOUS CARBONATE CORES USING X-RAY CT SCA005-56 / TRACER TESTS FOR VARIOUS CARBONATE CORES USING X-RAY CT M. Fourar,, G. Konan, C. Fichen, E. Rosenberg, P. Egermann, and R. Lenormand Ecole des Mines de Nancy Laboratoire d Energétique et de

More information

Comparison of the Effects of k-ϵ, k-ω, and Zero Equation Models on Characterization of Turbulent Permeability of Porous Media

Comparison of the Effects of k-ϵ, k-ω, and Zero Equation Models on Characterization of Turbulent Permeability of Porous Media Comparison of the Effects of k-ϵ, k-ω, and Zero Equation Models on Characterization of Turbulent Permeability of Porous Media Charlie Matsubara *, Tim Kuo, Helen Wu PIM Consulting, No. 16, Gonyequ 1 st

More information

Modeling of 1D Anomalous Diffusion In Fractured Nanoporous Media

Modeling of 1D Anomalous Diffusion In Fractured Nanoporous Media LowPerm2015 Colorado School of Mines Low Permeability Media and Nanoporous Materials from Characterisation to Modelling: Can We Do It Better? IFPEN / Rueil-Malmaison - 9-11 June 2015 CSM Modeling of 1D

More information

Chapter 3 Permeability

Chapter 3 Permeability 3.2 Darcy s Law In 1856, Darcy investigated the flow of water through sand filters for water purification. His experimental apparatus is shown in Figure 3.11. By empirical observation Figure 3.11 Schematic

More information

Chapter Seven. For ideal gases, the ideal gas law provides a precise relationship between density and pressure:

Chapter Seven. For ideal gases, the ideal gas law provides a precise relationship between density and pressure: Chapter Seven Horizontal, steady-state flow of an ideal gas This case is presented for compressible gases, and their properties, especially density, vary appreciably with pressure. The conditions of the

More information

Flow of Non-Newtonian Fluids within a Double Porosity Reservoir under Pseudosteady State Interporosity Transfer Conditions

Flow of Non-Newtonian Fluids within a Double Porosity Reservoir under Pseudosteady State Interporosity Transfer Conditions SPE-185479-MS Flow of Non-Newtonian Fluids within a Double Porosity Reservoir under Pseudosteady State Interporosity Transfer Conditions J. R. Garcia-Pastrana, A. R. Valdes-Perez, and T. A. Blasingame,

More information

On the displacement of two immiscible Stokes fluids in a 3D Hele-Shaw cell

On the displacement of two immiscible Stokes fluids in a 3D Hele-Shaw cell On the displacement of two immiscible Stokes fluids in a 3D Hele-Shaw cell Gelu Paşa Abstract. In this paper we study the linear stability of the displacement of two incompressible Stokes fluids in a 3D

More information

New Renormalization Schemes for Conductivity Upscaling in Heterogeneous Media

New Renormalization Schemes for Conductivity Upscaling in Heterogeneous Media Transp Porous Med () 85:677 69 DOI.7/s4--9585-9 New Renormalization Schemes for Conductivity Upscaling in Heterogeneous Media M. R. Karim K. Krabbenhoft Received: 8 February / Accepted: April / Published

More information

A BENCHMARK CALCULATION OF 3D HORIZONTAL WELL SIMULATIONS

A BENCHMARK CALCULATION OF 3D HORIZONTAL WELL SIMULATIONS INTERNATINAL JURNAL F NUMERICAL ANALYSIS AND MDELING Volume 1, Number 2, Pages 189 201 c 2004 Institute for Scientific Computing and Information A BENCHMARK CALCULATIN F 3D HRIZNTAL WELL SIMULATINS ZHANGIN

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 II Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

More information

A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS

A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS JØRG E. AARNES AND YALCHIN EFENDIEV Abstract. methods are currently under active investigation for the simulation

More information

An Update on the Use of Analogy for Oil and Gas Reserves Estimation

An Update on the Use of Analogy for Oil and Gas Reserves Estimation An Update on the Use of Analogy for Oil and Gas Reserves Estimation R.E. (Rod) Sidle to the Houston Chapter of SPEE 3 November 2010 1 Analogy - Origins Term does not appear in 1987 SEC Rule 4-10 Reference

More information

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- CIBLE DISPLACEMENTS N. Mangiavacchi, A.L.G.A. Coutinho, N.F.F. Ebecken Center for Parallel Computations, COPPE / Federal University

More information

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS June - July, 5 Melbourne, Australia 9 7B- NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS Werner M.J. Lazeroms () Linné FLOW Centre, Department of Mechanics SE-44

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Comparing the gradual deformation with the probability perturbation method

Comparing the gradual deformation with the probability perturbation method Comparing the gradual deformation with the probability perturbation method Jef Caers Petroleum Engineering Department Stanford University, California USA 1. Introduction This paper is intended as a comparison

More information

Petroleum reservoir simulation using EbFVM: the negative transmissibility issue

Petroleum reservoir simulation using EbFVM: the negative transmissibility issue Computational Methods in Multhase Flow IV 133 etroleum reservoir simulation using EbFVM: the negative transmissibility issue C. R. Maliska, J. Cordazzo & A. F. C. Silva Computational Fluid Dynamics Laboratory,

More information

Modelling of CO 2 storage and long term behaviour in the Casablanca field

Modelling of CO 2 storage and long term behaviour in the Casablanca field Available online at www.sciencedirect.com Energy Procedia 1 (2009) (2008) 2919 2927 000 000 GHGT-9 www.elsevier.com/locate/xxx www.elsevier.com/locate/procedia Modelling of CO 2 storage and long term behaviour

More information

Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems

Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems Sanjay K Khattri Abstract We present an Altered Jacobian Newton Iterative Method for solving nonlinear elliptic problems Effectiveness

More information

Comparison of Averaging Methods for Interface Conductivities in One-dimensional Unsaturated Flow in Layered Soils

Comparison of Averaging Methods for Interface Conductivities in One-dimensional Unsaturated Flow in Layered Soils Comparison of Averaging Methods for Interface Conductivities in One-dimensional Unsaturated Flow in Layered Soils Ruowen Liu, Bruno Welfert and Sandra Houston School of Mathematical & Statistical Sciences,

More information

Reservoir Flow Properties Fundamentals COPYRIGHT. Introduction

Reservoir Flow Properties Fundamentals COPYRIGHT. Introduction Reservoir Flow Properties Fundamentals Why This Module is Important Introduction Fundamental understanding of the flow through rocks is extremely important to understand the behavior of the reservoir Permeability

More information

The Certified Reduced-Basis Method for Darcy Flows in Porous Media

The Certified Reduced-Basis Method for Darcy Flows in Porous Media The Certified Reduced-Basis Method for Darcy Flows in Porous Media S. Boyaval (1), G. Enchéry (2), R. Sanchez (2), Q. H. Tran (2) (1) Laboratoire Saint-Venant (ENPC - EDF R&D - CEREMA) & Matherials (INRIA),

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

Rate Transient Analysis COPYRIGHT. Introduction. This section will cover the following learning objectives:

Rate Transient Analysis COPYRIGHT. Introduction. This section will cover the following learning objectives: Learning Objectives Rate Transient Analysis Core Introduction This section will cover the following learning objectives: Define the rate time analysis Distinguish between traditional pressure transient

More information

Fracture-Matrix Flow Partitioning and Cross Flow: Numerical Modeling of Laboratory Fractured Core Flood

Fracture-Matrix Flow Partitioning and Cross Flow: Numerical Modeling of Laboratory Fractured Core Flood Fracture-Matrix Flow Partitioning and Cross Flow: Numerical Modeling of Laboratory Fractured Core Flood R. Sanaee *, G. F. Oluyemi, M. Hossain, and M. B. Oyeneyin Robert Gordon University *Corresponding

More information

Analysis of a drainage efficiency in stratified porous media

Analysis of a drainage efficiency in stratified porous media Analysis of a drainage efficiency in stratified porous media CHAKIB SELADJI Département de Génie Mécanique Université Abou Bekr BELKAID BP 119 Chétouane Tlemcen 13000 ALGERIA seladji@yahoo.fr Abstract:

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

Calculation of Permeability Tensors for Unstructured Grid Blocks

Calculation of Permeability Tensors for Unstructured Grid Blocks Calculation of Permeability Tensors for Unstructured Grid Blocs R. M. Hassanpour, O. Leuangthong and C.V. Deutsch Centre for Computational Geostatistics Department of Civil and Environmental Engineering

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Geostatistical History Matching coupled with Adaptive Stochastic Sampling: A zonation-based approach using Direct Sequential Simulation

Geostatistical History Matching coupled with Adaptive Stochastic Sampling: A zonation-based approach using Direct Sequential Simulation Geostatistical History Matching coupled with Adaptive Stochastic Sampling: A zonation-based approach using Direct Sequential Simulation Eduardo Barrela* Instituto Superior Técnico, Av. Rovisco Pais 1,

More information

A CLASSICAL SOLUTION OF THE PROBLEM OF SEEPAGE IN TWO LAYERED SOIL WITH AN INCLINED BOUNDARY

A CLASSICAL SOLUTION OF THE PROBLEM OF SEEPAGE IN TWO LAYERED SOIL WITH AN INCLINED BOUNDARY International Journal of Mathematical Sciences Vol., No. 3-4, July-December, pp. 69-74 Serials Publications A CLASSICAL SOLUTION OF THE PROBLEM OF SEEPAGE IN TWO LAYERED SOIL WITH AN INCLINED BOUNDARY

More information

ChE 385M Surface Phenomena University of Texas at Austin. Marangoni-Driven Finger Formation at a Two Fluid Interface. James Stiehl

ChE 385M Surface Phenomena University of Texas at Austin. Marangoni-Driven Finger Formation at a Two Fluid Interface. James Stiehl ChE 385M Surface Phenomena University of Texas at Austin Marangoni-Driven Finger Formation at a Two Fluid Interface James Stiehl Introduction Marangoni phenomena are driven by gradients in surface tension

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

Determination of Locally Varying Directions through Mass Moment of Inertia Tensor

Determination of Locally Varying Directions through Mass Moment of Inertia Tensor Determination of Locally Varying Directions through Mass Moment of Inertia Tensor R. M. Hassanpour and C.V. Deutsch Centre for Computational Geostatistics Department of Civil and Environmental Engineering

More information

SCA : A STRUCTURAL MODEL TO PREDICT TRANSPORT PROPERTIES OF GRANULAR POROUS MEDIA Guy Chauveteau, IFP, Yuchun Kuang IFP and Marc Fleury, IFP

SCA : A STRUCTURAL MODEL TO PREDICT TRANSPORT PROPERTIES OF GRANULAR POROUS MEDIA Guy Chauveteau, IFP, Yuchun Kuang IFP and Marc Fleury, IFP SCA2003-53: A STRUCTURAL MODEL TO PREDICT TRANSPORT PROPERTIES OF GRANULAR POROUS MEDIA Guy Chauveteau, IFP, Yuchun Kuang IFP and Marc Fleury, IFP This paper was prepared for presentation at the International

More information

A013 HISTORY MATCHING WITH RESPECT TO RESERVOIR STRUCTURE

A013 HISTORY MATCHING WITH RESPECT TO RESERVOIR STRUCTURE A3 HISTORY MATCHING WITH RESPECT TO RESERVOIR STRUCTURE SIGURD IVAR AANONSEN ; ODDVAR LIA ; AND OLE JAKOB ARNTZEN Centre for Integrated Research, University of Bergen, Allégt. 4, N-7 Bergen, Norway Statoil

More information

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE In this chapter, the governing equations for the proposed numerical model with discretisation methods are presented. Spiral

More information

FFT-based Galerkin method for homogenization of periodic media

FFT-based Galerkin method for homogenization of periodic media FFT-based Galerkin method for homogenization of periodic media Jaroslav Vondřejc 1,2 Jan Zeman 2,3 Ivo Marek 2 Nachiketa Mishra 4 1 University of West Bohemia in Pilsen, Faculty of Applied Sciences Czech

More information

Simple closed form formulas for predicting groundwater flow model uncertainty in complex, heterogeneous trending media

Simple closed form formulas for predicting groundwater flow model uncertainty in complex, heterogeneous trending media WATER RESOURCES RESEARCH, VOL. 4,, doi:0.029/2005wr00443, 2005 Simple closed form formulas for predicting groundwater flow model uncertainty in complex, heterogeneous trending media Chuen-Fa Ni and Shu-Guang

More information

MHD and Thermal Dispersion-Radiation Effects on Non-Newtonian Fluid Saturated Non-Darcy Mixed Convective Flow with Melting Effect

MHD and Thermal Dispersion-Radiation Effects on Non-Newtonian Fluid Saturated Non-Darcy Mixed Convective Flow with Melting Effect ISSN 975-333 Mapana J Sci,, 3(22), 25-232 https://doi.org/.2725/mjs.22.4 MHD and Thermal Dispersion-Radiation Effects on Non-Newtonian Fluid Saturated Non-Darcy Mixed Convective Flow with Melting Effect

More information

This paper was prepared for presentation at the Unconventional Resources Technology Conference held in Denver, Colorado, USA, August 2013.

This paper was prepared for presentation at the Unconventional Resources Technology Conference held in Denver, Colorado, USA, August 2013. 1 SPE 168873 / URTeC 1606914 Numerical Upcaling of Coupled Flow and Geomechanics in Highly Heterogeneous Porous Media Daegil Yang, Texas A&M University; George J. Moridis, Lawrence Berkeley National Laboratory;

More information

Studies on flow through and around a porous permeable sphere: II. Heat Transfer

Studies on flow through and around a porous permeable sphere: II. Heat Transfer Studies on flow through and around a porous permeable sphere: II. Heat Transfer A. K. Jain and S. Basu 1 Department of Chemical Engineering Indian Institute of Technology Delhi New Delhi 110016, India

More information

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline - Part 4 - Multicore and Manycore Technology: Chances and Challenges Vincent Heuveline 1 Numerical Simulation of Tropical Cyclones Goal oriented adaptivity for tropical cyclones ~10⁴km ~1500km ~100km 2

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

Revising Darcy s law: a necessary step toward progress in fluid mechanics and reservoir engineering

Revising Darcy s law: a necessary step toward progress in fluid mechanics and reservoir engineering Advances in Fluid Mechanics VI 615 Revising Darcy s law: a necessary step toward progress in fluid mechanics and reservoir engineering C. Ketata, M. G. Satish & M. R. Islam Department of Civil Engineering,

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 III Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

More information

ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer

ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer Solution to Final Examination Date: May 4, 2011 1:00 3:00 PM Instructor: J. Murthy Open Book, Open Notes Total: 100 points Use the finite volume

More information

Fractional Transport Models for Shale Gas in Tight Porous Media

Fractional Transport Models for Shale Gas in Tight Porous Media Engineering Conferences International ECI Digital Archives Sixth International Conference on Porous Media and Its Applications in Science, Engineering and Industry Proceedings 7-5-2016 Fractional Transport

More information

TIME SPACE DOMAIN DECOMPOSITION AND REACTIVE TRANSPORT IN POROUS MEDIA

TIME SPACE DOMAIN DECOMPOSITION AND REACTIVE TRANSPORT IN POROUS MEDIA XVIII International Conference on Water Resources CMWR 2 J. Carrera (Ed) c CIMNE, Barcelona, 2 TIME SPACE DOMAIN DECOMPOSITION AND REACTIVE TRANSPORT IN POROUS MEDIA Florian Haeberlein and Anthony Michel

More information

6. GRID DESIGN AND ACCURACY IN NUMERICAL SIMULATIONS OF VARIABLY SATURATED FLOW IN RANDOM MEDIA: REVIEW AND NUMERICAL ANALYSIS

6. GRID DESIGN AND ACCURACY IN NUMERICAL SIMULATIONS OF VARIABLY SATURATED FLOW IN RANDOM MEDIA: REVIEW AND NUMERICAL ANALYSIS Harter Dissertation - 1994-132 6. GRID DESIGN AND ACCURACY IN NUMERICAL SIMULATIONS OF VARIABLY SATURATED FLOW IN RANDOM MEDIA: REVIEW AND NUMERICAL ANALYSIS 6.1 Introduction Most numerical stochastic

More information

Application of finite difference method to estimation of diffusion coefficient in a one dimensional nonlinear inverse diffusion problem

Application of finite difference method to estimation of diffusion coefficient in a one dimensional nonlinear inverse diffusion problem International Mathematical Forum, 1, 2006, no. 30, 1465-1472 Application of finite difference method to estimation of diffusion coefficient in a one dimensional nonlinear inverse diffusion problem N. Azizi

More information

Green s Function for Tenuous Random Media

Green s Function for Tenuous Random Media EECS 730, Winter 2009 c K. Sarabandi Green s Function for Tenuous Random Media In the previous section we demonstrated the application of wave theory to a tenuous medium excited by a plane wave for evaluating

More information

A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach

A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach SPE-172990-MS A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach Benjamin Ganis, Kundan Kumar, and Gergina Pencheva, SPE; Mary F. Wheeler, The

More information

Reservoir Simulator Practical

Reservoir Simulator Practical Reservoir Simulator Practical Course Notes 2012 Philipp Lang IZR Room 403 Tel 3004 philipp.lang@unileoben.ac.at for further information please refer to the accompanying document Info Sheet & Course Logistics

More information

PORE PRESSURE EVOLUTION AND CORE DAMAGE: A COMPUTATIONAL FLUID DYNAMICS APPROACH

PORE PRESSURE EVOLUTION AND CORE DAMAGE: A COMPUTATIONAL FLUID DYNAMICS APPROACH SCA211-41 1/6 PORE PRESSURE EVOLUTION AND CORE DAMAGE: A COMPUTATIONAL FLUID DYNAMICS APPROACH I. Zubizarreta, M. Byrne, M.A. Jimenez, E. Roas, Y. Sorrentino and M.A. Velazco. Senergy. Aberdeen, United

More information

Hydraulic tomography: Development of a new aquifer test method

Hydraulic tomography: Development of a new aquifer test method WATER RESOURCES RESEARCH, VOL. 36, NO. 8, PAGES 2095 2105, AUGUST 2000 Hydraulic tomography: Development of a new aquifer test method T.-C. Jim Yeh and Shuyun Liu Department of Hydrology and Water Resources,

More information

A theoretical model for relative permeabilities in two-phase flow in a fracture

A theoretical model for relative permeabilities in two-phase flow in a fracture A theoretical model for relative permeabilities in two-phase flow in a fracture M. Fourar & C. Moyne Ecole des Mines Laboratoire d'energetique et de Mecanique Theorique et Appliquee Pare de Saurupt - 54042

More information

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

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

More information

A Two-grid Method for Coupled Free Flow with Porous Media Flow

A Two-grid Method for Coupled Free Flow with Porous Media Flow A Two-grid Method for Coupled Free Flow with Porous Media Flow Prince Chidyagwai a and Béatrice Rivière a, a Department of Computational and Applied Mathematics, Rice University, 600 Main Street, Houston,

More information

Modeling Reactive Flows in Porous Media

Modeling Reactive Flows in Porous Media Modeling Reactive Flows in Porous Media Peter Lichtner (lead PI), Los Alamos National Laboratory Glenn Hammond, Pacific Northwest National Laboratory Richard Tran Mills, Oak Ridge National Laboratory NCCS

More information

NEW DEMANDS FOR APPLICATION OF NUMERICAL SIMULATION TO IMPROVE RESERVOIR STUDIES IN CHINA

NEW DEMANDS FOR APPLICATION OF NUMERICAL SIMULATION TO IMPROVE RESERVOIR STUDIES IN CHINA INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 2, Supp, Pages 148 152 c 2005 Institute for Scientific Computing and Information NEW DEMANDS FOR APPLICATION OF NUMERICAL SIMULATION TO IMPROVE

More information

Hydromagnetic oscillatory flow through a porous medium bounded by two vertical porous plates with heat source and soret effect

Hydromagnetic oscillatory flow through a porous medium bounded by two vertical porous plates with heat source and soret effect Available online at www.pelagiaresearchlibrary.com Advances in Applied Science Research, 2012, 3 (4):2169-2178 ISSN: 0976-8610 CODEN (USA): AASRFC Hydromagnetic oscillatory flow through a porous medium

More information

TENSOR RELATIVE PERMEABILITIES: ORIGINS, MODELING AND NUMERICAL DISCRETIZATION

TENSOR RELATIVE PERMEABILITIES: ORIGINS, MODELING AND NUMERICAL DISCRETIZATION INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 9, Number 3, Pages 701 724 c 2012 Institute for Scientific Computing and Information TENSOR RELATIVE PERMEABILITIES: ORIGINS, MODELING AND

More information

Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids

Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids Jørg Espen Aarnes and Vera Louise Hauge SINTEF ICT, Deptartment of Applied Mathematics Applied Mathematics

More information

On the choice of abstract projection vectors for second level preconditioners

On the choice of abstract projection vectors for second level preconditioners On the choice of abstract projection vectors for second level preconditioners C. Vuik 1, J.M. Tang 1, and R. Nabben 2 1 Delft University of Technology 2 Technische Universität Berlin Institut für Mathematik

More information

ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS

ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS VINCENT FONTAINE 1,2 AND ANIS YOUNES 2 1 Laboratoire de Physique des Bâtiments et des Systèmes, Université de La Réunion, 15 avenue

More information

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Igor Mozolevski, Endre Süli Federal University of Santa Catarina, Brazil Oxford University Computing Laboratory,

More information

Flow of shale gas in tight rocks using a non-linear transport model with pressure dependent model parameters

Flow of shale gas in tight rocks using a non-linear transport model with pressure dependent model parameters Engineering Conferences International ECI Digital Archives Sixth International Conference on Porous Media and Its Applications in Science, Engineering and Industry Proceedings 7-4-2016 Flow of shale gas

More information

Inverse Modelling for Flow and Transport in Porous Media

Inverse Modelling for Flow and Transport in Porous Media Inverse Modelling for Flow and Transport in Porous Media Mauro Giudici 1 Dipartimento di Scienze della Terra, Sezione di Geofisica, Università degli Studi di Milano, Milano, Italy Lecture given at the

More information

In all of the following equations, is the coefficient of permeability in the x direction, and is the hydraulic head.

In all of the following equations, is the coefficient of permeability in the x direction, and is the hydraulic head. Groundwater Seepage 1 Groundwater Seepage Simplified Steady State Fluid Flow The finite element method can be used to model both steady state and transient groundwater flow, and it has been used to incorporate

More information

Permeability and fluid transport

Permeability and fluid transport Permeability and fluid transport Thermal transport: Fluid transport: q = " k # $p with specific discharge (filter velocity) q [m s 1 ] pressure gradient p [N m 3 ] dynamic viscosity η [N s m 2 ] (intrinsic)

More information

A hybrid Marquardt-Simulated Annealing method for solving the groundwater inverse problem

A hybrid Marquardt-Simulated Annealing method for solving the groundwater inverse problem Calibration and Reliability in Groundwater Modelling (Proceedings of the ModelCARE 99 Conference held at Zurich, Switzerland, September 1999). IAHS Publ. no. 265, 2000. 157 A hybrid Marquardt-Simulated

More information

On the Numerical Modelling of Orthotropic Large Strain Elastoplasticity

On the Numerical Modelling of Orthotropic Large Strain Elastoplasticity 63 Advances in 63 On the Numerical Modelling of Orthotropic Large Strain Elastoplasticity I. Karsaj, C. Sansour and J. Soric Summary A constitutive model for orthotropic yield function at large strain

More information

Analytical Coupled Axial and Radial Productivity Model for Steady-State Flow in Horizontal Wells. Thormod Johansen*, Lesley James, Jie Cao

Analytical Coupled Axial and Radial Productivity Model for Steady-State Flow in Horizontal Wells. Thormod Johansen*, Lesley James, Jie Cao Int. J. Petroleum Engineering, Vol. x, No. x, 1 19 1 Analytical Coupled Axial and Radial Productivity Model for Steady-State Flow in Horizontal Wells Thormod Johansen*, Lesley James, Jie Cao Engineering

More information

DETERMINING THE DISTRIBUTION TEMPERATURE FIELD AROUND THE STEAM INJECTING WELLS BY USING THE ECLIPSE TM SIMULATOR

DETERMINING THE DISTRIBUTION TEMPERATURE FIELD AROUND THE STEAM INJECTING WELLS BY USING THE ECLIPSE TM SIMULATOR Bulletin of the Transilvania University of Brasov Vol. 2 (51) 2009 Series I: Engineering Sciences DETERMINING THE DISTRIBUTION TEMPERATURE FIELD AROUND THE STEAM INJECTING WELLS BY USING THE ECLIPSE TM

More information

Termination criteria for inexact fixed point methods

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

More information

Darcy's Law. Laboratory 2 HWR 531/431

Darcy's Law. Laboratory 2 HWR 531/431 Darcy's Law Laboratory HWR 531/431-1 Introduction In 1856, Henry Darcy, a French hydraulic engineer, published a report in which he described a series of experiments he had performed in an attempt to quantify

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

Upscaling non-darcy flow

Upscaling non-darcy flow Transport in Porous Media manuscript No. (will be inserted by the editor) Upscaling non-darcy flow C.R. Garibotti M.Peszyńska Received: date / Accepted: date Abstract We consider upscaling of non-darcy

More information

NUMERICAL MODELING OF FLOW THROUGH DOMAINS WITH SIMPLE VEGETATION-LIKE OBSTACLES

NUMERICAL MODELING OF FLOW THROUGH DOMAINS WITH SIMPLE VEGETATION-LIKE OBSTACLES XIX International Conference on Water Resources CMWR 2012 University of Illinois at Urbana-Champaign June 17-22,2012 NUMERICAL MODELING OF FLOW THROUGH DOMAINS WITH SIMPLE VEGETATION-LIKE OBSTACLES Steven

More information

arxiv: v1 [cond-mat.stat-mech] 2 Jun 2013

arxiv: v1 [cond-mat.stat-mech] 2 Jun 2013 Water Propagation in the Porous Media, Self-Organized Criticality and Ising Model M. N. Najafi Department of Physics, University of Mohaghegh Ardabili, P.O. Box 179, Ardabil, Iran M. Ghaedi Chemical and

More information

Table of Contents. Preface... xiii

Table of Contents. Preface... xiii Preface... xiii PART I. ELEMENTS IN FLUID MECHANICS... 1 Chapter 1. Local Equations of Fluid Mechanics... 3 1.1. Forces, stress tensor, and pressure... 4 1.2. Navier Stokes equations in Cartesian coordinates...

More information