THE IMPLEMENTATION AND NUMERICAL ANALYSIS OF FULLY-COUPLED NON- ISOTHERMAL FLUID FLOW THROUGH A DEFORMABLE POROUS MEDIUM

Size: px
Start display at page:

Download "THE IMPLEMENTATION AND NUMERICAL ANALYSIS OF FULLY-COUPLED NON- ISOTHERMAL FLUID FLOW THROUGH A DEFORMABLE POROUS MEDIUM"

Transcription

1 THE IMPLEMENTATION AND NUMERICAL ANALYSIS OF FULLY-COUPLED NON- ISOTHERMAL FLUID FLOW THROUGH A DEFORMABLE POROUS MEDIUM Justin Pogacnik 1, Peter Leary 1, and Peter Malin 1 1 Institute for Earth Science and Engineering, University of Auckland, 58 Symonds St. Floor 6, j.pogacnik@auckland.ac.nz Keywords: Fully coupled finite element model, deformable porous media, geothermal systems, heat and mass transfer, power-law scaling. ABSTRACT This work seeks to simulate subsurface fluid flow and heat transport within a deformable porous medium. Previous work indicates that it is imperative to consider the in situ spatial fluctuations recorded in well-log and well-core data to achieve accurate numerical flow simulations for nondeforming porous solids. The consideration of in situ spatial property fluctuations naturally gives rise to preferential pathways of fluid flow and heat transport. Provision for solid deformations offers a logical step forward to allow for stress-controlled fluctuation evolution of in situ properties. A sophisticated numerical model will be able to capture the growth and collapse of in situ voids, fractures, and fracture connectivity due to variation in fluid pressure and flow, faulting, and temperature as, say, induced at Enhanced/Engineered Geothermal System (EGS) projects. The relevant linear momentum, mass, and enthalpy balance equations have been coupled in a combined finite element and finite difference analysis. The governing differential equations and discretized set of equations are realized in preliminary results for 2D vertical planes in which one or more horizontal wellbores act as flow sources/sinks. The model presented in this work is a critical first step toward full 3D EGS heat exchange reservoir development and fluid flow simulation. 1. INTRODUCTION Traditionally, the true spatial variations of porosity and permeability are ignored in favor of their mean values (e.g., Sutter et al., 2011). However, previous work indicates that it is imperative to consider true spatial fluctuations in poroperm properties. Leary and Walter (2008) show that observed tight gas well production unpredictability is traceable to the false assumption that in situ flow in gas sands is quasi-uniform rather than spatially fluctuating. On an economic note, Goldstein et al (2011) cite insufficiently predictable reliability of geothermal reservoir performance (and in particular, the [un]predictable reliability of EGS reservoirs) that is traceable to EGS models based on quasiuniform media. Quasi-uniform media are effectively assumed to have a white noise Fourier power-spectra in spatial frequency k, S ( k) ~ const. Microresistivity and most other geophysical well-log data have, however, Fourier power-spectra that scale inversely with wave number by S(k)~ 1 k over about 5 decades of the length scale from 10-2 m to 10 3 m. The specific well log properties that obey this law include: sonic wave speeds, electrical resistivity, soluble chemical species density, neutron porosity, and mass density. Also, via fracture-connectivity percolation, clastic rock well-core data show a close spatial fluctuation relationship between well-core permeability and well-core porosity n n ~ log( ) that governs how permeability spatially varies in situ. This work simulates subsurface fluid flow and heat transport within a 2-D deformable porous medium with power-law scaling fluctuations in porosity combined with the aforementioned relationship controlling permeability. Few available finite element codes are equipped to handle the full spatial variability in porosity and permeability that are necessary to accurately depict the physics of in situ flow and heat transport. Further, the codes that can handle this behavior do not solve for the fully coupled problem, but only consider fluid and thermal flow through nondeformable media. Therefore, a new finite element code was written in C++ that is capable of modeling the abovementioned scenario. Section 2 details the boundary value problem and the governing coupled differential equations for the linear momentum balance, mass balance, and enthalpy balance. In Section 3, the finite element method is applied to yield a discretized linear system of equations where the unknowns are nodal values for solid displacements, pore fluid pressures, and temperatures. Section 4 outlines a benchmark problem and a specific trial numerical analysis for a 2D vertical section consisting of two horizontal wellbores cycling water in/out of an EGS volume. Section 5 provides discussion of the preliminary results and the future work that is being undertaken for this analysis. 2. GOVERNING EQUATIONS 2.1 Linear Momentum Balance A suitable first step in acquiring the finite element system of equations is to consider the linear momentum balance: g 0 where refers to the gradient operator, is the Cauchy stress tensor, g is the gravity acceleration vector, and is the average density of the entire matrix: 1

2 1 n s n w, where s is the density of the solid grains, w is the density of the fluid (water) surrounding the grains, and n is the porosity defined as the volume of void space per unit volume. The Cauchy stress can be expressed as a vector and split into two components, the effective stress component ''and a pore pressure component as ''mp, where is a dimensionless constant between 0 and 1, m is related to the identity tensor, and p is the pore fluid pressure (Lewis and Schrefler 1998; Ingebritsen, Sanford, and Neuzil 2006). Assuming linear isotropic elastic behavior, the effective stress is calculated as '' D e T, where D is the standard elasticity tensor, e is the mechanical strain vector, and T is the thermal strain vector. In the effective stress equation, and Lu T m s 3 T where L is a matrix of spatial derivatives, u is the displacement vector, m again is related to the identity matrix, s is the coefficient of thermal expansion of the solid matrix, and T is the temperature. 2.2 Mass Balance Consideration of both the fluid and solid mass balance equations gives: 0 (1 n) s n w T t 1 n K s v s p g w Q p n K w p t w C w C s s T t w C w T 0 w P g T where C w is the specific heat of the fluid, C s is the specific heat of the solid grains, and is related to the diffusivity of the medium. The thermal properties of solid and fluid are taken to be constant in space and time with the exception of fluid density, which has standard linearized temperature dependence. The assumption of constant fluid viscosity is disputable. In these simulations, the fluid viscosity for water at 200C was used (Table 1). The possibility exists to incorporate temperature-dependent spatial variations in fluid viscosity into the code (Figure 15). This is the subject of future work. Compared with spatial variation in fracture density and poroperm properties documented by well-log and well core data to vary significantly on all scale lengths, the thermal properties of rock constituents vary little in value and have few observable constraints to enter into the model equations. 3. THE FINITE ELEMENT METHOD 3.1 Boundary Value Problem Figure 1 depicts an arbitrary 2-D porous domain with a boundary that is subject to natural and essential boundary conditions on portions of denoted h and g, respectively. Natural boundary conditions enforce forces on the system, such as external tractions, mass fluid flow, or temperature fluxes. Essential boundary conditions enforce known degrees of freedom, such as solid displacements, pore fluid pressures, and temperature. The domain is considered to be a fully saturated assemblage of rigid solid grains bonded by weak cements and having a spatially fluctuating density of fluid-filled void space between grains. Void space fluids percolate between voids where grain-grain cement bonds are ruptured by tectonically imposed finite-strain of the bulk medium. The controlling physical variable is grain-scale fracture density. At a critical density of grain-scale fractures, long-range spatial correlations between grain-scale fractures arise, creating the observed power-law scaling properties of well log spatial fluctuations (Leary 2002). where S w is the fluid saturation and has been omitted for the fully saturated case, v s is the solid matrix velocity from the system elastic modulus, is the permeability matrix, and Q p is fluid flow into the system. 2.3 Enthalpy Balance Lastly, to fully couple thermal effects, we consider the enthalpy balance equation: Figure 1: An arbitrary porous domain. The solid-fluid matrix is non-isothermal and grain assemblages are subject to small strains on all scale lengths. Therefore, the problem is evaluated as a coupled problem 2

3 involving temperature and fluid flow through a deformable porous medium. 3.2 Discretization and Solution The first step in the application of the Finite Element Method (FEM) is to define the approximation spaces for the nodal values of the unknowns: displacement, pressure, and temperature. These functions are defined by: u* N u u p* N p p T* N T T where (.)* represents the exact solution of the unknowns, the N * are the finite element shape functions that are a vector in the case of the scalar unknowns and a 2 nd order tensor in the case of the vector unknown (displacement). The vectors u, p, and T are the finite element approximations to the exact solutions. The shape functions are not necessarily the same order. There is evidence reported in the literature that higher order shape functions are required for the displacement degrees of freedom in the undrained limit state. This is called a mixed method and requires elements that satisfy the Babuska-Brezzi convergence criterion. Elements that use second-order interpolation functions for displacement degrees of freedom and first-order interpolation functions for pressure and temperature degrees of freedom satisfy this condition. These elements were implemented and used in this work. Each quadrilateral element contains 4 nodes for representing pressure and temperature degrees of freedom, but nine nodes to represent displacement degrees of freedom. The main advantage of mixed method elements reported by Lewis and Schrefler (1998) and Aboustit (1985) is a significant decrease in pressure field oscillations. The results reported in Section 4 utilize higher order mixed elements. Introducing the standard finite element discretization gives rise to the global system of equations to be solved: and where: K Ku K tt T Qp f u H P Q T u t S P t R T t f p B T D e Bd C t T t K t T f t K tt Q H B T D e m s 3 N T d B T mn p d N p T w N p d T 1 n S N p n N T d K s K w R N p T (n 1) s n w C t N T T w C w C s s N T d N T d K t N T T w C w N p P p w gn T d N T w f u N T u gd N T u t d f p N p T gd q out Q in w f t N T T N T nd q(t *T ) Where w C w n s 1 n w I T N T d is the diffusivity tensor with solid and fluid diffusivities and I is the identity tensor. The matrices B, N *, and D e are standard matrices used in finite elements. Their exact structure can be found in Lewis and Schrefler (1998) or Hughes (2000). The values of Young s modulus, Poisson s ratio (both in D ), e s, s, w, S w, n, C s, C w, s, w, w, and are material input parameters. K introduces a nonlinearity into the system of equations t that must be solved using an appropriate technique, such as the Newton-Raphson iteration scheme. The final matrix system of equations that is solved can be constructed as: K Q K tt u u 0 H 0 p Q T S R d p dt 0 0 K t T 0 0 C t T f u f p f t 3

4 This system can be re-written as: Ax B dx dt F and can be solved using a single-step finite difference operator such as in Lewis and Schrefler (1998) or Zienkiewicz and Taylor (2000). 4. NUMERICAL IMPLEMENTATION/ANALYSIS The governing system of equations introduced in the previous section was solved using a C++ in-house finite element code. Preliminary investigations have been carried out on a 2D benchmark problem and a 2D EGS heat exchange volume. The EGS simulations show the potential capabilities of solving the fully coupled EGS heat exchange problem in a realistic poroperm medium. The numerical implementation is not complete in its current state. The details of future work and capabilities are important and will be discussed in Section 5. Table 1 shows the material parameters used in this work. The parameters are taken to be an approximation for an EGS volume from parameters given in the SUTRA user s manual, Ingebritsen, et al. (2006), and Lewis and Schrefler (1998). These parameters and boundary conditions compose a representative parameter space intended demonstrate the potential capabilities of the FE code. More simulations will be run with more appropriate boundary conditions and material parameters in the future. Note that porosity and permeability are taken to be constants in the table. The constant presented is the mean value of data that fluctuates with 1/k spatial correlation sometimes called pink noise. This is consistent with the spatial fluctuation in well-log data in most EGS volumes. Observed well-log and well-core spatial variation about the mean is of order ~ 5%-10%. For permeability, it is understood that this fluctuation magnitude applies to the logarithm of permeability, hence leading to substantially greater variation of permeability per se. Table 2: Input Material Properties Symbol Parameter Value Units E Young's modulus 72.9 Gpa ν Poisson's ratio 0.14 β s solid coefficient of thermal expansion 5.50E 07 1/ C ρ s solid density 2600 kg/m 3 ρ w fluid density 1000 kg/m 3 S w fluid saturation 1 n porosity 0.2 C s solid specific heat 840 J/kg C C w fluid specific heat 4182 J/kg C σ s solid thermal conductivity 3.5 J/s m C σ w fluid thermal conductivity 0.6 J/s m C μ w fluid viscosity kg/m s κ permeability 1.00E 12 m 2 β w fluid coefficient of thermal expansion 2.02E 04 1/ C 4.1 Benchmarking Procedures No analytical solutions to this coupled problem exist. To ensure that the code developed is working properly, the results can be compared to those presented in Lewis and Schrefler (1998) and Aboustit, et al. (1985). Both report the 4 results of the same non-isothermal fully-saturated soil column consolidation problem. It is rather difficult to offer a direct comparison between the two problems because some of the material parameters used in this formulation are combined into effective parameters in the benchmark problem presented by the authors and it is not possible to exactly replicate their parameter space from the data they present. However, we will show that the trends in behavior are the same even with realistic EGS field parameters and in investigations not shown here, it is possible to reproduce the trends seen in Lewis and Schrefler (1998) by adjusting the material parameters. Figure 2 displays the mesh used in the benchmark consolidation problem for this work. The bottom surface of the geometry is fixed in the vertical direction, while the sidewalls are fixed from displacement in the horizontal direction. The top surface has a prescribed traction of 1000 Pa applied, where the temperature is fixed at 50 C and the pore fluid pressure is set to be 0 Pa. The rest of the domain boundaries are fully insulated and sealed. In the outputs, we will analyze nodal values of displacement, pore fluid pressure, and temperature along all the nodes along the right sidewall boundary. The results are fully symmetric in the 2D (effectively 1D) problem, so either sidewall could be analyzed. Figure 2: Benchmark mesh for non-isothermal consolidation problem. Adapted from (Aboustit, et al., 1985). In accordance with the discussion from Lewis and Schrefler (1998), the matrices R and K tt were set to zero. This means that temperature changes are not deemed to have a significant impact on the deformation state of the material and the coupling of the pore fluid pressure to changes in temperature are also small compared to the rest of the effects. This may be true for the material parameter space chosen in the work of Aboustit, et al. (1985), but for realistic parameter spaces at EGS depths, this simplification should not be allowed. Figure 3 displays the displacement (consolidation) response of the medium from Lewis and Schrefler (1998) and Figure 4 displays the consolidation result from this work. The magnitudes of the displacements are not important, since different choices of material parameters can affect this. Even the signs of the displacement can be affected by the parameters associated with the coupling matrices. It is possible to reproduce these magnitudes and even the peak displacement before consolidation by adjusting the parameter space. However, Lewis and Schrefler (1998)

5 report that this peak disappears when realistic values for the bulk moduli are used (as in this work as seen in Figure 4). Figure 3: Vertical displacement values for different nodes in benchmark problem, taken from Lewis and Schrefler (1998). Figure 6: Evolution of pore fluid pressures from this work. Figure 7 displays the nodal values of temperature over time from Lewis and Schrefler (1998) and Figure 8 displays the same variable from this work. Again, the exact trends are matched with the current model. The data of Figure 7 appear stretched compared to Figure 8, however, this is again due to the material parameter space. Adjustment of material parameters can give rise to the behavior seen in Figure 7. Figure 4: Vertical displacement of different nodes for soil consolidation problem from this work. Figure 5 displays the pore fluid pressure evolution as a function of time from Lewis and Schrefler (1998). Figure 6 shows the results of the same plot from this work. These trends are identical. It is not clear if the pressures have been normalized in Figure 5. An interesting observation of Figure 5 is also that only 3 nodal values have been reported. This is most probably due to the oscillatory behavior of the pressure solution. Figure 6 shows the result of pressure for every node in the vertical direction and the oscillations are obvious, especially at early times. Both Aboustit et al. (1985) and Lewis and Schrefler (1998) report these oscillations in normalized data and they are apparent in these simulations as well. The oscillations are significantly reduced with the use of Babuska-Brezzi elements and mesh refinement. The trends in pore fluid pressure are identical to those shown in the benchmark problem presented by Lewis and Schrefler (1998). Figure 7: Nodal temperature evolution for benchmark problem taken from Lewis and Schrefler (1998). Figure 5: Pore fluid pressures for benchmark problem taken from Lewis and Schrefler (1998). 5 Figure 8: Evolution of nodal temperatures in this work. Comparing Figure 4 to Figures 6 and 8 offers interesting insight into the displacement behavior of the column. The problem is formulated to be quasi-static. Therefore, the system should be in static equilibrium at each time step. When a compressive traction load is placed on the top surface of the column, the column is compressed uniformly

6 near to the linear elastostatic solution. Figure 4 shows this result even at very small times. However, after pressure and temperature have roughly equilibrated, there is a noticeable consolidation effect on the column as the displacements further decrease. This result makes sense from a solid mechanics perspective, because pore pressure can be thought of as incompressibility in the medium. As the pressure is decreased, the magnitude of the displacements should increase. This is clearly demonstrated in Figure Double Borehole Preliminary Simulation Results Figures 11 and 12 display the results for the primary variables of pore fluid pressure and temperature in the double bore simulations. To demonstrate the importance of the matrices R and K tt when realistic material parameters for EGS volumes are used, the terms were included in the results generating the data of Figure 9. The figure displays the displacement behavior of the column in that case. Figure 11: Double borehole pore fluid pressure. Figure 9: Displacement evolution for fully coupled problem with appropriate EGS parameters. 4.3 Double Borehole Simulation Set-up Figure 10 displays the double borehole simulation set up. The figure is colored by the porosity, which varies spatially with 1/k correlation. The domain size is 70 m wide by 40 m tall with 0.5 m borehole widths. The horizontal distance between the boreholes is 14 m. The external boundary is fixed with temperature set to 200C and pore fluid pressure set to 2 MPa. 100C fluid flows into the left borehole that is pressurized to 4 MPa. The simulation was performed with time steps of s to a final time of 7000 s to reach equilibrium. Figure 12: Double borehole domain temperature. Figure 13 displays the result for shear stress in the double borehole simulations. Underground fractures often occur in regions of maximum shear stress. Therefore, shear stress in the domain could be used in future work incorporating an increase in fracture density. Figure 13: Double borehole shear stress. Figure 14 displays the result for the magnitude of the fluid velocity. There is a greater fluid velocity around the pressurized borehole. However, the fluid velocity is not symmetric. This is due to differences in porosity and permeability around the borehole. The higher porosity results in a lower velocity on the left side of the borehole. This may result in a greater overall flow in that direction, but the outflow calculations have not yet been implemented into the C++ FE code. Figure 10: Double borehole simulation mesh and porosity. 6

7 Figure 14: Double borehole magnitude of fluid velocity. 5. DISCUSSION/CONCLUSIONS 5.1 Results The results in Section 4 are preliminary results intended to demonstrate potential modeling capabilities of FE codes applied to coupled thermo-poro-mechanical processes in realistic heterogeneous media such as EGS rock volumes. While the meshes represent relatively small domains and have very coarse levels of refinement, the physics of EGS flow is implemented and the potential exists to offer new insight into the understanding of in situ fluid flow, heat transport, and pressure-induced fracture evolution. It is imperative for long-term energy solutions that the coupled physics of EGS volumes are well understood. Simulations of this type and Figures allow for the comparison of material and domain characteristics to resulting fluid flows and, potentially, fracture networks. Figure 14 clearly depicts fluctuations in small fluid velocities that are dependent upon the values of porosity and permeability within the domain. The temperature at a receiver well is important to consider as well as the outflow. From Figure 12, the temperature surrounding the outflow wellbore is about 180 C. 5.2 Future Work There is a significant amount of future work to perform for EGS simulations that used the C++ code from this work. It is highly desirable to determine the exact fluid mass outflow at boundaries (i.e., outflow wellbore boundaries). Taking the dot product of Darcy s Law for fluid and the boundary of interest s outward normal vector performs this calculation. This implementation is straightforward, but requires the robust and consistent determination of the outward normal vector at a boundary. As mentioned in Section 2, the temperature dependence of certain fluid properties (e.g., density and viscosity) needs to be accounted for. Over the range of these simulations ( C), a linear dependence in fluid density is not a bad assumption. However, more complicated relationships can easily be incorporated into the code. Constant water viscosity at 200C was used in the borehole simulations of Section 4. Figure 15 displays water viscosity as a function of temperature. Like fluid density, it is straightforward to implement a temperature dependence of the fluid viscosity term into the code assuming that no fluid phase changes are present within the simulation. Figure 15: Temperature dependence of water viscosity. Solving for the stresses and strains in the domain allows for more robust consideration of fracture networks. Natural pathways for fluid flow (fracture networks) already exist in EGS volumes. These systems can be enhanced by borehole pressurization through an influx of fluid. The enhancement of natural fracture networks will be explored in this work. A working hypothesis indicates that when critical stresses or strains are reached within a portion of the domain, permeability and porosity in that portion of the domain will increase appropriately as a result of an increase in fracture density. This can allow for fluid flows to also increase appropriately in highly stressed regions. Further, these 2-dimensional analyses will be extended to 3 dimensions for more complete representation of geothermal fields. This extension will require significantly more computational cost. The problems presented here already require a computational cost that is not insignificant. It was mentioned in Section 5 that these are relatively coarse meshes; therefore the simulations are relatively small. Memory availability limits the maximum size problems that can be computed. It is imperative for future work to implement the FETI method for parallel computation in finite element analysis on a MPI cluster located at the University of Auckland. Parallelization will allow for faster run time of large simulations as well as reduced memory requirements for individual CPUs. This will allow for fullscale 3-D simulations with significantly refined mesh structures. 7

8 REFERENCES Aboustit, B.L., Advani, S.H., and Lee, J.K., Variational Principles and Finite Element Simulations for Thermoelastic Consilidation, International Journal for Numerical and Analytical Methods in Geomechanics. 9, pp (1985). Goldstein, B.A., Hiriart, G., Tester, J., B., Bertani, R., Bromley, Gutierrez-Negrin, L.,C.J., Huenges, E., H, Ragnarsson, A., Mongillo, M.A. Muraoka, and V. I. Zui, Great expectations for geothermal energy to 2100, Proceedings Thirty-Sixth Workshop on Geothermal Reservoir Engineering, Stanford University, Stanford, California, January 31 - February 2, 2011 Hughes, T.J.R.: The Finite Element Method: Linear Static and Dynamic Finite Element Analysis. Dover Publications. (2000). Ingebritsen, S., Sanford, W., and Neuzil, C.: Groundwater in Geologial Processes. pp Cambridge University Press. (2006). Leary, P.C. Fractures and physical heterogeneity in crustal rock, in Heterogeneity of the Crust and Upper Mantle Nature, Scaling and Seismic Properties, J. A. Goff, & K. Holliger (eds.), Kluwer Academic/Plenum Publishers, NewYork, , (2002). Leary, P.C. and Walter, L.A.: Crosswell Seismic Applications to Highly Heterogenous Tight Gas Reservoirs. First Break 26 (2008). Lewis, R.W. and Schrefler, B.A.: The Finite Element Method in the Static and Dynamic Deformation and Consolidation of Porous Media. pp. 9-97, John Wiley and Sons. (1998). Sutter, D., Fox, D.B., Anderson B.J., Koch. D.L., Rudolf von Rohr, P., Tester, J.W., Sustainable heat farming of geothermal systems: a case study of heat extraction and thermal recovery in a model EGS fractured reservoir, Proceedings Thirty-Sixth Workshop on Geothermal Reservoir Engineering, Stanford University, Stanford, California, January 31 - February 2, 2011 Zienkiewicz, O.C. and Taylor, R.L.: The Finite Element Method: Volume 1 The Basis. 5 th Edition. Butterworth and Heinemann. (2000). 8

Fractures ~ Porosity Connectivity ~ Permeability EGS Flow Stimulation

Fractures ~ Porosity Connectivity ~ Permeability EGS Flow Stimulation GRC Transactions, Vol. 36, Fractures ~ Porosity Connectivity ~ Permeability EGS Flow Stimulation P. Leary, J. Pogacnik, and P. Malin Institute of Earth Science & Engineering, University of Auckland, New

More information

Analytical and Numerical Investigations on the Vertical Seismic Site Response

Analytical and Numerical Investigations on the Vertical Seismic Site Response Analytical and Numerical Investigations on the Vertical Seismic Site Response Bo Han, Lidija Zdravković, Stavroula Kontoe Department of Civil and Environmental Engineering, Imperial College, London SW7

More information

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

3D simulations of an injection test done into an unsaturated porous and fractured limestone

3D simulations of an injection test done into an unsaturated porous and fractured limestone 3D simulations of an injection test done into an unsaturated porous and fractured limestone A. Thoraval *, Y. Guglielmi, F. Cappa INERIS, Ecole des Mines de Nancy, FRANCE *Corresponding author: Ecole des

More information

Jihoon Kim, George J. Moridis, John Edmiston, Evan S. Um, Ernest Majer. Earth Sciences Division, Lawrence Berkeley National Laboratory 24 Mar.

Jihoon Kim, George J. Moridis, John Edmiston, Evan S. Um, Ernest Majer. Earth Sciences Division, Lawrence Berkeley National Laboratory 24 Mar. TOUGH+ROCMECH for the Analysis of coupled Flow, Thermal, Geomechanical and Geophysical Processes Code Description and Applications to Tight/Shale Gas Problems Jihoon Kim, George J. Moridis, John Edmiston,

More information

Finite Element Method in Geotechnical Engineering

Finite Element Method in Geotechnical Engineering Finite Element Method in Geotechnical Engineering Short Course on + Dynamics Boulder, Colorado January 5-8, 2004 Stein Sture Professor of Civil Engineering University of Colorado at Boulder Contents Steps

More information

TIME-DEPENDENT BEHAVIOR OF PILE UNDER LATERAL LOAD USING THE BOUNDING SURFACE MODEL

TIME-DEPENDENT BEHAVIOR OF PILE UNDER LATERAL LOAD USING THE BOUNDING SURFACE MODEL TIME-DEPENDENT BEHAVIOR OF PILE UNDER LATERAL LOAD USING THE BOUNDING SURFACE MODEL Qassun S. Mohammed Shafiqu and Maarib M. Ahmed Al-Sammaraey Department of Civil Engineering, Nahrain University, Iraq

More information

IN-SITU STRESS ESTIMATION IN OFFSHORE EASTERN MEDITERRANEAN WITH FINITE ELEMENT ANALYSIS

IN-SITU STRESS ESTIMATION IN OFFSHORE EASTERN MEDITERRANEAN WITH FINITE ELEMENT ANALYSIS 8 th GRACM International Congress on Computational Mechanics Volos, 12 July 15 July 2015 IN-SITU STRESS ESTIMATION IN OFFSHORE EASTERN MEDITERRANEAN WITH FINITE ELEMENT ANALYSIS Anna Kyriacou 1, Panos

More information

Flow and Transport. c(s, t)s ds,

Flow and Transport. c(s, t)s ds, Flow and Transport 1. The Transport Equation We shall describe the transport of a dissolved chemical by water that is traveling with uniform velocity ν through a long thin tube G with uniform cross section

More information

Calculation types: drained, undrained and fully coupled material behavior. Dr Francesca Ceccato

Calculation types: drained, undrained and fully coupled material behavior. Dr Francesca Ceccato Calculation types: drained, undrained and fully coupled material behavior Dr Francesca Ceccato Summary Introduction Applications: Piezocone penetration (CPTU) Submerged slope Conclusions Introduction Porous

More information

A Constitutive Framework for the Numerical Analysis of Organic Soils and Directionally Dependent Materials

A Constitutive Framework for the Numerical Analysis of Organic Soils and Directionally Dependent Materials Dublin, October 2010 A Constitutive Framework for the Numerical Analysis of Organic Soils and Directionally Dependent Materials FracMan Technology Group Dr Mark Cottrell Presentation Outline Some Physical

More information

6298 Stress induced azimuthally anisotropic reservoir - AVO modeling

6298 Stress induced azimuthally anisotropic reservoir - AVO modeling 6298 Stress induced azimuthally anisotropic reservoir - AVO modeling M. Brajanovski* (Curtin University of Technology), B. Gurevich (Curtin University of Technology), D. Nadri (CSIRO) & M. Urosevic (Curtin

More information

Geology 229 Engineering Geology. Lecture 5. Engineering Properties of Rocks (West, Ch. 6)

Geology 229 Engineering Geology. Lecture 5. Engineering Properties of Rocks (West, Ch. 6) Geology 229 Engineering Geology Lecture 5 Engineering Properties of Rocks (West, Ch. 6) Common mechanic properties: Density; Elastic properties: - elastic modulii Outline of this Lecture 1. Uniaxial rock

More information

Unjacketed bulk compressibility of sandstone in laboratory experiments. R. M. Makhnenko 1 and J. F. Labuz 1

Unjacketed bulk compressibility of sandstone in laboratory experiments. R. M. Makhnenko 1 and J. F. Labuz 1 481 Unjacketed bulk compressibility of sandstone in laboratory experiments R. M. Makhnenko 1 and J. F. Labuz 1 1 Department of Civil Engineering, University of Minnesota, Minneapolis, MN 55455; PH (612)

More information

2. Governing Equations. 1. Introduction

2. Governing Equations. 1. Introduction Multiphysics Between Deep Geothermal Water Cycle, Surface Heat Exchanger Cycle and Geothermal Power Plant Cycle Li Wah Wong *,1, Guido Blöcher 1, Oliver Kastner 1, Günter Zimmermann 1 1 International Centre

More information

Elements of Rock Mechanics

Elements of Rock Mechanics Elements of Rock Mechanics Stress and strain Creep Constitutive equation Hooke's law Empirical relations Effects of porosity and fluids Anelasticity and viscoelasticity Reading: Shearer, 3 Stress Consider

More information

Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams

Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams Application of pseudo-symmetric technique in dynamic analysis of concrete gravity dams V. Lotfi Department of Civil and Environmental Engineering, Amirkabir University, Iran Abstract A new approach is

More information

Modeling seismic wave propagation during fluid injection in a fractured network: Effects of pore fluid pressure on time-lapse seismic signatures

Modeling seismic wave propagation during fluid injection in a fractured network: Effects of pore fluid pressure on time-lapse seismic signatures Modeling seismic wave propagation during fluid injection in a fractured network: Effects of pore fluid pressure on time-lapse seismic signatures ENRU LIU, SERAFEIM VLASTOS, and XIANG-YANG LI, Edinburgh

More information

DISPENSA FEM in MSC. Nastran

DISPENSA FEM in MSC. Nastran DISPENSA FEM in MSC. Nastran preprocessing: mesh generation material definitions definition of loads and boundary conditions solving: solving the (linear) set of equations components postprocessing: visualisation

More information

FRACTURE REORIENTATION IN HORIZONTAL WELL WITH MULTISTAGE HYDRAULIC FRACTURING

FRACTURE REORIENTATION IN HORIZONTAL WELL WITH MULTISTAGE HYDRAULIC FRACTURING SPE Workshop OILFIELD GEOMECHANICS Slide 1 FRACTURE REORIENTATION IN HORIZONTAL WELL WITH MULTISTAGE HYDRAULIC FRACTURING A. Pimenov, R. Kanevskaya Ltd. BashNIPIneft March 27-28, 2017 Moscow, Russia Slide

More information

Thermo-Hydro-Mechanical modeling of EGS using COMSOL Multiphysics

Thermo-Hydro-Mechanical modeling of EGS using COMSOL Multiphysics PROCEEDINGS, Fourtieth Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, January 26-28, 2015 SGP-TR-204 Thermo-Hydro-Mechanical modeling of EGS using COMSOL Multiphysics

More information

Practical methodology for inclusion of uplift and pore pressures in analysis of concrete dams

Practical methodology for inclusion of uplift and pore pressures in analysis of concrete dams Practical methodology for inclusion of uplift and pore pressures in analysis of concrete dams Michael McKay 1 and Francisco Lopez 2 1 Dams Engineer, GHD Pty 2 Principal Dams/Structural Engineer, GHD Pty

More information

CONSOLIDATION BEHAVIOR OF PILES UNDER PURE LATERAL LOADINGS

CONSOLIDATION BEHAVIOR OF PILES UNDER PURE LATERAL LOADINGS VOL., NO., DECEMBER 8 ISSN 89-8 -8 Asian Research Publishing Network (ARPN). All rights reserved. CONSOLIDATION BEAVIOR OF PILES UNDER PURE LATERAL LOADINGS Qassun S. Mohammed Shafiqu Department of Civil

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

NUMERICAL MODELING OF INSTABILITIES IN SAND

NUMERICAL MODELING OF INSTABILITIES IN SAND NUMERICAL MODELING OF INSTABILITIES IN SAND KIRK ELLISON March 14, 2008 Advisor: Jose Andrade Masters Defense Outline of Presentation Randomized porosity in FEM simulations Liquefaction in FEM simulations

More information

Analysis of Fracture Propagation under Thermal Stress in Geothermal Reservoirs

Analysis of Fracture Propagation under Thermal Stress in Geothermal Reservoirs Proceedings World Geothermal Congress 2015 Melbourne, Australia, 19-25 April 2015 Analysis of Fracture Propagation under Thermal Stress in Geothermal Reservoirs Ahmad Ghassemi, Sergej Tarasovs Mailing

More information

16 Rainfall on a Slope

16 Rainfall on a Slope Rainfall on a Slope 16-1 16 Rainfall on a Slope 16.1 Problem Statement In this example, the stability of a generic slope is analyzed for two successive rainfall events of increasing intensity and decreasing

More information

Finite Deformation Analysis of Dynamic Behavior of Embankment on Liquefiable Sand Deposit Considering Pore Water Flow and Migration

Finite Deformation Analysis of Dynamic Behavior of Embankment on Liquefiable Sand Deposit Considering Pore Water Flow and Migration 6 th International Conference on Earthquake Geotechnical Engineering 1-4 November 215 Christchurch, New Zealand Finite Deformation Analysis of Dynamic Behavior of Embankment on Liquefiable Sand Deposit

More information

4 Undrained Cylindrical Cavity Expansion in a Cam-Clay Medium

4 Undrained Cylindrical Cavity Expansion in a Cam-Clay Medium Undrained Cylindrical Cavity Expansion in a Cam-Clay Medium 4-1 4 Undrained Cylindrical Cavity Expansion in a Cam-Clay Medium 4.1 Problem Statement The stress and pore pressure changes due to the expansion

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Exercise: concepts from chapter 8

Exercise: concepts from chapter 8 Reading: Fundamentals of Structural Geology, Ch 8 1) The following exercises explore elementary concepts associated with a linear elastic material that is isotropic and homogeneous with respect to elastic

More information

Numerical Modelling of Dynamic Earth Force Transmission to Underground Structures

Numerical Modelling of Dynamic Earth Force Transmission to Underground Structures Numerical Modelling of Dynamic Earth Force Transmission to Underground Structures N. Kodama Waseda Institute for Advanced Study, Waseda University, Japan K. Komiya Chiba Institute of Technology, Japan

More information

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

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

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

WELLBORE STABILITY ANALYSIS IN CHEMICALLY ACTIVE SHALE FORMATIONS

WELLBORE STABILITY ANALYSIS IN CHEMICALLY ACTIVE SHALE FORMATIONS S911 WELLBORE SABILIY ANALYSIS IN CHEMICALLY ACIVE SHALE FORMAIONS by Xiang-Chao SHI *, Xu YANG, Ying-Feng MENG, and Gao LI State Key Laboratory of Oil and Gas Reservoir Geology and Exploitation, Southwest

More information

EFFECTS OF GROUND WATER ON SEISMIC RESPONSES OF BASIN

EFFECTS OF GROUND WATER ON SEISMIC RESPONSES OF BASIN EFFECTS OF GROUND WATER ON SEISMIC RESPONSES OF BASIN Huei-Tsyr CHEN And Jern-Chern HO 2 SUMMARY It has long been recognized that the local soil and geology conditions may affect significantly the nature

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

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Table of Contents Chapter 1 Introduction to Geotechnical Engineering 1.1 Geotechnical Engineering 1.2 The Unique Nature of Soil and Rock Materials

Table of Contents Chapter 1 Introduction to Geotechnical Engineering 1.1 Geotechnical Engineering 1.2 The Unique Nature of Soil and Rock Materials Table of Contents Chapter 1 Introduction to Geotechnical Engineering 1.1 Geotechnical Engineering 1.2 The Unique Nature of Soil and Rock Materials 1.3 Scope of This Book 1.4 Historical Development of Geotechnical

More information

Seepage flow analysis in gravity and in variable acceleration fields

Seepage flow analysis in gravity and in variable acceleration fields Annals of the University of Bucharest (mathematical series) 5 (LXIII) (2014), 245 258 Seepage flow analysis in gravity and in variable acceleration fields Annamaria Cividini and Giancarlo Gioda In the

More information

DOWN-HOLE SEISMIC SURVEY AND VERTICAL ELECTRIC SOUNDINGS RABASKA PROJECT, LÉVIS, QUÉBEC. Presented to :

DOWN-HOLE SEISMIC SURVEY AND VERTICAL ELECTRIC SOUNDINGS RABASKA PROJECT, LÉVIS, QUÉBEC. Presented to : DOWN-HOLE SEISMIC SURVEY AND VERTICAL ELECTRIC SOUNDINGS RABASKA PROJECT, LÉVIS, QUÉBEC Presented to : TERRATECH 455, René-Lévesque Blvd. West Montreal, Québec HZ 1Z3 Presented by : GEOPHYSICS GPR INTERNATIONAL

More information

Production-induced stress change in and above a reservoir pierced by two salt domes: A geomechanical model and its applications

Production-induced stress change in and above a reservoir pierced by two salt domes: A geomechanical model and its applications Production-induced stress change in and above a reservoir pierced by two salt domes: A geomechanical model and its applications Peter Schutjens, Jeroen Snippe, Hassan Mahani, Jane Turner, Joel Ita and

More information

Brittle Deformation. Earth Structure (2 nd Edition), 2004 W.W. Norton & Co, New York Slide show by Ben van der Pluijm

Brittle Deformation. Earth Structure (2 nd Edition), 2004 W.W. Norton & Co, New York Slide show by Ben van der Pluijm Lecture 6 Brittle Deformation Earth Structure (2 nd Edition), 2004 W.W. Norton & Co, New York Slide show by Ben van der Pluijm WW Norton, unless noted otherwise Brittle deformation EarthStructure (2 nd

More information

Rock Mechanics Laboratory Tests for Petroleum Applications. Rob Marsden Reservoir Geomechanics Advisor Gatwick

Rock Mechanics Laboratory Tests for Petroleum Applications. Rob Marsden Reservoir Geomechanics Advisor Gatwick Rock Mechanics Laboratory Tests for Petroleum Applications Rob Marsden Reservoir Geomechanics Advisor Gatwick Summary A wide range of well established and proven laboratory tests are available for petroleum

More information

Calibration of the petro-elastic model (PEM) for 4D seismic studies in multi-mineral rocks Amini, Hamed; Alvarez, Erick Raciel

Calibration of the petro-elastic model (PEM) for 4D seismic studies in multi-mineral rocks Amini, Hamed; Alvarez, Erick Raciel Heriot-Watt University Heriot-Watt University Research Gateway Calibration of the petro-elastic model (PEM) for 4D seismic studies in multi-mineral rocks Amini, Hamed; Alvarez, Erick Raciel DOI: 10.3997/2214-4609.20132136

More information

Tu P8 08 Modified Anisotropic Walton Model for Consolidated Siliciclastic Rocks: Case Study of Velocity Anisotropy Modelling in a Barents Sea Well

Tu P8 08 Modified Anisotropic Walton Model for Consolidated Siliciclastic Rocks: Case Study of Velocity Anisotropy Modelling in a Barents Sea Well Tu P8 08 Modified Anisotropic Walton Model for Consolidated Siliciclastic Rocks: Case Study of Velocity Anisotropy Modelling in a Barents Sea Well Y. Zhou (Rock Solid Images), F. Ruiz (Repsol), M. Ellis*

More information

Hydrogeophysics - Seismics

Hydrogeophysics - Seismics Hydrogeophysics - Seismics Matthias Zillmer EOST-ULP p. 1 Table of contents SH polarized shear waves: Seismic source Case study: porosity of an aquifer Seismic velocities for porous media: The Frenkel-Biot-Gassmann

More information

Tensor character of pore pressure/stress coupling in reservoir depletion and injection

Tensor character of pore pressure/stress coupling in reservoir depletion and injection Tensor character of pore pressure/stress coupling in reservoir depletion and injection Müller, B., Altmann, J.B., Müller, T.M., Weißhardt, A., Shapiro, S., Schilling, F.R., Heidbach, O. Geophysical Institute

More information

Title: Application and use of near-wellbore mechanical rock property information to model stimulation and completion operations

Title: Application and use of near-wellbore mechanical rock property information to model stimulation and completion operations SPE OKC Oil and Gas Symposium March 27-31, 2017 Best of OKC Session Chairperson: Matthew Mower, Chaparral Energy Title: Application and use of near-wellbore mechanical rock property information to model

More information

A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel Current Wires

A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel Current Wires 13 th International LS-DYNA Users Conference Session: Electromagnetic A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel

More information

Using Probabilistic Analysis with Finite Element Modeling of High Temperature Geothermal Well Casings

Using Probabilistic Analysis with Finite Element Modeling of High Temperature Geothermal Well Casings Using Probabilistic Analysis with Finite Element Modeling of High Temperature Geothermal Well Casings Gunnar Skúlason Kaldal, Magnús Þór Jónsson, Halldór Pálsson, and Sigrún Nanna Karlsdóttir Faculty of

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

The Frictional Regime

The Frictional Regime The Frictional Regime Processes in Structural Geology & Tectonics Ben van der Pluijm WW Norton+Authors, unless noted otherwise 1/25/2016 10:08 AM We Discuss The Frictional Regime Processes of Brittle Deformation

More information

Chapter 6. Conclusions. 6.1 Conclusions and perspectives

Chapter 6. Conclusions. 6.1 Conclusions and perspectives Chapter 6 Conclusions 6.1 Conclusions and perspectives In this thesis an approach is presented for the in-situ characterization of rocks in terms of the distribution of hydraulic parameters (called SBRC

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

Surface changes caused by erosion and sedimentation were treated by solving: (2)

Surface changes caused by erosion and sedimentation were treated by solving: (2) GSA DATA REPOSITORY 214279 GUY SIMPSON Model with dynamic faulting and surface processes The model used for the simulations reported in Figures 1-3 of the main text is based on two dimensional (plane strain)

More information

Lecture 12: Finite Elements

Lecture 12: Finite Elements Materials Science & Metallurgy Part III Course M6 Computation of Phase Diagrams H. K. D. H. Bhadeshia Lecture 2: Finite Elements In finite element analysis, functions of continuous quantities such as temperature

More information

CHARACTERIZATION OF FRACTURES IN GEOTHERMAL RESERVOIRS USING RESISTIVITY

CHARACTERIZATION OF FRACTURES IN GEOTHERMAL RESERVOIRS USING RESISTIVITY PROCEEDINGS, Thirty-Seventh Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, January 30 - February 1, 01 SGP-TR-194 CHARACTERIZATION OF FRACTURES IN GEOTHERMAL RESERVOIRS

More information

Finite element modelling of fault stress triggering due to hydraulic fracturing

Finite element modelling of fault stress triggering due to hydraulic fracturing Finite element modelling of fault stress triggering due to hydraulic fracturing Arsalan, Sattari and David, Eaton University of Calgary, Geoscience Department Summary In this study we aim to model fault

More information

Site Characterization & Hydrogeophysics

Site Characterization & Hydrogeophysics Site Characterization & Hydrogeophysics (Source: Matthew Becker, California State University) Site Characterization Definition: quantitative description of the hydraulic, geologic, and chemical properties

More information

Coupled Thermomechanical Contact Problems

Coupled Thermomechanical Contact Problems Coupled Thermomechanical Contact Problems Computational Modeling of Solidification Processes C. Agelet de Saracibar, M. Chiumenti, M. Cervera ETS Ingenieros de Caminos, Canales y Puertos, Barcelona, UPC

More information

Towards Efficient Finite Element Model Review Dr. Richard Witasse, Plaxis bv (based on the original presentation of Dr.

Towards Efficient Finite Element Model Review Dr. Richard Witasse, Plaxis bv (based on the original presentation of Dr. Towards Efficient Finite Element Model Review Dr. Richard Witasse, Plaxis bv (based on the original presentation of Dr. Brinkgreve) Journée Technique du CFMS, 16 Mars 2011, Paris 1/32 Topics FEA in geotechnical

More information

URTeC: Abstract

URTeC: Abstract URTeC: 2902950 Can Seismic Inversion Be Used for Geomechanics? A Casing Deformation Example Jeremy J. Meyer 1*, Jeremy Gallop 1, Alvin Chen 1, Scott Reynolds 1, Scott Mildren 1 ; 1. Ikon Science Copyright

More information

A SIMULATOR WITH NUMERICAL UPSCALING FOR THE ANALYSIS OF COUPLED MULTIPHASE FLOW AND GEOMECHANICS IN HETEROGE-

A SIMULATOR WITH NUMERICAL UPSCALING FOR THE ANALYSIS OF COUPLED MULTIPHASE FLOW AND GEOMECHANICS IN HETEROGE- A SIMULATOR WITH NUMERICAL UPSCALING FOR THE ANALYSIS OF COUPLED MULTIPHASE FLOW AND GEOMECHANICS IN HETEROGE- NEOUS AND DEFORMABLE POROUS AND FRACTURED MEDIA A Dissertation by DAEGIL YANG Submitted to

More information

NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS

NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS IGC 009, Guntur, INDIA NUMERICAL ANALYSIS OF A PILE SUBJECTED TO LATERAL LOADS Mohammed Younus Ahmed Graduate Student, Earthquake Engineering Research Center, IIIT Hyderabad, Gachibowli, Hyderabad 3, India.

More information

Appendix: Nomenclature

Appendix: Nomenclature Appendix: Nomenclature 209 Appendix: Nomenclature Chapter 2: Roman letters A amplitude of surface wave m A j (complex) amplitude of tidal component [various] a right ascension rad or a magnitude of tidal

More information

INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA)

INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA) INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA) Title 3 Column (full page) 2 Column What is Finite Element Analysis? 1 Column Half page The Finite Element Method The Finite Element Method (FEM)

More information

Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis

Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis Print ISSN: 2322-2093; Online ISSN: 2423-6691 DOI: 10.7508/ceij.2016.02.011 Technical Note Investigation of Utilizing a Secant Stiffness Matrix for 2D Nonlinear Shape Optimization and Sensitivity Analysis

More information

INVERSE ANALYSIS METHODS OF IDENTIFYING CRUSTAL CHARACTERISTICS USING GPS ARRYA DATA

INVERSE ANALYSIS METHODS OF IDENTIFYING CRUSTAL CHARACTERISTICS USING GPS ARRYA DATA Problems in Solid Mechanics A Symposium in Honor of H.D. Bui Symi, Greece, July 3-8, 6 INVERSE ANALYSIS METHODS OF IDENTIFYING CRUSTAL CHARACTERISTICS USING GPS ARRYA DATA M. HORI (Earthquake Research

More information

Reservoir Geomechanics with ABAQUS

Reservoir Geomechanics with ABAQUS Reservoir Geomechanics with ABAQUS B. Bostrøm and E. Skomedal Statoil ASA, Norway Abstract: The coupled hydro-mechanical behavior of two North Sea high-pressure/hightemperature gas-condensate fields during

More information

PLAXIS. Scientific Manual

PLAXIS. Scientific Manual PLAXIS Scientific Manual 2016 Build 8122 TABLE OF CONTENTS TABLE OF CONTENTS 1 Introduction 5 2 Deformation theory 7 2.1 Basic equations of continuum deformation 7 2.2 Finite element discretisation 8 2.3

More information

A MODEL FOR COUPLED DYNAMIC ELASTO-PLASTIC ANALYSIS OF SOILS

A MODEL FOR COUPLED DYNAMIC ELASTO-PLASTIC ANALYSIS OF SOILS Journal of GeoEngineering, Vol. 7, No. 3, pp. 089-096, December 2012 Fattah et al.: A Model for Coupled Dynamic Elastic Plastic Analysis of Soils 89 A MODEL FOR COUPLED DYNAMIC ELASTO-PLASTIC ANALYSIS

More information

Methane hydrate rock physics models for the Blake Outer Ridge

Methane hydrate rock physics models for the Blake Outer Ridge Stanford Exploration Project, Report 80, May 15, 2001, pages 1 307 Methane hydrate rock physics models for the Blake Outer Ridge Christine Ecker 1 ABSTRACT Seismic analyses of methane hydrate data from

More information

EFFECTS OF RESERVOIR LENGTH ON DYNAMIC ANALYSIS OF CONCRETE GRAVITY DAMS

EFFECTS OF RESERVOIR LENGTH ON DYNAMIC ANALYSIS OF CONCRETE GRAVITY DAMS The th October -,, Beijing, China EFFECTS OF RESERVOIR LENGTH ON DYNAMIC ANALYSIS OF CONCRETE GRAVITY DAMS A. Fathi and V. Lotfi M.Sc. Student, Dept. of Civil and Environmental Engineering, Amirkabir University

More information

Integration of seismic and fluid-flow data: a two-way road linked by rock physics

Integration of seismic and fluid-flow data: a two-way road linked by rock physics Integration of seismic and fluid-flow data: a two-way road linked by rock physics Abstract Yunyue (Elita) Li, Yi Shen, and Peter K. Kang Geologic model building of the subsurface is a complicated and lengthy

More information

Modeling pressure response into a fractured zone of Precambrian basement to understand deep induced-earthquake hypocenters from shallow injection

Modeling pressure response into a fractured zone of Precambrian basement to understand deep induced-earthquake hypocenters from shallow injection Modeling pressure response into a fractured zone of Precambrian basement to understand deep induced-earthquake hypocenters from shallow injection S. Raziperchikolaee 1 and J. F. Miller 1 Abstract Analysis

More information

Numerical model comparison on deformation behavior of a TSF embankment subjected to earthquake loading

Numerical model comparison on deformation behavior of a TSF embankment subjected to earthquake loading Numerical model comparison on deformation behavior of a TSF embankment subjected to earthquake loading Jorge Castillo, Yong-Beom Lee Ausenco, USA Aurelian C. Trandafir Fugro GeoConsulting Inc., USA ABSTRACT

More information

Coalbed Methane Properties

Coalbed Methane Properties Coalbed Methane Properties Subtopics: Permeability-Pressure Relationship Coal Compressibility Matrix Shrinkage Seidle and Huitt Palmer and Mansoori Shi and Durucan Constant Exponent Permeability Incline

More information

Navier-Stokes Equation: Principle of Conservation of Momentum

Navier-Stokes Equation: Principle of Conservation of Momentum Navier-tokes Equation: Principle of Conservation of Momentum R. hankar ubramanian Department of Chemical and Biomolecular Engineering Clarkson University Newton formulated the principle of conservation

More information

Defmod, an earthquake simulator that adaptively switches between quasi-static and dynamic states

Defmod, an earthquake simulator that adaptively switches between quasi-static and dynamic states Defmod, an earthquake simulator that adaptively switches between quasi-static and dynamic states C. Meng (cmeng@mit.edu) B. Hager ERL, MIT May 16, 2016 Reservoir production/injection induced seismicity

More information

(b) What is the amplitude at the altitude of a satellite of 400 km?

(b) What is the amplitude at the altitude of a satellite of 400 km? Practice final quiz 2015 Geodynamics 2015 1 a) Complete the following table. parameter symbol units temperature T C or K thermal conductivity heat capacity density coefficient of thermal expansion volumetric)

More information

Particle flow simulation of sand under biaxial test

Particle flow simulation of sand under biaxial test 5th International Conference on Civil Engineering and Transportation (ICCET 2015) Particle flow simulation of sand under biaxial test Xiao-li Dong1,2, a *,Wei-hua Zhang1,a 1 Beijing City University, China

More information

Wave Propagation in Fractured Poroelastic Media

Wave Propagation in Fractured Poroelastic Media Wave Propagation in Fractured Poroelastic Media WCCM, MS170: Advanced Computational Techniques in Geophysical Sciences, Barcelona, Spain, July 2014 Juan E. Santos Instituto del Gas y del Petróleo (IGPUBA),

More information

Understanding hydraulic fracture variability through a penny shaped crack model for pre-rupture faults

Understanding hydraulic fracture variability through a penny shaped crack model for pre-rupture faults Penny shaped crack model for pre-rupture faults Understanding hydraulic fracture variability through a penny shaped crack model for pre-rupture faults David Cho, Gary F. Margrave, Shawn Maxwell and Mark

More information

Thermal Modeling of the Mountain Home Geothermal Area

Thermal Modeling of the Mountain Home Geothermal Area PROCEEDINGS, 41st Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, February 22-24, 2016 SGP-TR-209 Thermal Modeling of the Mountain Home Geothermal Area Sabodh K.

More information

THE EFFECT OF THERMOELASTIC STRESS CHANGE IN THE NEAR WELLBORE REGION ON HYDRAULIC FRACTURE GROWTH

THE EFFECT OF THERMOELASTIC STRESS CHANGE IN THE NEAR WELLBORE REGION ON HYDRAULIC FRACTURE GROWTH PROCEEDINGS, Thirty-Seventh Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, 30 Jan 2011-1 Feb 2012 THE EFFECT OF THERMOELASTIC STRESS CHANGE IN THE NEAR WELLBORE

More information

q v = - K h = kg/ν units of velocity Darcy's Law: K = kρg/µ HYDRAULIC CONDUCTIVITY, K Proportionality constant in Darcy's Law

q v = - K h = kg/ν units of velocity Darcy's Law: K = kρg/µ HYDRAULIC CONDUCTIVITY, K Proportionality constant in Darcy's Law Darcy's Law: q v - K h HYDRAULIC CONDUCTIVITY, K m/s K kρg/µ kg/ν units of velocity Proportionality constant in Darcy's Law Property of both fluid and medium see D&S, p. 62 HYDRAULIC POTENTIAL (Φ): Φ g

More information

Stress Analysis and Validation of Superstructure of 15-meter Long Bus under Normal Operation

Stress Analysis and Validation of Superstructure of 15-meter Long Bus under Normal Operation AIJSTPME (2013) 6(3): 69-74 Stress Analysis and Validation of Superstructure of 15-meter Long Bus under Normal Operation Lapapong S., Pitaksapsin N., Sucharitpwatkul S.*, Tantanawat T., Naewngerndee R.

More information

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

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

FRICTIONAL HEATING DURING AN EARTHQUAKE. Kyle Withers Qian Yao

FRICTIONAL HEATING DURING AN EARTHQUAKE. Kyle Withers Qian Yao FRICTIONAL HEATING DURING AN EARTHQUAKE Kyle Withers Qian Yao Temperature Change Along Fault Mode II (plain strain) crack rupturing bilaterally at a constant speed v r Idealize earthquake ruptures as shear

More information

3D Finite Element Thermal and Structural Analysis of the RT-70 Full-Circle Radio Telescope

3D Finite Element Thermal and Structural Analysis of the RT-70 Full-Circle Radio Telescope 3D Finite Element Thermal and Structural Analysis of the RT-70 Full-Circle Radio Telescope Alexey I. Borovkov Denis V. Shevchenko Alexander V. Gaev Alexander S. Nemov Computational Mechanics Laboratory,

More information

Model tests and FE-modelling of dynamic soil-structure interaction

Model tests and FE-modelling of dynamic soil-structure interaction Shock and Vibration 19 (2012) 1061 1069 1061 DOI 10.3233/SAV-2012-0712 IOS Press Model tests and FE-modelling of dynamic soil-structure interaction N. Kodama a, * and K. Komiya b a Waseda Institute for

More information

Reservoir Rock Properties COPYRIGHT. Sources and Seals Porosity and Permeability. This section will cover the following learning objectives:

Reservoir Rock Properties COPYRIGHT. Sources and Seals Porosity and Permeability. This section will cover the following learning objectives: Learning Objectives Reservoir Rock Properties Core Sources and Seals Porosity and Permeability This section will cover the following learning objectives: Explain why petroleum fluids are found in underground

More information

Mechanics PhD Preliminary Spring 2017

Mechanics PhD Preliminary Spring 2017 Mechanics PhD Preliminary Spring 2017 1. (10 points) Consider a body Ω that is assembled by gluing together two separate bodies along a flat interface. The normal vector to the interface is given by n

More information

Stress equilibrium in southern California from Maxwell stress function models fit to both earthquake data and a quasi-static dynamic simulation

Stress equilibrium in southern California from Maxwell stress function models fit to both earthquake data and a quasi-static dynamic simulation Stress equilibrium in southern California from Maxwell stress function models fit to both earthquake data and a quasi-static dynamic simulation Peter Bird Dept. of Earth, Planetary, and Space Sciences

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

More information

A THREE-DIMENSIONAL STOCHASTIC FRACTURE NETWORK MODEL FOR GEOTHERMAL RESERVOIR STIMULATION

A THREE-DIMENSIONAL STOCHASTIC FRACTURE NETWORK MODEL FOR GEOTHERMAL RESERVOIR STIMULATION PROCEEDINGS, Thirty-Sixth Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, January 31 - February 2, 2011 SGP-TR-191 A THREE-DIMENSIONAL STOCHASTIC FRACTURE NETWORK

More information

Gas Shale Hydraulic Fracturing, Enhancement. Ahmad Ghassemi

Gas Shale Hydraulic Fracturing, Enhancement. Ahmad Ghassemi Gas Shale Hydraulic Fracturing, Stimulated Volume and Permeability Enhancement Ahmad Ghassemi Tight Gas A reservoir that cannot produce gas in economic quantities without massive fracture stimulation treatments

More information

MPM Research Community. Anura3D MPM Software. Verification Manual

MPM Research Community. Anura3D MPM Software. Verification Manual MPM Research Community Anura3D MPM Software Verification Manual Version: 2017.1 12 January 2017 Anura3D MPM Software, Verification Manual Edited by: Miriam Mieremet (Deltares Delft, The Netherlands) With

More information