Gyroviscosity in the NIMROD code. A.Y. Pankin D. D. Schnack C. Sovinec S. E. Kruger

Size: px
Start display at page:

Download "Gyroviscosity in the NIMROD code. A.Y. Pankin D. D. Schnack C. Sovinec S. E. Kruger"

Transcription

1 Gyroviscosity in the NIMROD code A.Y. Pankin D. D. Schnack C. Sovinec S. E. Kruger

2 Outline Introduction Two possible implementations Testing GV in the NIMROD code Convergence Summary

3 ε = ω / Ω i ξ = V 0 /V thi δ = ρ i / L Gyroviscous force εξ V i t + ξ δv i V i = 1 n δ p + Π i 0 Π i i + ξ E + V i B p 0 ( ) ratio of the characteristic frequency to the ion gyro-frequency ratio of the characteristic flow velocity to the ion thermal speed ratio of the ion Larmor (gyro-) radius to the macroscopic scale length Properties of Fluid Models Model V i ω β J B Whistlers KAW Hall V thi /δ Ω ci O(δ ) MHD mn dv i Yes No + O(δ) dt Ideal V thi δω ci O(δ) O(δ) No No MHD Drift δv thi δ O(1) Ωci p + O(δ ) No Yes GV force is not caused by particle collisions GV force is nor dissipative

4 Π i = Π + Π + Π gv Π = 3 η 0 b W b ( ) I 1 3 bb Π = η 1 ( I bb) W I bb Π gv = η 3 Stress tensor ( ) 1 ( I bb) ( I bb) :W [ b W ( I+ 3bb) ( I+ 3bb) W b], + 4[ ( I bb) W bb + transpose]} where W is the rate of strain tensor : W = V + ( V) T 3 I ( V ) η 3 = nt i Ω, η 0 Ω = eb m i = 0.96 nt i ν, η 1 = 3 10 is the ion gyro - frequency nt i ν Ω,

5 First Implantation: Hooke s law Linear relationship between stress and rate of strain : Π ij = E ijkl W kl Elastic constant tensor : Symmetry : E ijkl Π ij W kl E ijkl = E jikl E ijkl = E ijlk 3 Π and W are symmetric E ijkl ( B) = E klij ( B) B is a pseudo-vector (Onsager) Elastic constant tensor for a magnetized plasma : E ijkl = 1 η 3( ε imk b m u lj + ε jmk b m u li ), u αβ = δ αβ + 3b α b β E xxxy = E xxyx = E yyxy = E yyyx = η 3 E xyxx = E yxxx = E xyyy = E yxyy = 1 η 3 E xzyz = E zxxy = E zxyz = E zxzy = E yzxz = E zyxz = E zyzx = E yzzx = η 4 (Cartesian representation, b = e z ) 81 components, 16 non - zero, 1 independent (single parameter dependence)

6 First Implantation: continue Cartesian rate of strain tensor : W = V i + V i T 3 Ι V i ( V) kl = V l x k W ij = A ijkl ( V) kl A ijkl = δ il δ kj + δ ik δ lk 3 δ ijδ km δ ml Write stress directly in terms of rate of strain : Π ij = E ijkl A klmn ( V) mn = D ijmn ( V) mn D ijmn = 1 η 3 ε izn δ mj + 3δ mz δ jz Symmetries : [ ( ) + ε izm ( δ nj + 3δ nz δ jz ) +ε jzn ( δ mi + 3δ mz δ iz ) + ε jzm ( δ nj + 3δ nz δ iz )] Assumes B locally aligned with z axis D ijmn = D jimn, D ijmn = D ijnm, D ijmn = D mnij These symmetries assure GV stress non - dissipative : V Π GV d 3 x = 0

7 First Implantation: Computation of GV stress 1. Compute D ijmn once at beginning of run. Transform D ijmn to cylindrical coordinates at each spatial location, depending on local direction of magnetic field D αβγδ = S iα S jβ D ijkl S kγ S lδ i, j, k, l = x, y,x α, β, γ, δ = r,θ,z cosα sinα 0 S = cosβ sinα cosβ cosα sinβ sinβ sinα sinβ cosα cosβ α = tan 1 B r, β = tan 1 B r + B θ B θ B z 3. Stress tensor components in cylindrical coordinates is Π ij = V r r ( V) 1 V = r r θ V θ r V r z D ijmn ( V) mn V θ r 1 V r r θ + V r r V θ z V z r 1 V z r θ V z z 4. FE divergence in cylindrical coordinates ( Π GV ) p = dv ( α p D α q ) V q,.

8 Second Implementation A r,p,n Based on weak formulation of the stress tensor force - dxa ν,p,n Π = dx( A ) T ν,p,n :Π ds Π A ν,p,n α p,n 0 0 r α = p,n 0 0 z in r α 0 α r A z,p,n α 0 p,n 0 r α = 0 p,n 0 z 0 in r α 0 IS ZERO for non-slip boundary conditions A φ,p,n α 0 0 p,n r α = 0 0 p,n z α 0 in r r α Find product ( A ) T :Π ν,p,n and heating - V :Π - > - dxa ν,p,n V :Π

9 c c stress tensor for gyro-viscosity c IF (gyr_visc>0) THEN ALLOCATE(wtmp(3,3,SIZE(int,),SIZE(int,3))) ALLOCATE(b_cross_w(3,3,SIZE(int,),SIZE(int,3))) DO imode=1,nmodes wtmp=0. DO iy=1,ncy DO ix=1,ncx vtmp(1:3,1)=vten(1:3,ix,iy,imode) vtmp(1:3,)=vten(4:6,ix,iy,imode) vtmp(1:3,3)=vten(7:9,ix,iy,imode) T W = V ptmp=vtmp+transpose(vtmp) 3 Ι V i + V i i btmp(1:3,1)=3.(be_eq(1:3,ix,iy)+be(1:3,ix,iy,imode)) (be_eq(1,ix,iy)+be(1,ix,iy,imode)) /btot(ix,iy) btmp(1:3,)=3.(be_eq(1:3,ix,iy)+be(1:3,ix,iy,imode)) ( I+ 3bb) (be_eq(,ix,iy)+be(,ix,iy,imode)) /btot(ix,iy) btmp(1:3,3)=3.(be_eq(1:3,ix,iy)+be(1:3,ix,iy,imode)) (be_eq(3,ix,iy)+be(3,ix,iy,imode)) /btot(ix,iy) btmp(1,1) = 1+btmp(1,1) btmp(,) = 1+btmp(,) btmp(3,3) = 1+btmp(3,3) DO i1=1,3 DO i=1,3 DO i3=1,3 wtmp(i1,i,ix,iy)=wtmp(i1,i,ix,iy)+ptmp(i1,i3) W ( I+ 3bb) btmp(i3,i) call math_cart_cross(b_cross_w(1,:,:,:), be_eq(:,:,:)+be(:,:,:,imode), wtmp(:,1,:,:),1._r8) call b math_cart_cross(b_cross_w(,:,:,:), W ( I+ 3bb) be_eq(:,:,:)+be(:,:,:,imode), wtmp(:,,:,:),1._r8) call math_cart_cross(b_cross_w(3,:,:,:), be_eq(:,:,:)+be(:,:,:,imode), wtmp(:,3,:,:),1._r8) DO iy=1,ncy DO ix=1,ncx η 3 [ b W ( I+ 3bb) ( I+ 3bb) W b] ptmp = gyr_visc(ti_eq(1,ix,iy)zeff)/ (1.9e4btot(ix,iy)) (b_cross_w(:,:,ix,iy) +TRANSPOSE(b_cross_w(:,:,ix,iy))) piten(1:3,ix,iy,imode)= $ piten(1:3,ix,iy,imode)-ptmp(1:3,1) piten(4:6,ix,iy,imode)= $ piten(4:6,ix,iy,imode)-ptmp(1:3,) Π i = piten(7:9,ix,iy,imode)= Π i + Π gv $ piten(7:9,ix,iy,imode)-ptmp(1:3,3) DEALLOCATE(wtmp,b_cross_w) IF (eq_flow/='none') THEN ALLOCATE(wtmpr(3,3,SIZE(int,),SIZE(int,3))) ALLOCATE(b_cross_wr(3,3,SIZE(int,),SIZE(int,3))) DO iy=1,ncy DO ix=1,ncx vtmpr(1:3,1)=veqten(1:3,ix,iy) vtmpr(1:3,)=veqten(4:6,ix,iy) vtmpr(1:3,3)=veqten(7:9,ix,iy) ptmpr=vtmpr+transpose(vtmpr) btmpr(1:3,1)=3.be_eq(1:3,ix,iy)be_eq(1,ix,iy) /btot(ix,iy) btmpr(1:3,)=3.be_eq(1:3,ix,iy)be_eq(,ix,iy) /btot(ix,iy) btmpr(1:3,3)=3.be_eq(1:3,ix,iy)be_eq(3,ix,iy) /btot(ix,iy) btmpr(1,1) = 1+btmpr(1,1) btmpr(,) = 1+btmpr(,) btmpr(3,3) = 1+btmpr(3,3) vtmpr=0. DO i1=1,3 DO i=1,3 DO i3=1,3 wtmpr(i1,i,ix,iy)=wtmpr(i1,i,ix,iy) +ptmpr(i1,i3)btmpr(i3,i) call math_cart_cross(b_cross_wr(1,:,:,:),be_eq, wtmpr(:,1,:,:),1._r8) call math_cart_cross(b_cross_wr(,:,:,:),be_eq, wtmpr(:,,:,:),1._r8) call math_cart_cross(b_cross_wr(3,:,:,:),be_eq, wtmpr(:,3,:,:),1._r8) DO iy=1,ncy DO ix=1,ncx ptmpr = gyr_visczeffti_eq(1,ix,iy)/ (1.9e4btot(ix,iy)) (b_cross_wr(:,:,ix,iy) +TRANSPOSE(b_cross_wr(:,:,ix,iy))) pi_veq(1:3,ix,iy)= $ pi_veq(1:3,ix,iy)-ptmpr(1:3,1) pi_veq(4:6,ix,iy)= $ pi_veq(4:6,ix,iy)-ptmpr(1:3,) pi_veq(7:9,ix,iy)= $ pi_veq(7:9,ix,iy)-ptmpr(1:3,3) DEALLOCATE(wtmpr,b_cross_wr) ENDIF ENDIF

10 Testing GV implementation Without gyroviscosity With gyroviscosity

11 Testing GV implementation Dispersion relation Parallel Propagation Dispersion relation: ( ω ± ω 4 )( ω ± ω W ) = ω A ω A ω 4 ω W = B 0 k z µ 0 mn = V A k z = η k 4 z mn = V thi Ω k z = B k 0 z µ 0 ne = ω A Ω = 1 ( ρ k ) Ω i z Ω = 1 ( β ρ k ) Ω i z If ρ i k z <<1, the solutions for the left and right polarized waves are ω L ± = V A k z ±1+ 1+ β β ρ k ( ) i z ω R ± = V A k z ±1 1+ β β ρ k ( ) i z Perpendicular Propagation Dispersion relation: ω s ω + ω A =1+ ω s ω s = C s k x, ω 3 = ω 4 /. ω = V A k x 1+ γβ + β 16 ρ ( ik x ) The mode is elliptically polarized in the plane perpendicular to B iv y = ± 1 β V x 4 1+ γβ/ ρ k i x ω 3 + ω A

12 Testing GV implementation Without gyroviscosity With gyroviscosity

16.21 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive Equations

16.21 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive Equations 6.2 Techniques of Structural Analysis and Design Spring 2003 Unit #5 - Constitutive quations Constitutive quations For elastic materials: If the relation is linear: Û σ ij = σ ij (ɛ) = ρ () ɛ ij σ ij =

More information

FLUID MODELS OF MAGNETIZED PLASMAS or BEYOND MHD or PLASMA PHYSICS IN 100 MINUTES!

FLUID MODELS OF MAGNETIZED PLASMAS or BEYOND MHD or PLASMA PHYSICS IN 100 MINUTES! FLUID MODELS OF MAGNETIZED PLASMAS or BEYOND MHD or PLASMA PHYSICS IN 100 MINUTES! Dalton D. Schnack April 18, 2006 1 Introduction You are now all experts in MHD. As you know, ideal MHD describes the dynamics

More information

Computational Modeling of Fully Ionized Magnetized Plasmas Using the Fluid Approximation

Computational Modeling of Fully Ionized Magnetized Plasmas Using the Fluid Approximation Computational Modeling of Fully Ionized Magnetized Plasmas Using the Fluid Approximation Dalton D. Schnack Center for Energy and Space Science Center for Magnetic Self-Organization in Space and Laboratory

More information

Elasticity in two dimensions 1

Elasticity in two dimensions 1 Elasticity in two dimensions 1 Elasticity in two dimensions Chapters 3 and 4 of Mechanics of the Cell, as well as its Appendix D, contain selected results for the elastic behavior of materials in two and

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

Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry

Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry D. D. Schnack University of Wisconsin Madison Jianhua Cheng, S. E. Parker University of Colorado

More information

Problem Set 4. Eshelby s Inclusion

Problem Set 4. Eshelby s Inclusion ME34B Elasticity of Microscopic Structures Wei Cai Stanford University Winter 24 Problem Set 4. Eshelby s Inclusion Chris Weinberger and Wei Cai c All rights reserved Problem 4. (5 Spherical inclusion.

More information

Computational modeling of fully ionized magnetized plasmas using the fluid approximation a

Computational modeling of fully ionized magnetized plasmas using the fluid approximation a PHYSICS OF PLASMAS 13, 058103 2006 Computational modeling of fully ionized magnetized plasmas using the fluid approximation a D. D. Schnack b Center for Energy Space Science, Science Applications International

More information

Local Anisotropy In Globally Isotropic Granular Packings. Kamran Karimi Craig E Maloney

Local Anisotropy In Globally Isotropic Granular Packings. Kamran Karimi Craig E Maloney Local Anisotropy In Globally Isotropic Granular Packings Kamran Karimi Craig E Maloney Granular Materials 2 A Granular Material Is A Conglomeration Of Discrete Solid, Natural Macroscopic Particles Characterized

More information

Homogenization in Elasticity

Homogenization in Elasticity uliya Gorb November 9 13, 2015 uliya Gorb Homogenization of Linear Elasticity problem We now study Elasticity problem in Ω ε R 3, where the domain Ω ε possess a periodic structure with period 0 < ε 1 and

More information

Fundamentals of Linear Elasticity

Fundamentals of Linear Elasticity Fundamentals of Linear Elasticity Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy

More information

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Somnath Bhowmick Materials Science and Engineering, IIT Kanpur April 6, 2018 Tensile test and Hooke s Law Upto certain strain (0.75),

More information

Modeling of ELM Dynamics for ITER

Modeling of ELM Dynamics for ITER Modeling of ELM Dynamics for ITER A.Y. PANKIN 1, G. BATEMAN 1, D.P. BRENNAN 2, A.H. KRITZ 1, S. KRUGER 3, P.B. SNYDER 4 and the NIMROD team 1 Lehigh University, 16 Memorial Drive East, Bethlehem, PA 18015

More information

MATH45061: SOLUTION SHEET 1 V

MATH45061: SOLUTION SHEET 1 V 1 MATH4561: SOLUTION SHEET 1 V 1.) a.) The faces of the cube remain aligned with the same coordinate planes. We assign Cartesian coordinates aligned with the original cube (x, y, z), where x, y, z 1. The

More information

16.20 HANDOUT #2 Fall, 2002 Review of General Elasticity

16.20 HANDOUT #2 Fall, 2002 Review of General Elasticity 6.20 HANDOUT #2 Fall, 2002 Review of General Elasticity NOTATION REVIEW (e.g., for strain) Engineering Contracted Engineering Tensor Tensor ε x = ε = ε xx = ε ε y = ε 2 = ε yy = ε 22 ε z = ε 3 = ε zz =

More information

Chapter 7. Kinematics. 7.1 Tensor fields

Chapter 7. Kinematics. 7.1 Tensor fields Chapter 7 Kinematics 7.1 Tensor fields In fluid mechanics, the fluid flow is described in terms of vector fields or tensor fields such as velocity, stress, pressure, etc. It is important, at the outset,

More information

Basic concepts to start Mechanics of Materials

Basic concepts to start Mechanics of Materials Basic concepts to start Mechanics of Materials Georges Cailletaud Centre des Matériaux Ecole des Mines de Paris/CNRS Notations Notations (maths) (1/2) A vector v (element of a vectorial space) can be seen

More information

Introduction to fracture mechanics

Introduction to fracture mechanics Introduction to fracture mechanics Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 6-9 November, 2017 Institute of Structural Engineering, ETH Zu rich November 9, 2017 Institute

More information

Constitutive Relations

Constitutive Relations Constitutive Relations Andri Andriyana, Ph.D. Centre de Mise en Forme des Matériaux, CEMEF UMR CNRS 7635 École des Mines de Paris, 06904 Sophia Antipolis, France Spring, 2008 Outline Outline 1 Review of

More information

APPENDIX Z. USEFUL FORMULAS 1. Appendix Z. Useful Formulas. DRAFT 13:41 June 30, 2006 c J.D Callen, Fundamentals of Plasma Physics

APPENDIX Z. USEFUL FORMULAS 1. Appendix Z. Useful Formulas. DRAFT 13:41 June 30, 2006 c J.D Callen, Fundamentals of Plasma Physics APPENDIX Z. USEFUL FORMULAS 1 Appendix Z Useful Formulas APPENDIX Z. USEFUL FORMULAS 2 Key Vector Relations A B = B A, A B = B A, A A = 0, A B C) = A B) C A B C) = B A C) C A B), bac-cab rule A B) C D)

More information

Semi-implicit Treatment of the Hall Effect in NIMROD Simulations

Semi-implicit Treatment of the Hall Effect in NIMROD Simulations Semi-implicit Treatment of the Hall Effect in NIMROD Simulations H. Tian and C. R. Soinec Department of Engineering Physics, Uniersity of Wisconsin-Madison Madison, WI 5376 Presented at the 45th Annual

More information

Continuum mechanics V. Constitutive equations. 1. Constitutive equation: definition and basic axioms

Continuum mechanics V. Constitutive equations. 1. Constitutive equation: definition and basic axioms Continuum mechanics office Math 0.107 ales.janka@unifr.ch http://perso.unifr.ch/ales.janka/mechanics Mars 16, 2011, Université de Fribourg 1. Constitutive equation: definition and basic axioms Constitutive

More information

Constitutive Relations

Constitutive Relations Constitutive Relations Dr. Andri Andriyana Centre de Mise en Forme des Matériaux, CEMEF UMR CNRS 7635 École des Mines de Paris, 06904 Sophia Antipolis, France Spring, 2008 Outline Outline 1 Review of field

More information

Math review. Math review

Math review. Math review Math review 1 Math review 3 1 series approximations 3 Taylor s Theorem 3 Binomial approximation 3 sin(x), for x in radians and x close to zero 4 cos(x), for x in radians and x close to zero 5 2 some geometry

More information

MHD Linear Stability Analysis Using a Full Wave Code

MHD Linear Stability Analysis Using a Full Wave Code US-Japan JIFT Workshop on Progress of Extended MHD Models NIFS, Toki,Japan 2007/03/27 MHD Linear Stability Analysis Using a Full Wave Code T. Akutsu and A. Fukuyama Department of Nuclear Engineering, Kyoto

More information

STRESS TRANSPORT MODELLING 2

STRESS TRANSPORT MODELLING 2 STRESS TRANSPORT MODELLING 2 T.J. Craft Department of Mechanical, Aerospace & Manufacturing Engineering UMIST, Manchester, UK STRESS TRANSPORT MODELLING 2 p.1 Introduction In the previous lecture we introduced

More information

Waves in plasmas. S.M.Lea

Waves in plasmas. S.M.Lea Waves in plasmas S.M.Lea 17 1 Plasma as an example of a dispersive medium We shall now discuss the propagation of electromagnetic waves through a hydrogen plasm an electrically neutral fluid of protons

More information

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations Math 575-Lecture 13 In 1845, tokes extended Newton s original idea to find a constitutive law which relates the Cauchy stress tensor to the velocity gradient, and then derived a system of equations. The

More information

Cartesian Tensors. e 2. e 1. General vector (formal definition to follow) denoted by components

Cartesian Tensors. e 2. e 1. General vector (formal definition to follow) denoted by components Cartesian Tensors Reference: Jeffreys Cartesian Tensors 1 Coordinates and Vectors z x 3 e 3 y x 2 e 2 e 1 x x 1 Coordinates x i, i 123,, Unit vectors: e i, i 123,, General vector (formal definition to

More information

Waveform inversion and time-reversal imaging in attenuative TI media

Waveform inversion and time-reversal imaging in attenuative TI media Waveform inversion and time-reversal imaging in attenuative TI media Tong Bai 1, Tieyuan Zhu 2, Ilya Tsvankin 1, Xinming Wu 3 1. Colorado School of Mines 2. Penn State University 3. University of Texas

More information

3D and Planar Constitutive Relations

3D and Planar Constitutive Relations 3D and Planar Constitutive Relations A School on Mechanics of Fibre Reinforced Polymer Composites Knowledge Incubation for TEQIP Indian Institute of Technology Kanpur PM Mohite Department of Aerospace

More information

CH.1. THERMODYNAMIC FOUNDATIONS OF CONSTITUTIVE MODELLING. Computational Solid Mechanics- Xavier Oliver-UPC

CH.1. THERMODYNAMIC FOUNDATIONS OF CONSTITUTIVE MODELLING. Computational Solid Mechanics- Xavier Oliver-UPC CH.1. THERMODYNAMIC FOUNDATIONS OF CONSTITUTIVE MODELLING Computational Solid Mechanics- Xavier Oliver-UPC 1.1 Dissipation approach for constitutive modelling Ch.1. Thermodynamical foundations of constitutive

More information

Introduction to Seismology Spring 2008

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

More information

Waves in plasma. Denis Gialis

Waves in plasma. Denis Gialis Waves in plasma Denis Gialis This is a short introduction on waves in a non-relativistic plasma. We will consider a plasma of electrons and protons which is fully ionized, nonrelativistic and homogeneous.

More information

Lecture Note 1. Introduction to Elasticity Equations

Lecture Note 1. Introduction to Elasticity Equations ME34B Elasticity of Microscopic tructures tanford University Winter 24 Lecture Note. Introduction to Elasticity Equations Chris Weinberger and Wei Cai c All rights reserved January 2, 24 Contents Index

More information

1. Tensor of Rank 2 If Φ ij (x, y) satisfies: (a) having four components (9 for 3-D). (b) when the coordinate system is changed from x i to x i,

1. Tensor of Rank 2 If Φ ij (x, y) satisfies: (a) having four components (9 for 3-D). (b) when the coordinate system is changed from x i to x i, 1. Tensor of Rank 2 If Φ ij (x, y satisfies: (a having four components (9 for 3-D. Φ i j (x 1, x 2 = β i iβ j jφ ij (x 1, x 2. Example 1: ( 1 0 0 1 Φ i j = ( 1 0 0 1 To prove whether this is a tensor or

More information

Understand basic stress-strain response of engineering materials.

Understand basic stress-strain response of engineering materials. Module 3 Constitutive quations Learning Objectives Understand basic stress-strain response of engineering materials. Quantify the linear elastic stress-strain response in terms of tensorial quantities

More information

Elastic Fields of Dislocations in Anisotropic Media

Elastic Fields of Dislocations in Anisotropic Media Elastic Fields of Dislocations in Anisotropic Media a talk given at the group meeting Jie Yin, David M. Barnett and Wei Cai November 13, 2008 1 Why I want to give this talk Show interesting features on

More information

Bulletin of the Transilvania University of Braşov Vol 10(59), No Series III: Mathematics, Informatics, Physics, 49-58

Bulletin of the Transilvania University of Braşov Vol 10(59), No Series III: Mathematics, Informatics, Physics, 49-58 Bulletin of the Transilvania University of Braşov Vol 10(59), No. 2-2017 Series III: Mathematics, Informatics, Physics, 49-58 THERMOELASTICITY WITH FRACTIONAL ORDER STRAIN FOR DIPOLAR MATERIALS WITH VOIDS

More information

Tensors - Lecture 4. cos(β) sin(β) sin(β) cos(β) 0

Tensors - Lecture 4. cos(β) sin(β) sin(β) cos(β) 0 1 Introduction Tensors - Lecture 4 The concept of a tensor is derived from considering the properties of a function under a transformation of the corrdinate system. As previously discussed, such transformations

More information

2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1. Waves in plasmas. T. Johnson

2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1. Waves in plasmas. T. Johnson 2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1 Waves in plasmas T. Johnson Introduction to plasma physics Magneto-Hydro Dynamics, MHD Plasmas without magnetic fields Cold plasmas Transverse waves

More information

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Tensors, and differential forms - Lecture 2

Tensors, and differential forms - Lecture 2 Tensors, and differential forms - Lecture 2 1 Introduction The concept of a tensor is derived from considering the properties of a function under a transformation of the coordinate system. A description

More information

A.1 Appendix on Cartesian tensors

A.1 Appendix on Cartesian tensors 1 Lecture Notes on Fluid Dynamics (1.63J/2.21J) by Chiang C. Mei, February 6, 2007 A.1 Appendix on Cartesian tensors [Ref 1] : H Jeffreys, Cartesian Tensors; [Ref 2] : Y. C. Fung, Foundations of Solid

More information

Dispersive Media, Lecture 7 - Thomas Johnson 1. Waves in plasmas. T. Johnson

Dispersive Media, Lecture 7 - Thomas Johnson 1. Waves in plasmas. T. Johnson 2017-02-14 Dispersive Media, Lecture 7 - Thomas Johnson 1 Waves in plasmas T. Johnson Introduction to plasmas as a coupled system Magneto-Hydro Dynamics, MHD Plasmas without magnetic fields Cold plasmas

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

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models 0-0 Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models B. Srinivasan, U. Shumlak Aerospace and Energetics Research Program, University of Washington, Seattle,

More information

Dr. Parveen Lata Department of Basic and Applied Sciences, Punjabi University, Patiala, Punjab, India.

Dr. Parveen Lata Department of Basic and Applied Sciences, Punjabi University, Patiala, Punjab, India. International Journal of Theoretical and Applied Mechanics. ISSN 973-685 Volume 12, Number 3 (217) pp. 435-443 Research India Publications http://www.ripublication.com Linearly Distributed Time Harmonic

More information

Electricity & Magnetism Qualifier

Electricity & Magnetism Qualifier Electricity & Magnetism Qualifier For each problem state what system of units you are using. 1. Imagine that a spherical balloon is being filled with a charged gas in such a way that the rate of charge

More information

Heating and current drive: Radio Frequency

Heating and current drive: Radio Frequency Heating and current drive: Radio Frequency Dr Ben Dudson Department of Physics, University of York Heslington, York YO10 5DD, UK 13 th February 2012 Dr Ben Dudson Magnetic Confinement Fusion (1 of 26)

More information

MECH 5312 Solid Mechanics II. Dr. Calvin M. Stewart Department of Mechanical Engineering The University of Texas at El Paso

MECH 5312 Solid Mechanics II. Dr. Calvin M. Stewart Department of Mechanical Engineering The University of Texas at El Paso MECH 5312 Solid Mechanics II Dr. Calvin M. Stewart Department of Mechanical Engineering The University of Texas at El Paso Table of Contents Thermodynamics Derivation Hooke s Law: Anisotropic Elasticity

More information

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

Lagrangian Formulation of Elastic Wave Equation on Riemannian Manifolds

Lagrangian Formulation of Elastic Wave Equation on Riemannian Manifolds RWE-C3-EAFIT Lagrangian Formulation of Elastic Wave Equation on Riemannian Manifolds Hector Roman Quiceno E. Advisors Ph.D Jairo Alberto Villegas G. Ph.D Diego Alberto Gutierrez I. Centro de Ciencias de

More information

Transition From Single Fluid To Pure Electron MHD Regime Of Tearing Instability

Transition From Single Fluid To Pure Electron MHD Regime Of Tearing Instability Transition From Single Fluid To Pure Electron MHD Regime Of Tearing Instability V.V.Mirnov, C.C.Hegna, S.C.Prager APS DPP Meeting, October 27-31, 2003, Albuquerque NM Abstract In the most general case,

More information

A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere

A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere P. Song Center for Atmospheric Research University of Massachusetts Lowell V. M. Vasyliūnas Max-Planck-Institut

More information

1 Gauss integral theorem for tensors

1 Gauss integral theorem for tensors Non-Equilibrium Continuum Physics TA session #1 TA: Yohai Bar Sinai 16.3.216 Index Gymnastics: Gauss Theorem, Isotropic Tensors, NS Equations The purpose of today s TA session is to mess a bit with tensors

More information

Fluid equations, magnetohydrodynamics

Fluid equations, magnetohydrodynamics Fluid equations, magnetohydrodynamics Multi-fluid theory Equation of state Single-fluid theory Generalised Ohm s law Magnetic tension and plasma beta Stationarity and equilibria Validity of magnetohydrodynamics

More information

20. Alfven waves. ([3], p ; [1], p ; Chen, Sec.4.18, p ) We have considered two types of waves in plasma:

20. Alfven waves. ([3], p ; [1], p ; Chen, Sec.4.18, p ) We have considered two types of waves in plasma: Phys780: Plasma Physics Lecture 20. Alfven Waves. 1 20. Alfven waves ([3], p.233-239; [1], p.202-237; Chen, Sec.4.18, p.136-144) We have considered two types of waves in plasma: 1. electrostatic Langmuir

More information

Exponential Growth and Filamentary Structure of Nonlinear Ballooning Instability 1

Exponential Growth and Filamentary Structure of Nonlinear Ballooning Instability 1 Exponential Growth and Filamentary Structure of Nonlinear Ballooning Instability 1 Ping Zhu in collaboration with C. C. Hegna and C. R. Sovinec University of Wisconsin-Madison Sherwood Conference Denver,

More information

MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION

MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION Marty Goldman University of Colorado Spring 2017 Physics 5150 Issues 2 How is MHD related to 2-fluid theory Level of MHD depends

More information

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length.

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length. Mathematical Tripos Part IA Lent Term 205 ector Calculus Prof B C Allanach Example Sheet Sketch the curve in the plane given parametrically by r(u) = ( x(u), y(u) ) = ( a cos 3 u, a sin 3 u ) with 0 u

More information

Single Particle Motion

Single Particle Motion Single Particle Motion C ontents Uniform E and B E = - guiding centers Definition of guiding center E gravitation Non Uniform B 'grad B' drift, B B Curvature drift Grad -B drift, B B invariance of µ. Magnetic

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

More information

Part 1 ELEMENTS OF CONTINUUM MECHANICS

Part 1 ELEMENTS OF CONTINUUM MECHANICS Part 1 ELEMENTS OF CONTINUUM MECHANICS CHAPTER 1 TENSOR PRELIMINARIES 1.1. Vectors An orthonormal basis for the three-dimensional Euclidean vector space is a set of three orthogonal unit vectors. The scalar

More information

Part 5 ACOUSTIC WAVE PROPAGATION IN ANISOTROPIC MEDIA

Part 5 ACOUSTIC WAVE PROPAGATION IN ANISOTROPIC MEDIA Part 5 ACOUSTIC WAVE PROPAGATION IN ANISOTROPIC MEDIA Review of Fundamentals displacement-strain relation stress-strain relation balance of momentum (deformation) (constitutive equation) (Newton's Law)

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

Faculty of Engineering, Mathematics and Science School of Mathematics

Faculty of Engineering, Mathematics and Science School of Mathematics Faculty of Engineering, Mathematics and Science School of Mathematics JS & SS Mathematics SS Theoretical Physics SS TSM Mathematics Module MA3429: Differential Geometry I Trinity Term 2018???, May??? SPORTS

More information

Exam paper: Biomechanics

Exam paper: Biomechanics Exam paper: Biomechanics Tuesday August 10th 2010; 9.00-12.00 AM Code: 8W020 Biomedical Engineering Department, Eindhoven University of Technology The exam comprises 10 problems. Every problem has a maximum

More information

Waves in Linear Optical Media

Waves in Linear Optical Media 1/53 Waves in Linear Optical Media Sergey A. Ponomarenko Dalhousie University c 2009 S. A. Ponomarenko Outline Plane waves in free space. Polarization. Plane waves in linear lossy media. Dispersion relations

More information

t, H = 0, E = H E = 4πρ, H df = 0, δf = 4πJ.

t, H = 0, E = H E = 4πρ, H df = 0, δf = 4πJ. Lecture 3 Cohomologies, curvatures Maxwell equations The Maxwell equations for electromagnetic fields are expressed as E = H t, H = 0, E = 4πρ, H E t = 4π j. These equations can be simplified if we use

More information

Incompressible MHD simulations

Incompressible MHD simulations Incompressible MHD simulations Felix Spanier 1 Lehrstuhl für Astronomie Universität Würzburg Simulation methods in astrophysics Felix Spanier (Uni Würzburg) Simulation methods in astrophysics 1 / 20 Outline

More information

E&M. 1 Capacitors. January 2009

E&M. 1 Capacitors. January 2009 E&M January 2009 1 Capacitors Consider a spherical capacitor which has the space between its plates filled with a dielectric of permittivity ɛ. The inner sphere has radius r 1 and the outer sphere has

More information

AA242B: MECHANICAL VIBRATIONS

AA242B: MECHANICAL VIBRATIONS AA242B: MECHANICAL VIBRATIONS 1 / 57 AA242B: MECHANICAL VIBRATIONS Dynamics of Continuous Systems These slides are based on the recommended textbook: M. Géradin and D. Rixen, Mechanical Vibrations: Theory

More information

Extended MHD simulation of Rayleigh-Taylor/Kelvin-Helmholtz instability

Extended MHD simulation of Rayleigh-Taylor/Kelvin-Helmholtz instability Extended MHD simulation of Rayleigh-Taylor/Kelvin-Helmholtz instability R. Goto (a), T. Hatori (a), H. Miura (a, b), A. Ito (a, b) and M. Sato (b) (a) The Graduate University for Advanced Studies (Sokendai)

More information

Homework 7-8 Solutions. Problems

Homework 7-8 Solutions. Problems Homework 7-8 Solutions Problems 26 A rhombus is a parallelogram with opposite sides of equal length Let us form a rhombus using vectors v 1 and v 2 as two adjacent sides, with v 1 = v 2 The diagonals of

More information

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics

CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS. Multimedia Course on Continuum Mechanics CH.9. CONSTITUTIVE EQUATIONS IN FLUIDS Multimedia Course on Continuum Mechanics Overview Introduction Fluid Mechanics What is a Fluid? Pressure and Pascal s Law Constitutive Equations in Fluids Fluid Models

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

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February.

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February. Engineering Sciences 241 Advanced Elasticity, Spring 2001 J. R. Rice Homework Problems / Class Notes Mechanics of finite deformation (list of references at end) Distributed Thursday 8 February. Problems

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

Finite Elements for Elastic Shell Models in

Finite Elements for Elastic Shell Models in Elastic s in Advisor: Matthias Heinkenschloss Computational and Applied Mathematics Rice University 13 April 2007 Outline Elasticity in Differential Geometry of Shell Geometry and Equations The Plate Model

More information

ASTR 320: Solutions to Problem Set 2

ASTR 320: Solutions to Problem Set 2 ASTR 320: Solutions to Problem Set 2 Problem 1: Streamlines A streamline is defined as a curve that is instantaneously tangent to the velocity vector of a flow. Streamlines show the direction a massless

More information

Diffusion equation, flux, diffusion coefficient scaling. Diffusion in fully ionized plasma vs. weakly ionized plasma. n => Coulomb collision frequency

Diffusion equation, flux, diffusion coefficient scaling. Diffusion in fully ionized plasma vs. weakly ionized plasma. n => Coulomb collision frequency Last Time Diffusion in plasma: the main reason why we need to control it (i.e. using magnetic field) Diffusion equation, flux, diffusion coefficient scaling o o t nx,t Dn D2 nx,t o D ~ L 2 T Diffusion

More information

Hall Viscosity of Hierarchical Quantum Hall States

Hall Viscosity of Hierarchical Quantum Hall States M. Fremling, T. H. Hansson, and J. Suorsa ; Phys. Rev. B 89 125303 Mikael Fremling Fysikum Stockholm University, Sweden Nordita 9 October 2014 Outline 1 Introduction Fractional Quantum Hall Eect 2 Quantum

More information

Cartesian Tensors. e 2. e 1. General vector (formal definition to follow) denoted by components

Cartesian Tensors. e 2. e 1. General vector (formal definition to follow) denoted by components Cartesian Tensors Reference: Jeffreys Cartesian Tensors 1 Coordinates and Vectors z x 3 e 3 y x 2 e 2 e 1 x x 1 Coordinates x i, i 123,, Unit vectors: e i, i 123,, General vector (formal definition to

More information

Chapter 2 General Anisotropic Elasticity

Chapter 2 General Anisotropic Elasticity Chapter 2 General Anisotropic Elasticity Abstract This Chapter is an introduction to general anisotropic elasticity, i.e. to the elasticity of 3D anisotropic bodies. The main classical topics of the matter

More information

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017 CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS Prof. N. Harnew University of Oxford TT 2017 1 OUTLINE : CP1 REVISION LECTURE 3 : INTRODUCTION TO CLASSICAL MECHANICS 1. Angular velocity and

More information

The Rule of Three for commutation relations

The Rule of Three for commutation relations The Rule of Three for commutation relations Jonah Blasiak Drexel University joint work with Sergey Fomin (University of Michigan) May 2016 Symmetric functions The ring of symmetric functions Λ(x) = Λ(x

More information

Fundamentals of Magnetic Island Theory in Tokamaks

Fundamentals of Magnetic Island Theory in Tokamaks Fundamentals of Magnetic Island Theory in Tokamaks Richard Fitzpatrick Institute for Fusion Studies University of Texas at Austin Austin, TX, USA Talk available at http://farside.ph.utexas.edu/talks/talks.html

More information

Memoirs on Differential Equations and Mathematical Physics

Memoirs on Differential Equations and Mathematical Physics Memoirs on Differential Equations and Mathematical Physics Volume 55 2012 1 150. Buchukuri O. Chkadua R. Duduchava and D. Natroshvili INERFACE CRACK PROBLEMS FOR MEALLIC-PIEZOELECRIC COMPOSIE SRUCURES

More information

ICES REPORT February Saumik Dana and Mary F. Wheeler

ICES REPORT February Saumik Dana and Mary F. Wheeler ICE REPORT 18-2 February 218 A framework for arriving at bounds on effective moduli in heterogeneous poroelastic solids by aumik Dana and Mary F. Wheeler The Institute for Computational Engineering and

More information

Introduction and Vectors Lecture 1

Introduction and Vectors Lecture 1 1 Introduction Introduction and Vectors Lecture 1 This is a course on classical Electromagnetism. It is the foundation for more advanced courses in modern physics. All physics of the modern era, from quantum

More information

Proceedings of Meetings on Acoustics

Proceedings of Meetings on Acoustics Proceedings of Meetings on Acoustics Volume 19, 2013 http://acousticalsociety.org/ ICA 2013 Montreal Montreal, Canada 2-7 June 2013 Engineering Acoustics Session 1aEA: Thermoacoustics I 1aEA7. On discontinuity

More information

MAGNETIC NOZZLE PLASMA EXHAUST SIMULATION FOR THE VASIMR ADVANCED PROPULSION CONCEPT

MAGNETIC NOZZLE PLASMA EXHAUST SIMULATION FOR THE VASIMR ADVANCED PROPULSION CONCEPT MAGNETIC NOZZLE PLASMA EXHAUST SIMULATION FOR THE VASIMR ADVANCED PROPULSION CONCEPT ABSTRACT A. G. Tarditi and J. V. Shebalin Advanced Space Propulsion Laboratory NASA Johnson Space Center Houston, TX

More information

Gyrokinetic simulations of magnetic fusion plasmas

Gyrokinetic simulations of magnetic fusion plasmas Gyrokinetic simulations of magnetic fusion plasmas Tutorial 2 Virginie Grandgirard CEA/DSM/IRFM, Association Euratom-CEA, Cadarache, 13108 St Paul-lez-Durance, France. email: virginie.grandgirard@cea.fr

More information

12. MHD Approximation.

12. MHD Approximation. Phys780: Plasma Physics Lecture 12. MHD approximation. 1 12. MHD Approximation. ([3], p. 169-183) The kinetic equation for the distribution function f( v, r, t) provides the most complete and universal

More information

Effect of internal state variables in thermoelasticity of microstretch bodies

Effect of internal state variables in thermoelasticity of microstretch bodies DOI: 10.1515/auom-016-0057 An. Şt. Univ. Ovidius Constanţa Vol. 43,016, 41 57 Effect of internal state variables in thermoelasticity of microstretch bodies Marin Marin and Sorin Vlase Abstract First, we

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

Theoretical Foundation of 3D Alfvén Resonances: Time Dependent Solutions

Theoretical Foundation of 3D Alfvén Resonances: Time Dependent Solutions Theoretical Foundation of 3D Alfvén Resonances: Time Dependent Solutions Tom Elsden 1 Andrew Wright 1 1 Dept Maths & Stats, University of St Andrews DAMTP Seminar - 8th May 2017 Outline Introduction Coordinates

More information

COMPARISON OF NEOCLASSICAL ROTATION THEORY WITH EXPERIMENT UNDER A VARIETY OF CONDITIONS IN DIII-D

COMPARISON OF NEOCLASSICAL ROTATION THEORY WITH EXPERIMENT UNDER A VARIETY OF CONDITIONS IN DIII-D COMPARISON OF NEOCLASSICAL ROTATION THEORY WITH EXPERIMENT UNDER A VARIETY OF CONDITIONS IN DIII-D W. M. Stacey and J. Mandrekas Fusion Research Center Georgia Institute of Technology October, 2001 ABSTRACT

More information