0- Numerical methods / Finite differences 1- Deformation and Estress, tensors 2- Basic equations of Solid Mechanics 3- Constitutive laws 4-

Size: px
Start display at page:

Download "0- Numerical methods / Finite differences 1- Deformation and Estress, tensors 2- Basic equations of Solid Mechanics 3- Constitutive laws 4-"

Transcription

1 0- Numerical methods / Finite differences 1- Deformation and Estress, tensors 2- Basic equations of Solid Mechanics 3- Constitutive laws 4- Orientation of faults on Earth (Anderson) 5- Critical shape of mountains... rôle of water

2 Finite Differences, with the diffusion equation dt d²t =κ 2 dt dx We resolve the equation of heat diffusion, in 1D. we need to discretize space (x), time (t) and temperature T. dt T i+1 T i T i+1 T i Progade differenciation: =. dx x i+1 x i Δx dt T i T i 1 dt T i+1 T i 1 Retrogade differenciation:, Central:. dx Δx dx 2Δx

3 T i+1 T i T i T i 1 dt d( ) T i+1 2T i +T i 1 d2 T dx Δx Δx Second order derivative: = = = dx Δx dx 2 Δx 2 dt d²t =κ 2 dt dx Δt Δt Explicit method: T i =(1 2κ 2 ). T i +(κ 2 ). (T i+1 +T i 1 ) Δx Δx + T i +κ Implicit method : T i = + Δt + + ( T +T i+1 i 1 ) 2 Δx Δt 1+2κ Δx 2 Mixte method: ( well known as Crank-Nicolson ) T i T i T 2T +T T 2T +T κ i+ 1 i i 1 i+ 1 i i 1 = +. 2 Δt 2 Δx 2 Δx + ( )

4 T 2 T Diffusion equation: =κ 2. t x T i T i T 2T +T i+1 i i 1 = κ 2. Δt Δx Δt therefore: T i =T +(κ ). (T 2T +T i i+1 i i 1 ). 2 Δx + + Stability of the aproximation depends on the value of (κ Algorithm : Δt ). 2 Δx

5 The critical time step for a finite difference method to work Ti t+1 - Ti t = k. t/ x² (Ti+1 t -2 Ti t + Ti-1 t) Ti t+1 = Ti t (1 2.k. t/ x²) + 2k. t/ x² (Ti+1 t + Ti-1 t)/2 If 2kDT/dx²=DD=0 => Ti t+1 = Ti t, nothing changes. If DD= ½ => Ti t+1 = (Ti+1 t + Ti-1 t)/2 : new T is the mean. If DD is between 0 and ½ => all good, but may take time to compute. If DD > ½ => Ti t+1 > (Ti+1 t + Ti-1 t)/2, instability (divergence). Stability Condition for the numerical scheme: t x² /(4.k)

6 Implementation with Matlab : We write a script to calculate the thermal state of an oceanic lithosphere as it is created at an oceanic ridge (mantle arrives at the surface at 1300 C), with the surface condition To=0 C. Thermal diffusion is given κ =10 ⁶m²/s. Prepocessing : - Spatial discretisation 1D, km : resolution... - Time discretisation Ma : numerical time-step... Processing : Resolve the equation step by step with an explicit method. Post-processing :Visualize he geothermal gradient with time. Plotting every 5 Ma for instance. * At which age is the temperature equal to 500 C at 20 km depth? * What is the critical time step, given a resolution of 1 km?

7 An elastic bar may be disccretized as a series of masses related by springs of rigidity k. Which system of equations allows to deduce the stresses and displacements of these masses? σ =ρ. g x u ε= x σ=e. ε 2 u ρ.g = E x2 1- Analytical solution: σ = ρgx u = ρ g x2/2e 2- finite difference solution: U1 U2 U3 U4 U5 σ i+1 =σ i +(x i+1 x i ). ρ. g 2 U i U i+1 2U i +U i 1 ρg = = 2 2 E x (x i+1 x i 1 )

8 FLAC :Example of a finite differences Lagrangian thermo-mechanical approach Equation of motion at the nodes: Strain-rates in elements: Temperature at nodes : t+ t Surface processes (erosion) : constitutive laws : Integration of forces at nodes : Boundary conditions -velocities: Displacements at nodes :

9 Numerical methods using finite element distinct elements, and finite differences

10 MESHES

11 Lagrangian vs. Eulerian formulations Coordonates of the Lagrangian nodes move with the material, and markers in an element move passively. The mesh distorsion becomes large and causes big problems to resolve equations, requiring remeshing, and numerical errors. Coordonates of the Eulerian nodes are fix in space, but internal markers transport their properties through the mesh. Therefore is is difficult to restore the history of materials (bad for elasticity). There is no distorsion of the mesh, but it must be much larger domain in order to account for the entire mvoement of the medium in time.

12 Example...

13

14 Models acounting for the fluid behaiovr of the mantle, and account for phase transformation, but don't account for faults at the surface... Li & Gerya, 2012 Tackley, 2011

15 Subduction benchmarks -- Schmeling et al., Codes use different assumptions : - Upper boundary condition (fix/ free), -Presence/absence of elasticity -Algorithm of interpolation

16 Problems of numerical interpolation

17 Deformation

18 Deformation Linearised Lagrangian deformation: Can be decomposed in symetrical and anti-symetrical parts: εij symetrical Infinitesimal Lagrangian tensor ε ε ωij antisymetrical ωij describes rigid rotation ~0

19 Ejemplos de tensores de deformacion y x ay ay

20 Stress tensor (Cauchy) t n =t 1.n 1+t 2.n 2 +t 3.n 3=t i.n i T i.ni =σ ji.n j =σ ij.n j is a symetric tensor

21 The state of stress ni a vertical column in the field of gravity Weight of a column : F y= m.g. Mass m= ρ.g.h.δa Fy σyy=ρ.g.y State of stress lithostatic: σxx=σzz=σyy Tectonic stress (~deviatoric) σxx : σxx= ρ g y + σxx The horizontal force necessary to maintain this column is : F x = σxxdy = ρ g h2/2

22 Principal stresses and invariants σ2 y σ1 θ x [ σ xx σ xy σ xz σ xy σ yy σ yz ][ σ xz σ1 σ yz 0 σ zz σ2 0 0 σ3 ] Decomposed in an isotropic P ( for deformation), plus deviatoric components: σ = -P + σdev [ σ xx σ xy σ xz σ xy σ yy σ yz ][ ][ σ xz σ xx P σ xy P 0 0 σ yz = 0 P 0 + σ xy σ yy P 0 0 P σ zz σ xz σ yz σ xz σ yz σ zz P P is pressure: First invariant of the tensor P= tr (σ)/3 = σ.ι/3= Σ (σii)/3= σ1+σ2+σ3= σxx+σyy+σzz τii is the deviator = Second stress Invariant. ]

23 Principal stresses and Mohr circle representation σ 1,2 =P±τ II I (σ xx +σ yy ) P= = 3 2 ( σ xx σ yy ) 2 τ II = II = +τ xy 4 2 Their projection on the Mohr circle (in 2D): tan2θ= 2τ xy σ yy P=-p τ II=R 2 ( σ xx +σ yy ) ( σ xx σ yy ) σ 1,2 =P±τ II = ± +τ xy 2 4 2

24 Normal and Shear Stresses Principal stresses may in turn be decomposed in a referencial of any given plane defined by its angle θ with respect to the X axis, with a NORMAL and TANGENCIAL component. B θ σ1 σn τ O σ2 A ( σ 1 +σ 2 ) ( σ 1 σ 2 ) σ n= + sin2θ 2 2 ( σ 1 σ 2 ) τ= cos2θ 2

25 2- Equations of solid mechanics Equilibrium of forces on a rigid block A block of density ρ, of length l and height h, lies on a slope of angle with the X axis α. Write the 2 equations of force equilibrium in the X and Y directions, and express the shear stress τ, that prevents the block from moving. τ = f (ρ,g, h, α)? y l h R F x g α

26 2.A) Mass conservation M= ρ( x,t )dv V Mass flux through S: ρυ nds S With the Gauss theorem: ρυ n ds= ( ρυ ) dv S V Mass variation in time equals the mass flux that exits the volume M = ( ρυ ) dv t V M ρ y con = dv t V t With a uniform density in the volume: CONTINUITY EQUATION With constant density in time: INCOMPRESSIBILITY EQUATION V υi dρ +ρ =0 dt xi υi xi =0 [ ] ρ + ( ρυ ) dv= 0 t dρ +ρ υ= 0 dt υ= 0

27 2.B) Conservation of momentum) Newton's statement: The sum of the forces on a medium's surface ( stresses T) and of the volumic forces (gravity g) are equal to its acceleration γ. F =mγ d TdS+ ρgdv = dt ρvdv S V V T i =σ ij. n j σ ij dv i ( x +ρgi ) dv = ρ dt dv V j V σ ij xj +ρg i =ρ dv i dt In 2D and in static: σ xx τ xy + =0 x y σ yy τ xy + +ρg= 0 y y

28 Elementary equilibrium In 2D, over an element of size dx and dy, with stresses σxx, σyy,σxy acting on each face and accounting for the gravity field, one expresses the force equilibrium in both directions... σyy(y+dy σxy(y+dy) y+dy σxy(x) σxx(x+dx) σxx(x) y σxy(x+dx) x+dx σxy(x+dx) x σyy(y) a) Σ Fx: σxx(x).dy + σxy(y).dx +σxy(y+dy).dx + σxx(x+dx).dy = 0 Σ Fy=?... = 0 b) Dividing by the volume dxdydz... σ xx τ xy + =0 x y σ yy τ xy + +ρg= 0 y y

29 3- Constitutive laws Elasticity Hook,1666: σ = Ε. ε Rigidity of tectonic plates (effective thickness h), is involved in the flexural equations D= E.h3/(1-ν)

30 Young's modulus E is the ratio of a unixial stress and the corresponding strain (σ22=σ33=0). Poisson's coefficient ν gives the associated vertical contraction: ε 11 = ε 11 σ 11 ε 33 ν= σ E ε 22 ε 11 = ε 33 ε 11 ε 22 σ= [ D ] ε E ν σ ij = (ε + δ ε )with Young and Poisson's parameters 1 +ν ij 1 2ν ij kk σ ij =2μ ε ij +λ δ ij ε kk with Lamé's parameters μ,λ In plane strain, ε zz =ε xz =ε yz=0 [] [ 1 σ xx E ν σ yy = (1 ν )² 0 σ xy ][ ] ν 0 ε xx 1 0. ε yy 1 ν 0 ε xy 2

31 Exercise A crust is submitted to a unixial stress ( σ2= 3= 0 ). Assuming for crustal rock that ν=0.25 and E=50 GPa, a) how much strain εxx will result from the application of a lateral stress σxx=100mpa? b) If the crust is l =10km, h =3km, how much does it shorten (Ux) and thicken (Uy)? Uy Ux εxx= ³, Ux= 12 m, Uy= 0.9m.

32 SUMMARY:Solid mechanics equations υi dρ +ρ =0 dt xi A) 1 equation of continuity (mass conservation): B) 3 equations of motion (Newton) : σ ij xj +ρg i =ρ dv i dt C) 6 constitutive equations (behaviour): vis pl ε ij = ε el + ε + ε ij ij ij = 1 dτ ij 1 + τ ij+ λ τ ij 2G dt 2μvis 10 equations for 10 unknowns : ρ(1), vi(3), σ ij (6) ) OK!

33 4- FAULTS ORIENTATIONS ON EARTH (ANDERSON's THEORY, 1919) The surface of the Earth is free of stress (contact with the Atmosphere). Since the orientation of the principal stresses correspond to directions of ZERO tangential stress, they must be parallel and perpendicular to the earth surface. With a criteriion of failure that considers the friction angle of 30 of most rocks, one can predict the orientation of faults. This theory results from the friction property of rocks.

34 Coulomb, 1773 : τs = So - µ.σn, µ= tanφ τs σn τs

35 Criteria of rupture (yield enveloppe) The rutpure surface is defined as the function in the principal stresses referential that satisfies : f (σ 1,σ 2,σ 3 )=0 at the plastic state( σ=σ s ) f< 0 at the elastic state (σ<σ s ) The criteria of Tresca ( ~ 1866) no depends on σ 2 intermediate: For σ 1 σ 2 σ 3 ( σ 1 σ 3 )/ 2=k and f=σ 1 σ 3 2k The criteria of Mohr-Coulomb depends on pressure. f=σ 1 1 sin ϕ σ C 1+sin ϕ 3 El criterio de Drucker-Prager depende de la pression tambien...

36 THEORY OF PLASTICITY TO PREDICT THE ORIENTATION OF FAULTS - The medium is assumed to be at a state of failure everywhere, with a deviatoric stress set to k: 2 (σ σ ) xx yy τ 2 =k 2 = +σ xy deformation is incompresible (φ= ψ= 0, directions of principal stress // deformation: 2σ xy 2 ε pxy tan2( x,σ 1 )= = p p σ xx σ yy ε xx ε yy - Force Equilibrium provides a solution in the form of perpendicular sli-lines, with a geometry defined by the boundary conditions, pressure P, velocities u,v, and orientaction θ = ( slip line, x) P+2kθ, du vdθ= constant along α P 2kθ, dv+udθ= constant along β

37 EXamples of slip-lines predicted by the theory and obtained in experiments Nadai, 1960

38 ELASTICITY, PLASTICITY, solutions for the problem of the INDENTOR Elasticity Tapponnier et al., 1976 Plasticity : slip along rigid blocs

39 5- Accretionary prisms and mountains Buiter et al., 2012

40 THEORY OF THE CRITICAL TAPERED WEDGE (Chapple, 1978, Davis et al.,1983, Dahlen, 1984) Hipoteses to predict the orientation of faults in an accretionary prism: a) the whole medium is at the state of failure : τ = µ.σn, µ = tan φ b) condition for failure at the base (inclined at angle β): τ = µb.σn Solution of the force equilibirum in a vertical column For α<<1, β<<1: 1 sin φ, 1+sin φ σ 1 +σ 3 Surface Slope: α+β=( β+μb ) Fault geometries: sin ψ= 3(σ 1 σ 3 )

41 Adam & Reuther (2000): along the margen of North Chile, variation in faults styles are attributed to changes in β and µ

42 Subduction of seamounts (Dominguez et al., 1998)

43 Continental Scale prism : the effect of climate on mountains α=β ( 1 sin φ 1 sin φ 1)+μb. 1+sin φ 1+sin φ 4 km 1 km Lamb et Davis, 2003

44 Evolution of a deforming wedge in time : numerical approach 3 km 32 km 100 km Prism with β = 6, φ = φ b = 30, α(t=0) = 0. A shear bands form to accomodate the shortening and build the topography (α) / its geometry evolves in time. Normal faults accommodate the slope at some point (super-critical taper).

45

46 6- Effect of water : the «pore pressure effect» Tensile fracture filled with fluid (vein) during dilation. Stress σ1 is parallel to ths teructure. The effective stress is very low, because high fluid pressure counteracts the normal (lithostatic) stress. Increasing pore fluid pressure favors failure! May lead to tensile failure deep in crust Effective stress = σ n fluid pressure

47 Friction at the plate interface and the effect of water Oleskevitch et al., 1999 Water has a fundamental role in plate tectonics... See next presentation.. Faregeng & Ellis, 2006

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

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting www.geosc.psu.edu/courses/geosc508 Surface and body forces Tensors, Mohr circles. Theoretical strength of materials Defects Stress concentrations Griffith failure

More information

3D Elasticity Theory

3D Elasticity Theory 3D lasticity Theory Many structural analysis problems are analysed using the theory of elasticity in which Hooke s law is used to enforce proportionality between stress and strain at any deformation level.

More information

PEAT SEISMOLOGY Lecture 2: Continuum mechanics

PEAT SEISMOLOGY Lecture 2: Continuum mechanics PEAT8002 - SEISMOLOGY Lecture 2: Continuum mechanics Nick Rawlinson Research School of Earth Sciences Australian National University Strain Strain is the formal description of the change in shape of a

More information

Tectonics. Lecture 12 Earthquake Faulting GNH7/GG09/GEOL4002 EARTHQUAKE SEISMOLOGY AND EARTHQUAKE HAZARD

Tectonics. Lecture 12 Earthquake Faulting GNH7/GG09/GEOL4002 EARTHQUAKE SEISMOLOGY AND EARTHQUAKE HAZARD Tectonics Lecture 12 Earthquake Faulting Plane strain 3 Strain occurs only in a plane. In the third direction strain is zero. 1 ε 2 = 0 3 2 Assumption of plane strain for faulting e.g., reverse fault:

More information

Continuum mechanism: Stress and strain

Continuum mechanism: Stress and strain Continuum mechanics deals with the relation between forces (stress, σ) and deformation (strain, ε), or deformation rate (strain rate, ε). Solid materials, rigid, usually deform elastically, that is the

More information

Macroscopic theory Rock as 'elastic continuum'

Macroscopic theory Rock as 'elastic continuum' Elasticity and Seismic Waves Macroscopic theory Rock as 'elastic continuum' Elastic body is deformed in response to stress Two types of deformation: Change in volume and shape Equations of motion Wave

More information

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting www.geosc.psu.edu/courses/geosc508 Standard Solids and Fracture Fluids: Mechanical, Chemical Effects Effective Stress Dilatancy Hardening and Stability Mead, 1925

More information

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature Chapter 1 Continuum mechanics review We will assume some familiarity with continuum mechanics as discussed in the context of an introductory geodynamics course; a good reference for such problems is Turcotte

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

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting www.geosc.psu.edu/courses/geosc508 Overview Milestones in continuum mechanics Concepts of modulus and stiffness. Stress-strain relations Elasticity Surface and body

More information

Rock Rheology GEOL 5700 Physics and Chemistry of the Solid Earth

Rock Rheology GEOL 5700 Physics and Chemistry of the Solid Earth Rock Rheology GEOL 5700 Physics and Chemistry of the Solid Earth References: Turcotte and Schubert, Geodynamics, Sections 2.1,-2.4, 2.7, 3.1-3.8, 6.1, 6.2, 6.8, 7.1-7.4. Jaeger and Cook, Fundamentals of

More information

Stress, Strain, Mohr s Circle

Stress, Strain, Mohr s Circle Stress, Strain, Mohr s Circle The fundamental quantities in solid mechanics are stresses and strains. In accordance with the continuum mechanics assumption, the molecular structure of materials is neglected

More information

Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount

Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount Elastoplastic Deformation in a Wedge-Shaped Plate Caused By a Subducting Seamount Min Ding* 1, and Jian Lin 2 1 MIT/WHOI Joint Program, 2 Woods Hole Oceanographic Institution *Woods Hole Oceanographic

More information

The finite difference code (fully staggered grid) includes a marker-in-cell Lagrangian marker

The finite difference code (fully staggered grid) includes a marker-in-cell Lagrangian marker GSA Data Repository 2018289 Ruh et al., 2018, Shale-related minibasins atop a massive olistostrome in an active accretionary wedge setting: Two-dimensional numerical modeling applied to the Iranian Makran:

More information

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

Basic Equations of Elasticity

Basic Equations of Elasticity A Basic Equations of Elasticity A.1 STRESS The state of stress at any point in a loaded bo is defined completely in terms of the nine components of stress: σ xx,σ yy,σ zz,σ xy,σ yx,σ yz,σ zy,σ zx,andσ

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

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies 13th February 2015 Jorge Lindley email: J.V.M.Lindley@warwick.ac.uk 1 2D Flows - Shear flows Example 1. Flow over an inclined plane A

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

Surface force on a volume element.

Surface force on a volume element. STRESS and STRAIN Reading: Section. of Stein and Wysession. In this section, we will see how Newton s second law and Generalized Hooke s law can be used to characterize the response of continuous medium

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

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

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16.

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16. CAVITY INSPECTION NDT&E Methods: UT VJ Technologies NDT&E Methods: UT 6. NDT&E: Introduction to Methods 6.1. Ultrasonic Testing: Basics of Elasto-Dynamics 6.2. Principles of Measurement 6.3. The Pulse-Echo

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

Stress, Strain, and Viscosity. San Andreas Fault Palmdale

Stress, Strain, and Viscosity. San Andreas Fault Palmdale Stress, Strain, and Viscosity San Andreas Fault Palmdale Solids and Liquids Solid Behavior: Liquid Behavior: - elastic - fluid - rebound - no rebound - retain original shape - shape changes - small deformations

More information

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ.

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ. Mohr s Circle By drawing Mohr s circle, the stress transformation in -D can be done graphically. σ = σ x + σ y τ = σ x σ y + σ x σ y cos θ + τ xy sin θ, 1 sin θ + τ xy cos θ. Note that the angle of rotation,

More information

SEMM Mechanics PhD Preliminary Exam Spring Consider a two-dimensional rigid motion, whose displacement field is given by

SEMM Mechanics PhD Preliminary Exam Spring Consider a two-dimensional rigid motion, whose displacement field is given by SEMM Mechanics PhD Preliminary Exam Spring 2014 1. Consider a two-dimensional rigid motion, whose displacement field is given by u(x) = [cos(β)x 1 + sin(β)x 2 X 1 ]e 1 + [ sin(β)x 1 + cos(β)x 2 X 2 ]e

More information

Mathematical Background

Mathematical Background CHAPTER ONE Mathematical Background This book assumes a background in the fundamentals of solid mechanics and the mechanical behavior of materials, including elasticity, plasticity, and friction. A previous

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

A short review of continuum mechanics

A short review of continuum mechanics A short review of continuum mechanics Professor Anette M. Karlsson, Department of Mechanical ngineering, UD September, 006 This is a short and arbitrary review of continuum mechanics. Most of this material

More information

DEFORMATION PATTERN IN ELASTIC CRUST

DEFORMATION PATTERN IN ELASTIC CRUST DEFORMATION PATTERN IN ELASTIC CRUST Stress and force in 2D Strain : normal and shear Elastic medium equations Vertical fault in elastic medium => arctangent General elastic dislocation (Okada s formulas)

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

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

Enabling Technologies

Enabling Technologies Enabling Technologies Mechanical Modelling 1 Key Parameter Mineral System Exploration is reflected in scale-dependent translation A. Gradient in hydraulic potential B. Permeability C. Solubility sensitivity

More information

Continuum Mechanics. Continuum Mechanics and Constitutive Equations

Continuum Mechanics. Continuum Mechanics and Constitutive Equations Continuum Mechanics Continuum Mechanics and Constitutive Equations Continuum mechanics pertains to the description of mechanical behavior of materials under the assumption that the material is a uniform

More information

CONSTITUTIVE RELATIONS FOR LINEAR ELASTIC SOLIDS

CONSTITUTIVE RELATIONS FOR LINEAR ELASTIC SOLIDS Chapter 9 CONSTITUTIV RLATIONS FOR LINAR LASTIC SOLIDS Figure 9.1: Hooke memorial window, St. Helen s, Bishopsgate, City of London 211 212 CHAPTR 9. CONSTITUTIV RLATIONS FOR LINAR LASTIC SOLIDS 9.1 Mechanical

More information

Effect of the intermediate principal stress on fault strike and dip - theoretical analysis and experimental verification

Effect of the intermediate principal stress on fault strike and dip - theoretical analysis and experimental verification Effect of the intermediate principal stress on fault strike and dip - theoretical analysis and experimental verification B. Haimson University of Wisconsin, USA J. Rudnicki Northwestern University, USA

More information

Material is perfectly elastic until it undergoes brittle fracture when applied stress reaches σ f

Material is perfectly elastic until it undergoes brittle fracture when applied stress reaches σ f Material is perfectly elastic until it undergoes brittle fracture when applied stress reaches σ f Material undergoes plastic deformation when stress exceeds yield stress σ 0 Permanent strain results from

More information

20. Rheology & Linear Elasticity

20. Rheology & Linear Elasticity I Main Topics A Rheology: Macroscopic deformation behavior B Linear elasticity for homogeneous isotropic materials 10/29/18 GG303 1 Viscous (fluid) Behavior http://manoa.hawaii.edu/graduate/content/slide-lava

More information

Mohr's Circle and Earth Stress (The Elastic Earth)

Mohr's Circle and Earth Stress (The Elastic Earth) Lect. 1 - Mohr s Circle and Earth Stress 6 Mohr's Circle and Earth Stress (The Elastic Earth) In the equations that we derived for Mohr s circle, we measured the angle, θ, as the angle between σ 1 and

More information

Classical fracture and failure hypotheses

Classical fracture and failure hypotheses : Chapter 2 Classical fracture and failure hypotheses In this chapter, a brief outline on classical fracture and failure hypotheses for materials under static loading will be given. The word classical

More information

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting Lectures & 3, 9/31 Aug 017 www.geosc.psu.edu/courses/geosc508 Discussion of Handin, JGR, 1969 and Chapter 1 Scholz, 00. Stress analysis and Mohr Circles Coulomb Failure

More information

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros

Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Inverse Design (and a lightweight introduction to the Finite Element Method) Stelian Coros Computational Design Forward design: direct manipulation of design parameters Level of abstraction Exploration

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

Mechanical Properties of Materials

Mechanical Properties of Materials Mechanical Properties of Materials Strains Material Model Stresses Learning objectives Understand the qualitative and quantitative description of mechanical properties of materials. Learn the logic of

More information

CIVL4332 L1 Introduction to Finite Element Method

CIVL4332 L1 Introduction to Finite Element Method CIVL L Introduction to Finite Element Method CIVL L Introduction to Finite Element Method by Joe Gattas, Faris Albermani Introduction The FEM is a numerical technique for solving physical problems such

More information

Rheology III. Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep

Rheology III. Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep Rheology III Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep Ideal materials fall into one of the following categories:

More information

GG612 Lecture 3. Outline

GG612 Lecture 3. Outline GG61 Lecture 3 Strain and Stress Should complete infinitesimal strain by adding rota>on. Outline Matrix Opera+ons Strain 1 General concepts Homogeneous strain 3 Matrix representa>ons 4 Squares of line

More information

Exercise: concepts from chapter 5

Exercise: concepts from chapter 5 Reading: Fundamentals of Structural Geology, Ch 5 1) Study the oöids depicted in Figure 1a and 1b. Figure 1a Figure 1b Figure 1. Nearly undeformed (1a) and significantly deformed (1b) oöids with spherulitic

More information

DEFORMATION PATTERN IN ELASTIC CRUST

DEFORMATION PATTERN IN ELASTIC CRUST DEFORMATION PATTERN IN ELASTIC CRUST Stress and force in 2D Strain : normal and shear Elastic medium equations Vertical fault in elastic medium => arctangent General elastic dislocation (Okada s formulas)

More information

EAS MIDTERM EXAM

EAS MIDTERM EXAM Ave = 98/150, s.d. = 21 EAS 326-03 MIDTERM EXAM This exam is closed book and closed notes. It is worth 150 points; the value of each question is shown at the end of each question. At the end of the exam,

More information

NONLINEAR CONTINUUM FORMULATIONS CONTENTS

NONLINEAR CONTINUUM FORMULATIONS CONTENTS NONLINEAR CONTINUUM FORMULATIONS CONTENTS Introduction to nonlinear continuum mechanics Descriptions of motion Measures of stresses and strains Updated and Total Lagrangian formulations Continuum shell

More information

Lecture 8. Stress Strain in Multi-dimension

Lecture 8. Stress Strain in Multi-dimension Lecture 8. Stress Strain in Multi-dimension Module. General Field Equations General Field Equations [] Equilibrium Equations in Elastic bodies xx x y z yx zx f x 0, etc [2] Kinematics xx u x x,etc. [3]

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

Rock mechanics. Master 1, Course PAX7STAD. University of Grenoble I Mai-Linh Doan

Rock mechanics. Master 1, Course PAX7STAD. University of Grenoble I Mai-Linh Doan Rock mechanics Master 1, Course PAX7STAD University of Grenoble I 2015-2016 Mai-Linh Doan 2016-09-19 Chapter I : Stress & Strain (M.-L. Doan) 2016-09-21 Tutorial I : Stress & Strain (M.-L. Doan) 2016-09-23

More information

Strain analysis.

Strain analysis. Strain analysis ecalais@purdue.edu Plates vs. continuum Gordon and Stein, 1991 Most plates are rigid at the until know we have studied a purely discontinuous approach where plates are

More information

3. The linear 3-D elasticity mathematical model

3. The linear 3-D elasticity mathematical model 3. The linear 3-D elasticity mathematical model In Chapter we examined some fundamental conditions that should be satisfied in the modeling of all deformable solids and structures. The study of truss structures

More information

Supplementary information on the West African margin

Supplementary information on the West African margin Huismans and Beaumont 1 Data repository Supplementary information on the West African margin Interpreted seismic cross-sections of the north Angolan to south Gabon west African passive margins 1-3, including

More information

FINAL EXAMINATION. (CE130-2 Mechanics of Materials)

FINAL EXAMINATION. (CE130-2 Mechanics of Materials) UNIVERSITY OF CLIFORNI, ERKELEY FLL SEMESTER 001 FINL EXMINTION (CE130- Mechanics of Materials) Problem 1: (15 points) pinned -bar structure is shown in Figure 1. There is an external force, W = 5000N,

More information

Introduction to Seismology Spring 2008

Introduction to Seismology Spring 2008 MIT OpenCourseWare http://ocw.mit.edu 12.510 Introduction to Seismology Spring 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. Stress and Strain

More information

OCN/ATM/ESS 587. The wind-driven ocean circulation. Friction and stress. The Ekman layer, top and bottom. Ekman pumping, Ekman suction

OCN/ATM/ESS 587. The wind-driven ocean circulation. Friction and stress. The Ekman layer, top and bottom. Ekman pumping, Ekman suction OCN/ATM/ESS 587 The wind-driven ocean circulation. Friction and stress The Ekman layer, top and bottom Ekman pumping, Ekman suction Westward intensification The wind-driven ocean. The major ocean gyres

More information

Mathematical Theory of Non-Newtonian Fluid

Mathematical Theory of Non-Newtonian Fluid Mathematical Theory of Non-Newtonian Fluid 1. Derivation of the Incompressible Fluid Dynamics 2. Existence of Non-Newtonian Flow and its Dynamics 3. Existence in the Domain with Boundary Hyeong Ohk Bae

More information

Numerical Modelling in Geosciences. Lecture 6 Deformation

Numerical Modelling in Geosciences. Lecture 6 Deformation Numerical Modelling in Geosciences Lecture 6 Deformation Tensor Second-rank tensor stress ), strain ), strain rate ) Invariants quantities independent of the coordinate system): - First invariant trace:!!

More information

Gravity Tectonics Volcanism Atmosphere Water Winds Chemistry. Planetary Surfaces

Gravity Tectonics Volcanism Atmosphere Water Winds Chemistry. Planetary Surfaces Gravity Tectonics Volcanism Atmosphere Water Winds Chemistry Planetary Surfaces Gravity & Rotation Polar flattening caused by rotation is the largest deviation from a sphere for a planet sized object (as

More information

Dynamic analysis. 1. Force and stress

Dynamic analysis. 1. Force and stress Dynamic analysis 1. Force and stress Dynamics is the part of structural geology that involves energy, force, stress, and strength. It's very important to distinguish dynamic concepts from kinematic ones.

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

Variational principles in mechanics

Variational principles in mechanics CHAPTER Variational principles in mechanics.1 Linear Elasticity n D Figure.1: A domain and its boundary = D [. Consider a domain Ω R 3 with its boundary = D [ of normal n (see Figure.1). The problem of

More information

CHAPTER 4 Stress Transformation

CHAPTER 4 Stress Transformation CHAPTER 4 Stress Transformation ANALYSIS OF STRESS For this topic, the stresses to be considered are not on the perpendicular and parallel planes only but also on other inclined planes. A P a a b b P z

More information

Dynamics of the Mantle and Lithosphere ETH Zürich Continuum Mechanics in Geodynamics: Equation cheat sheet

Dynamics of the Mantle and Lithosphere ETH Zürich Continuum Mechanics in Geodynamics: Equation cheat sheet Dynamics of the Mantle and Lithosphere ETH Zürich Continuum Mechanics in Geodynamics: Equation cheat sheet or all equations you will probably ever need Definitions 1. Coordinate system. x,y,z or x 1,x

More information

Force and Stress. Processes in Structural Geology & Tectonics. Ben van der Pluijm. WW Norton+Authors, unless noted otherwise 1/9/ :35 PM

Force and Stress. Processes in Structural Geology & Tectonics. Ben van der Pluijm. WW Norton+Authors, unless noted otherwise 1/9/ :35 PM Force and Stress Processes in Structural Geology & Tectonics Ben van der Pluijm WW Norton+Authors, unless noted otherwise 1/9/2017 12:35 PM We Discuss Force and Stress Force and Units (Trigonometry) Newtonian

More information

GEOL5690: Fold and Thrust Belts and Orogenic Wedges ! = S 0

GEOL5690: Fold and Thrust Belts and Orogenic Wedges ! = S 0 GEOL569: Fold and Thrust Belts and Orogenic Wedges One of the earlier mysteries in geology was the discovery in the 19 th century of large scale overthrusts in the Alps. Sheets of rock were found to have

More information

Geodynamics Lecture 5 Basics of elasticity

Geodynamics Lecture 5 Basics of elasticity Geodynamics Lecture 5 Basics of elasticity Lecturer: David Whipp david.whipp@helsinki.fi! 16.9.2014 Geodynamics www.helsinki.fi/yliopisto 1 Goals of this lecture Introduce linear elasticity! Look at the

More information

MEMORANDUM SUBJECT: CERTIFICATE IN ROCK MECHANICS PAPER 1 : THEORY SUBJECT CODE: COMRMC MODERATOR: H YILMAZ EXAMINATION DATE: OCTOBER 2017 TIME:

MEMORANDUM SUBJECT: CERTIFICATE IN ROCK MECHANICS PAPER 1 : THEORY SUBJECT CODE: COMRMC MODERATOR: H YILMAZ EXAMINATION DATE: OCTOBER 2017 TIME: MEMORANDUM SUBJECT: CERTIFICATE IN ROCK MECHANICS PAPER 1 : THEORY EXAMINER: WM BESTER SUBJECT CODE: COMRMC EXAMINATION DATE: OCTOBER 2017 TIME: MODERATOR: H YILMAZ TOTAL MARKS: [100] PASS MARK: (60%)

More information

Introduction to Fluid Mechanics

Introduction to Fluid Mechanics Introduction to Fluid Mechanics Tien-Tsan Shieh April 16, 2009 What is a Fluid? The key distinction between a fluid and a solid lies in the mode of resistance to change of shape. The fluid, unlike the

More information

Physics 141 Rotational Motion 2 Page 1. Rotational Motion 2

Physics 141 Rotational Motion 2 Page 1. Rotational Motion 2 Physics 141 Rotational Motion 2 Page 1 Rotational Motion 2 Right handers, go over there, left handers over here. The rest of you, come with me.! Yogi Berra Torque Motion of a rigid body, like motion of

More information

Constitutive Equations (Linear Elasticity)

Constitutive Equations (Linear Elasticity) Constitutive quations (Linear lasticity) quations that characterize the physical properties of the material of a system are called constitutive equations. It is possible to find the applied stresses knowing

More information

Strain Transformation equations

Strain Transformation equations Strain Transformation equations R. Chandramouli Associate Dean-Research SASTRA University, Thanjavur-613 401 Joint Initiative of IITs and IISc Funded by MHRD Page 1 of 8 Table of Contents 1. Stress transformation

More information

SEISMOLOGY I. Laurea Magistralis in Physics of the Earth and of the Environment. Elasticity. Fabio ROMANELLI

SEISMOLOGY I. Laurea Magistralis in Physics of the Earth and of the Environment. Elasticity. Fabio ROMANELLI SEISMOLOGY I Laurea Magistralis in Physics of the Earth and of the Environment Elasticity Fabio ROMANELLI Dept. Earth Sciences Università degli studi di Trieste romanel@dst.units.it 1 Elasticity and Seismic

More information

Module III - Macro-mechanics of Lamina. Lecture 23. Macro-Mechanics of Lamina

Module III - Macro-mechanics of Lamina. Lecture 23. Macro-Mechanics of Lamina Module III - Macro-mechanics of Lamina Lecture 23 Macro-Mechanics of Lamina For better understanding of the macromechanics of lamina, the knowledge of the material properties in essential. Therefore, the

More information

c) Plot stability diagrams (Figure 11, p 10 of notes) for cases i) - iv), all on the same graph.

c) Plot stability diagrams (Figure 11, p 10 of notes) for cases i) - iv), all on the same graph. 12.520 Problem Set 4 1) (100%) Consider a dry, noncohesive critical wedge, as discussed in class, as a model of snow in front of a snow plow. We will consider 4 cases: i) φ = 30, φ b = 10 ; ii) φ = 30,

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Lecture Notes #10. The "paradox" of finite strain and preferred orientation pure vs. simple shear

Lecture Notes #10. The paradox of finite strain and preferred orientation pure vs. simple shear 12.520 Lecture Notes #10 Finite Strain The "paradox" of finite strain and preferred orientation pure vs. simple shear Suppose: 1) Anisotropy develops as mineral grains grow such that they are preferentially

More information

GEO E1050 Finite Element Method Mohr-Coulomb and other constitutive models. Wojciech Sołowski

GEO E1050 Finite Element Method Mohr-Coulomb and other constitutive models. Wojciech Sołowski GEO E050 Finite Element Method Mohr-Coulomb and other constitutive models Wojciech Sołowski To learn today. Reminder elasticity 2. Elastic perfectly plastic theory: concept 3. Specific elastic-perfectly

More information

Mechanics of materials Lecture 4 Strain and deformation

Mechanics of materials Lecture 4 Strain and deformation Mechanics of materials Lecture 4 Strain and deformation Reijo Kouhia Tampere University of Technology Department of Mechanical Engineering and Industrial Design Wednesday 3 rd February, 206 of a continuum

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

Basic Concepts of Strain and Tilt. Evelyn Roeloffs, USGS June 2008

Basic Concepts of Strain and Tilt. Evelyn Roeloffs, USGS June 2008 Basic Concepts of Strain and Tilt Evelyn Roeloffs, USGS June 2008 1 Coordinates Right-handed coordinate system, with positions along the three axes specified by x,y,z. x,y will usually be horizontal, and

More information

GG611 Structural Geology Sec1on Steve Martel POST 805

GG611 Structural Geology Sec1on Steve Martel POST 805 GG611 Structural Geology Sec1on Steve Martel POST 805 smartel@hawaii.edu Lecture 5 Mechanics Stress, Strain, and Rheology 11/6/16 GG611 1 Stresses Control How Rock Fractures hkp://hvo.wr.usgs.gov/kilauea/update/images.html

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

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

Unit IV State of stress in Three Dimensions

Unit IV State of stress in Three Dimensions Unit IV State of stress in Three Dimensions State of stress in Three Dimensions References Punmia B.C.,"Theory of Structures" (SMTS) Vol II, Laxmi Publishing Pvt Ltd, New Delhi 2004. Rattan.S.S., "Strength

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

CH.4. STRESS. Continuum Mechanics Course (MMC)

CH.4. STRESS. Continuum Mechanics Course (MMC) CH.4. STRESS Continuum Mechanics Course (MMC) Overview Forces Acting on a Continuum Body Cauchy s Postulates Stress Tensor Stress Tensor Components Scientific Notation Engineering Notation Sign Criterion

More information

VYSOKÁ ŠKOLA BÁŇSKÁ TECHNICKÁ UNIVERZITA OSTRAVA

VYSOKÁ ŠKOLA BÁŇSKÁ TECHNICKÁ UNIVERZITA OSTRAVA VYSOKÁ ŠKOLA BÁŇSKÁ TECHNICKÁ UNIVERZITA OSTRAVA FAKULTA METALURGIE A MATERIÁLOVÉHO INŽENÝRSTVÍ APPLIED MECHANICS Study Support Leo Václavek Ostrava 2015 Title:Applied Mechanics Code: Author: doc. Ing.

More information

Geodynamics. Brittle deformation and faulting Lecture Predicting fault orientations. Lecturer: David Whipp

Geodynamics. Brittle deformation and faulting Lecture Predicting fault orientations. Lecturer: David Whipp Geodynamics Brittle deformation and faulting Lecture 11.6 - Predicting fault orientations Lecturer: David Whipp david.whipp@helsinki.fi Geodynamics www.helsinki.fi/yliopisto 1 Goals of this lecture Introduce

More information

Chapter 2. Rubber Elasticity:

Chapter 2. Rubber Elasticity: Chapter. Rubber Elasticity: The mechanical behavior of a rubber band, at first glance, might appear to be Hookean in that strain is close to 100% recoverable. However, the stress strain curve for a rubber

More information

Lecture 2: Deformation in the crust and the mantle. Read KK&V chapter 2.10

Lecture 2: Deformation in the crust and the mantle. Read KK&V chapter 2.10 Lecture 2: Deformation in the crust and the mantle Read KK&V chapter 2.10 Tectonic plates What are the structure and composi1on of tectonic plates? Crust, mantle, and lithosphere Crust relatively light

More information

RHEOLOGY & LINEAR ELASTICITY. B Importance of fluids and fractures in deformation C Linear elasticity for homogeneous isotropic materials

RHEOLOGY & LINEAR ELASTICITY. B Importance of fluids and fractures in deformation C Linear elasticity for homogeneous isotropic materials GG303 Lecture 2 0 9/4/01 1 RHEOLOGY & LINEAR ELASTICITY I II Main Topics A Rheology: Macroscopic deformation behavior B Importance of fluids and fractures in deformation C Linear elasticity for homogeneous

More information