X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow.

Size: px
Start display at page:

Download "X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow."

Transcription

1 Physical processes by characteristic timescale Diffusive timescale t diff ~ L2 D largest Sound crossing timescale t sound ~ L a Flow timescale t flow ~ L u Free fall timescale Cooling timescale Reaction timescale t ff ~ 1 G t cool ~ X i t react ~min i X i ~ 1 max i j X j R ij smallest

2 Continuity equation source terms Multiple fluid components N f = X 1 X 2 X 3... X N f =1} X i i i t i u =0 X i t u X i=0 Reactions that convert one fluid component into another N X i t u X = f i j=1 X i X j R ij Mass diffusion usually negligible in astrophysical settings t u = [ D ]

3 Importance of conservation in continuity equations The sum X i =1 is not always preserved by an update step: Interpolants: different flattening of the X i Source terms: not always guaranteed to preserve sum Solutions: Rescaling X i X i j X j Restricting X i min[1,max 0, X i ] Problem: no error control Solving only N f 1 equations N f 1 X N f =1 j =1 Problem: error tends to accumulate in the assumed fluid abundance X j Flatten all abundances when X i 1, otherwise none of them Problem: reduces spatial order, leads to numerical mixing

4 Momentum equation source terms Gravitational forces and viscosity u uu P= g D t = [G D ] For momentum equation these terms can be written as the divergence of a conserved flux. Can also have true momentum source terms: e.g., AGN jets modelled as pistons

5 Energy equation source terms Energy sources/sinks gravity, radiation E t t u P u= [ E P u]= u g Thermal conduction and viscous heating t u P u= [ K ] 1 2 D 2 D ij = u i x j u j x i 2 3 ij u Equation of state,t, X 1,..., X N f for ideal gases: Dalton's law of partial pressures P=P 1,T P 2, T... P N f, T

6 Unsplit methods Solve the advection, diffusion, and source terms together e.g., upwind differencing for advection, FTCS for diffusion, and FT for source: q i n 1 =q i n t q t where s = 1 if u i n < 0, s = 0 if u i n > 0 n x [ qu i s = qu x D 2 q x 2 n qu i s 1 D x n q i 1 n] 2 q n n i q i 1 i Advantage: Disadvantage: avoids errors introduced by operator splitting difficult to develop Godunov type methods and multidimensional methods; usually no exact solution to Riemann problem

7 Split (fractional step) methods Apply difference operators for each piece of physics in sequence. Consider D = D 1 + D 2 + D 3 First order (time): D[q] = D 1 [D 2 [D 3 [q]]] + O( t) Second order (time) Strang splitting: With operator splitting we cannot do better than the time accuracy of the splitting method, no matter what the accuracy of the component operators is. Solve the advection part of our equation with a standard CFD method, with the diffusion terms split off and solved with a parabolic solver, and the source terms split off and solved with an ordinary differential equation solver: q t D[q] = D 1 1/2 [D 2 1/2 [D 3 1/2 [D 3 1/2 [D 2 1/2 [D 1 1/2 [q]]]]]] + O( t 2 ) qu = x D 2 q x 2 { q qu = t x q t =D 2 q x 2 d q d t =

8 Stiffness Often have very different timescales for flow and source terms. e.g., thermonuclear runaway in a white dwarf (Type Ia supernova) nuclear burning timescale ( 12 C + 12 C) sound crossing timescale If we stick to explicit time integration schemes, we are forced to integrate on the shortest timescale in order to maintain numerical stability! Yet doing everything implicitly causes problems when shock waves are involved. So commonly we: t burn ~ ~ n 1 cm 3 sec ~ sec t sound ~ R a ~ cm c ~ 1 sec Use explicit methods for longest timescale physics (advection, diffusion) Use implicit methods for shortest timescale physics (reactions, diffusion) Set timestep using explicit method and then sub cycle the implicit method

9 Sub cycling q(x,t) source term q n+1 q n+2 q n advection total t t n t n+1 t n+2 t n,1 t n,2 t n,3 t n,4 t n,5 t n,6 t n,7 Intervals t n between Intervals t n,m between determined by stability needs of explicit scheme determined by accuracy needs of implicit scheme; last interval set to make t n,mmax = t n+1 Cannot have t n max m t n,m causes advection and source terms to decouple

10 Explicit ODE methods Consider the system of linear ordinary differential equations with A symmetric and positive definite (all positive eigenvalues). The number of elements in the vector q is the number of simultaneous source term equations we are solving. One such system is solved for every zone in our grid. Forward Euler (explicit) differencing gives For stability, the timestep must satisfy d q dt = A q q m 1 = I A t q m 1 max t 1 t 2 max where max is the maximum eigenvalue of A.

11 Runge Kutta methods Explicit ODE integration schemes that achieve higher order than forward Euler by computing derivatives at intermediate points Combine with adaptive step size control for robust integration to modest accuracy (~ 10 4 ) either by halving t or by combining different orders to get error estimate ( embedding ) Second order Runge Kutta (midpoint method): k 1 = t f t m,q m q(t) k 2 = t f t m 1 2 t,qm 1 2 k 1 q m 1 =q m k 2 O t 3 Fourth order Runge Kutta method: k 1 = t f t m, q m k 2 = t f t m 1 2 t, qm 1 2 k 1 k 3 = t f t m 1 2 t, qm 1 2 k 2 k 4 = t f t m t, q m k 3 q m q m+1 t q m 1 =q m 1 6 k k k k 4 O t 5 t m t m+1/2 t m+1 k 1 k 2 k 3 k 4

12 Bulirsch Stoer method Can also use midpoint method on successively smaller intervals t and use Richardson extrapolation to estimate solution at t 0. q(t) 2 steps q m 4 steps 6 steps steps m+1 q t m t m+1 t Advantage: much more efficient than Runge Kutta for large systems & high accuracy Disadvantage: not as robust for nonsmooth or singular source terms

13 Implicit and semi implicit ODE methods Backward Euler (implicit) differencing gives which is unconditionally stable, since for all eigenvalues and timesteps t. For nonlinear systems of equations we use Newton's method: q m 1 =q m A q m 1 t q m 1 = I A t 1 q m 1 t 1 1 d q dt =f q qm 1 =q m f q m 1 t q m 1 =q m t[ I t f q m] 1 f q m f/ q is the Jacobian matrix. This type of method is called semi implicit.

14 Rosenbrock methods Semi implicit generalization of Runge Kutta methods. Look for a solution of the form where f I t q m k i = t f qm s is the order of the method. q m 1 =q m i=1 s i 1 j=1 c i k i ij k j t f q m i 1 j=1 ij k j By combining third and fourth order methods, can obtain an estimate of truncation error to use for adaptive step size control. Method is not guaranteed to be stable (semi implicit), but fairly robust nevertheless, even for nonsmooth right hand sides (e.g., from tabular interpolation). For large vectors q (> 10 elements) and high accuracy (< 10 5 ), methods based on Richardson extrapolation are more efficient.

15 Intermission

16 Reaction networks example: diffuse gas + radiation Partially or fully ionized diffuse gas experiences several types of reaction: Photoionization: X + X + + e Recombination: X + + e X + Photon absorption: X + X* Photon emission: X* X + Stimulated emission: X* + X + 2 Collisional excitation: X + e X* + e Collisional ionization: X + e X + + 2e + Charge exchange: X + p X + + H Dielectronic recombination: X+ + e X* Bremsstrahlung: X + e X + e +... Again, we treat different elements and ionization states as different fluids: H 0, H +, H, He 0, He +, He ++,... Overall charge neutrality gives free electron number density: n e = i Z i n i In optically thin limit all radiation escapes; in optically thick limit it is absorbed; in other regimes we need to keep track of radiation field and do radiation transfer

17 Thermal and ionization equilibrium If we have local thermodynamic equilibrium conditions (necessary for a fluid approach!), the Boltzmann relation gives relative abundances of excited states: n i = n g U i e E / kt i i n i n U i g i E i = number density of atomic/ionic species in ith excited state = total number density of species = partition function for ith state = statistical weight for ith state = energy of ith state relative to ground state If we have ionization equilibrium conditions, we can use Saha equation to determine ionic abundances rather than following them separately: n i 1 n e n i = 2U i 1 U i 2 m kt e h 2 3 /2 e / kt i n i n e U i i = number density of ions in ionization state i = free electron number density = partition function for ionization state i = ionization energy of for ionization state i Then we just track the atomic abundances and use the Saha equation whenever we need an ionic abundance.

18 Collisional ionization equilibrium A common situation in the intergalactic medium is collisional ionization equilibrium, in which atoms are collisionally ionized and radiatively recombine. If the gas is optically thin, this causes a net loss of energy from the gas. Treat this situation using: One continuity equation for each element (or a single metallicity for all of them) Ionization fraction is a known function of temperature and abundances use to determine n e (needed for emissivity and equation of state) n X,i n X, i T, n H, n H, n He, n He, n He,... P= n e X,i n X, i kt Radiative cooling via a local energy sink term cooling rate is a known function of density, temperature, and abundances: d dt = T, n H,...

19 Radiative cooling rate for collisionally ionized gas Primordial abundances (from Black 1981) 22 total excitation ionization recombination bremsstrahlung (erg s 1 cm 3 ) 23 H H He + log /n H 2 24 He + H 25 He He He log T (K)

20 Photoionization equilibrium Another common situation: a source of ultraviolet photons ionizes nearby gas; medium is optically thick to recombination photons ( Strömgren sphere ) In the interior of the nebula the ionization state is set by the equilibrium between: Photoionization by photons from central source and from locally produced recombination photons Collisional ionization by local free electrons Recombination Neutral gas Ionized gas O star 5 pc The size of the nebula increases with time unless collisional processes produce radiation that can escape pc Inside cloud treat using: Ionic abundances from photoionization equilibrium given known external photon source: varying optical depth to known source, local recombination radiation produces local re ionization ( on the spot approximation) Net heating source term for energy equation includes collisional cooling effects Near the edge of the cloud finite optical depth to local recombination photons must be taken into account

21 Photoionization equilibrium 2 Case 1: no external radiation field, optically thin, collisional cooling only T decreases with time (( )) Case 2: known external radiation field, net photoionization energy input exceeds collisional cooling rate T increases with time Case 3: known external radiation field, collisional cooling rate exceeds net photoionization energy input T decreases with time (( )) Case 4: known external radiation field, net photoionization energy input balances collisional cooling thermal equilibrium (( ))

22 Cooling curves including photoionization Representative curves for uniform external J = ( L / ) erg s 1 cm 2 sr 1 Hz 1 (N. Katz) At lower density, almost complete ionization so gas transparent to recombination photons, allowing them to act as a coolant At higher density, recombination photons are locally absorbed cooling occurs by collisionally excited line emission and bremsstrahlung n H = cm 3 n H = cm (erg s 1 cm 3 ) 23 Heating 23 log /n H log T (K) 25 Equilibrium temperature log T (K)

Photoionized Gas Ionization Equilibrium

Photoionized Gas Ionization Equilibrium Photoionized Gas Ionization Equilibrium Ionization Recombination H nebulae - case A and B Strömgren spheres H + He nebulae Heavy elements, dielectronic recombination Ionization structure 1 Ionization Equilibrium

More information

CHAPTER 22. Astrophysical Gases

CHAPTER 22. Astrophysical Gases CHAPTER 22 Astrophysical Gases Most of the baryonic matter in the Universe is in a gaseous state, made up of 75% Hydrogen (H), 25% Helium (He) and only small amounts of other elements (called metals ).

More information

NUMERICAL METHODS IN ASTROPHYSICS An Introduction

NUMERICAL METHODS IN ASTROPHYSICS An Introduction -1 Series in Astronomy and Astrophysics NUMERICAL METHODS IN ASTROPHYSICS An Introduction Peter Bodenheimer University of California Santa Cruz, USA Gregory P. Laughlin University of California Santa Cruz,

More information

Outline of lectures. Adding more physics. Doing Better: source terms in CTU unsplit integrator

Outline of lectures. Adding more physics. Doing Better: source terms in CTU unsplit integrator Grid-based methods for hydrodynamics, MHD, and radiation hydrodynamics. Outline of lectures (Four lectures) Lecture 1. Introduction to physics and numerics Lecture 2. Operator split (ZEUS-like) methods

More information

Theory of optically thin emission line spectroscopy

Theory of optically thin emission line spectroscopy Theory of optically thin emission line spectroscopy 1 Important definitions In general the spectrum of a source consists of a continuum and several line components. Processes which give raise to the continuous

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

Ay Fall 2004 Lecture 6 (given by Tony Travouillon)

Ay Fall 2004 Lecture 6 (given by Tony Travouillon) Ay 122 - Fall 2004 Lecture 6 (given by Tony Travouillon) Stellar atmospheres, classification of stellar spectra (Many slides c/o Phil Armitage) Formation of spectral lines: 1.excitation Two key questions:

More information

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients AM 205: lecture 13 Last time: ODE convergence and stability, Runge Kutta methods Today: the Butcher tableau, multi-step methods, boundary value problems Butcher tableau Can summarize an s + 1 stage Runge

More information

6. Interstellar Medium. Emission nebulae are diffuse patches of emission surrounding hot O and

6. Interstellar Medium. Emission nebulae are diffuse patches of emission surrounding hot O and 6-1 6. Interstellar Medium 6.1 Nebulae Emission nebulae are diffuse patches of emission surrounding hot O and early B-type stars. Gas is ionized and heated by radiation from the parent stars. In size,

More information

Notes on Photoionized Regions Wednesday, January 12, 2011

Notes on Photoionized Regions Wednesday, January 12, 2011 Notes on Photoionized Regions Wednesday, January 12, 2011 CONTENTS: 1. Introduction 2. Hydrogen Nebulae A. Ionization equations B. Recombination coefficients and cross sections C. Structure of the hydrogen

More information

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Modeling, Simulating and Rendering Fluids Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Applications Mostly Hollywood Shrek Antz Terminator 3 Many others Games Engineering Animating Fluids is

More information

Computational Astrophysics 7 Hydrodynamics with source terms

Computational Astrophysics 7 Hydrodynamics with source terms Computational Astrophysics 7 Hydrodynamics with source terms Oscar Agertz Outline - Optically thin radiative hydrodynamics - Relaxation towards the diffusion limit - Hydrodynamics with gravity source term

More information

The family of Runge Kutta methods with two intermediate evaluations is defined by

The family of Runge Kutta methods with two intermediate evaluations is defined by AM 205: lecture 13 Last time: Numerical solution of ordinary differential equations Today: Additional ODE methods, boundary value problems Thursday s lecture will be given by Thomas Fai Assignment 3 will

More information

Physics and Chemistry of the Interstellar Medium

Physics and Chemistry of the Interstellar Medium Physics and Chemistry of the Interstellar Medium Sun Kwok The University of Hong Kong UNIVERSITY SCIENCE BOOKS Sausalito, California * Preface xi The Interstellar Medium.1.1 States of Matter in the ISM

More information

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H -

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 6. Stellar spectra excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 1 Occupation numbers: LTE case Absorption coefficient: κ ν = n i σ ν$ à calculation of occupation

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

Thermal Equilibrium in Nebulae 1. For an ionized nebula under steady conditions, heating and cooling processes that in

Thermal Equilibrium in Nebulae 1. For an ionized nebula under steady conditions, heating and cooling processes that in Thermal Equilibrium in Nebulae 1 For an ionized nebula under steady conditions, heating and cooling processes that in isolation would change the thermal energy content of the gas are in balance, such that

More information

The RAMSES code and related techniques 4. Source terms

The RAMSES code and related techniques 4. Source terms The RAMSES code and related techniques 4. Source terms Outline - Optically thin radiative hydrodynamics - Relaxation towards the diffusion limit - Hydrodynamics with gravity source term - Relaxation towards

More information

Some fundamentals. Statistical mechanics. The non-equilibrium ISM. = g u

Some fundamentals. Statistical mechanics. The non-equilibrium ISM. = g u Some fundamentals Statistical mechanics We have seen that the collision timescale for gas in this room is very small relative to radiative timesscales such as spontaneous emission. The frequent collisions

More information

Topics ASTR 3730: Fall 2003

Topics ASTR 3730: Fall 2003 Topics Qualitative questions: might cover any of the main topics (since 2nd midterm: star formation, extrasolar planets, supernovae / neutron stars, black holes). Quantitative questions: worthwhile to

More information

Gas Dynamics: Basic Equations, Waves and Shocks

Gas Dynamics: Basic Equations, Waves and Shocks Astrophysical Dynamics, VT 010 Gas Dynamics: Basic Equations, Waves and Shocks Susanne Höfner Susanne.Hoefner@fysast.uu.se Astrophysical Dynamics, VT 010 Gas Dynamics: Basic Equations, Waves and Shocks

More information

2. Basic assumptions for stellar atmospheres

2. Basic assumptions for stellar atmospheres . Basic assumptions for stellar atmospheres 1. geometry, stationarity. conservation of momentum, mass 3. conservation of energy 4. Local Thermodynamic Equilibrium 1 1. Geometry Stars as gaseous spheres

More information

Last Time... We discussed energy sources to a shell of stellar material:

Last Time... We discussed energy sources to a shell of stellar material: Energy Sources We are straying a bit from HKT Ch 6 initially, but it is still a good read, and we'll use it for the summary of rates at the end. Clayton is a great source Last Time... We discussed energy

More information

23 Astrophysics 23.5 Ionization of the Interstellar Gas near a Star

23 Astrophysics 23.5 Ionization of the Interstellar Gas near a Star 23 Astrophysics 23.5 Ionization of the Interstellar Gas near a Star (8 units) No knowledge of Astrophysics is assumed or required: all relevant equations are defined and explained in the project itself.

More information

The Interstellar Medium

The Interstellar Medium http://www.strw.leidenuniv.nl/~pvdwerf/teaching/ The Interstellar Medium Lecturer: Dr. Paul van der Werf Fall 2014 Oortgebouw 565, ext 5883 pvdwerf@strw.leidenuniv.nl Assistant: Kirstin Doney Huygenslaboratorium

More information

while the Planck mean opacity is defined by

while the Planck mean opacity is defined by PtII Astrophysics Lent, 2016 Physics of Astrophysics Example sheet 4 Radiation physics and feedback 1. Show that the recombination timescale for an ionised plasma of number density n is t rec 1/αn where

More information

Astronomy 8824: Numerical Methods Notes 2 Ordinary Differential Equations

Astronomy 8824: Numerical Methods Notes 2 Ordinary Differential Equations Astronomy 8824: Numerical Methods Notes 2 Ordinary Differential Equations Reading: Numerical Recipes, chapter on Integration of Ordinary Differential Equations (which is ch. 15, 16, or 17 depending on

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

The Diffuse ISM Friday, February 11, 2011

The Diffuse ISM Friday, February 11, 2011 The Diffuse ISM Friday, February 11, 2011 CONTENTS: 1. Introduction 2. Diffuse Cold and Warm Gas A. Ionization B. Cooling C. Thermal Equlibrium D. The Warm Ionized Medium 3. Hot Gas A. Ionization B. Cooling

More information

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra Semi-discrete central schemes for balance laws. Application to the Broadwell model. Alexander Kurganov * *Department of Mathematics, Tulane University, 683 St. Charles Ave., New Orleans, LA 708, USA kurganov@math.tulane.edu

More information

Lec 3. Radiative Processes and HII Regions

Lec 3. Radiative Processes and HII Regions Lec 3. Radiative Processes and HII Regions 1. Photoionization 2. Recombination 3. Photoionization-Recombination Equilibrium 4. Heating & Cooling of HII Regions 5. Strömgren Theory (for Hydrogen) 6. The

More information

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H -

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 6. Stellar spectra excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 1 Occupation numbers: LTE case Absorption coefficient: = n i calculation of occupation numbers

More information

2. Basic Assumptions for Stellar Atmospheres

2. Basic Assumptions for Stellar Atmospheres 2. Basic Assumptions for Stellar Atmospheres 1. geometry, stationarity 2. conservation of momentum, mass 3. conservation of energy 4. Local Thermodynamic Equilibrium 1 1. Geometry Stars as gaseous spheres!

More information

Computational Fluid Dynamics. PHY 688: Numerical Methods for (Astro)Physics

Computational Fluid Dynamics. PHY 688: Numerical Methods for (Astro)Physics Computational Fluid Dynamics Hydrodynamics When we discussed PDEs, we focused so far on scalar PDEs Often we wish to study systems of PDEs. Here we'll look at the equations of hydrodynamics Nonlinear system

More information

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H -

6. Stellar spectra. excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 6. Stellar spectra excitation and ionization, Saha s equation stellar spectral classification Balmer jump, H - 1 Occupation numbers: LTE case Absorption coefficient: = n i calculation of occupation numbers

More information

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand

Numerical modelling of phase change processes in clouds. Challenges and Approaches. Martin Reitzle Bernard Weigand Institute of Aerospace Thermodynamics Numerical modelling of phase change processes in clouds Challenges and Approaches Martin Reitzle Bernard Weigand Introduction Institute of Aerospace Thermodynamics

More information

Opacity. requirement (aim): radiative equilibrium: near surface: Opacity

Opacity. requirement (aim): radiative equilibrium: near surface: Opacity (Gray) Diffusion approximation to radiative transport: (assumes isotropy valid only in the deep stellar interior) - opacity is a function of frequency (wave length ). - aim: to reduce the (rather complex)

More information

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics The Center for Astrophysical Thermonuclear Flashes FLASH Hydrodynamics Jonathan Dursi (CITA), Alan Calder (FLASH) B. Fryxell, T. Linde, A. Mignone, G. Wiers Many others! Mar 23, 2005 An Advanced Simulation

More information

Photoionization Modelling of H II Region for Oxygen Ions

Photoionization Modelling of H II Region for Oxygen Ions Journal of Materials Science and Chemical Engineering, 2015, 3, 7-16 Published Online April 2015 in SciRes. http://www.scirp.org/journal/msce http://dx.doi.org/10.4236/msce.2015.34002 Photoionization Modelling

More information

X-ray Radiation, Absorption, and Scattering

X-ray Radiation, Absorption, and Scattering X-ray Radiation, Absorption, and Scattering What we can learn from data depend on our understanding of various X-ray emission, scattering, and absorption processes. We will discuss some basic processes:

More information

The Chemical Kinetics Time Step a detailed lecture. Andrew Conley ACOM Division

The Chemical Kinetics Time Step a detailed lecture. Andrew Conley ACOM Division The Chemical Kinetics Time Step a detailed lecture Andrew Conley ACOM Division Simulation Time Step Deep convection Shallow convection Stratiform tend (sedimentation, detrain, cloud fraction, microphysics)

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 29 Almost Done! No

More information

Astrophysics of Gaseous Nebulae and Active Galactic Nuclei

Astrophysics of Gaseous Nebulae and Active Galactic Nuclei SECOND EDITION Astrophysics of Gaseous Nebulae and Active Galactic Nuclei Donald E. Osterbrock Lick Observatory, University of California, Santa Cruz Gary J. Ferland Department of Physics and Astronomy,

More information

ASTR 610 Theory of Galaxy Formation Lecture 14: Heating & Cooling

ASTR 610 Theory of Galaxy Formation Lecture 14: Heating & Cooling ASTR 610 Theory of Galaxy Formation Lecture 14: Heating & Cooling Frank van den Bosch Yale University, spring 2017 Heating & Cooling In this lecture we address heating and cooling of gas inside dark matter

More information

The inverse process is recombination, and in equilibrium

The inverse process is recombination, and in equilibrium Section 4 Ionization equilibrium As we have discussed previously, UV photons will photoionize neutral hydrogen atoms if they have with hν > 13.6eV (= I H, the ionization potential for hydrogen). The excess

More information

The Birth Of Stars. How do stars form from the interstellar medium Where does star formation take place How do we induce star formation

The Birth Of Stars. How do stars form from the interstellar medium Where does star formation take place How do we induce star formation Goals: The Birth Of Stars How do stars form from the interstellar medium Where does star formation take place How do we induce star formation Interstellar Medium Gas and dust between stars is the interstellar

More information

M.Phys., M.Math.Phys., M.Sc. MTP Radiative Processes in Astrophysics and High-Energy Astrophysics

M.Phys., M.Math.Phys., M.Sc. MTP Radiative Processes in Astrophysics and High-Energy Astrophysics M.Phys., M.Math.Phys., M.Sc. MTP Radiative Processes in Astrophysics and High-Energy Astrophysics Professor Garret Cotter garret.cotter@physics.ox.ac.uk Office 756 in the DWB & Exeter College Radiative

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

a few more introductory subjects : equilib. vs non-equil. ISM sources and sinks : matter replenishment, and exhaustion Galactic Energetics

a few more introductory subjects : equilib. vs non-equil. ISM sources and sinks : matter replenishment, and exhaustion Galactic Energetics Today : a few more introductory subjects : equilib. vs non-equil. ISM sources and sinks : matter replenishment, and exhaustion Galactic Energetics photo-ionization of HII assoc. w/ OB stars ionization

More information

Ordinary Differential Equations

Ordinary Differential Equations Chapter 13 Ordinary Differential Equations We motivated the problem of interpolation in Chapter 11 by transitioning from analzying to finding functions. That is, in problems like interpolation and regression,

More information

Split explicit methods

Split explicit methods Split explicit methods Almut Gassmann Meteorological Institute of the University of Bonn Germany St.Petersburg Summer School 2006 on nonhydrostatic dynamics and fine scale data assimilation Two common

More information

Chapter 3C. 3-4C. Ionization

Chapter 3C. 3-4C. Ionization Chapter 3C The excitation ratio N B /N A increases as the excitation potential get smaller. Also, as T increases, the higher energy levels become more populated. One should see that as T goes to infinity,

More information

2. Basic assumptions for stellar atmospheres

2. Basic assumptions for stellar atmospheres . Basic assumptions for stellar atmospheres 1. geometry, stationarity. conservation of momentum, mass 3. conservation of energy 4. Local Thermodynamic Equilibrium 1 1. Geometry Stars as gaseous spheres

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

LECTURE NOTES. Ay/Ge 132 ATOMIC AND MOLECULAR PROCESSES IN ASTRONOMY AND PLANETARY SCIENCE. Geoffrey A. Blake. Fall term 2016 Caltech

LECTURE NOTES. Ay/Ge 132 ATOMIC AND MOLECULAR PROCESSES IN ASTRONOMY AND PLANETARY SCIENCE. Geoffrey A. Blake. Fall term 2016 Caltech LECTURE NOTES Ay/Ge 132 ATOMIC AND MOLECULAR PROCESSES IN ASTRONOMY AND PLANETARY SCIENCE Geoffrey A. Blake Fall term 2016 Caltech Acknowledgment Part of these notes are based on lecture notes from the

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

More information

Astr 5465 March 6, 2018 Abundances in Late-type Galaxies Spectra of HII Regions Offer a High-Precision Means for Measuring Abundance (of Gas)

Astr 5465 March 6, 2018 Abundances in Late-type Galaxies Spectra of HII Regions Offer a High-Precision Means for Measuring Abundance (of Gas) Astr 5465 March 6, 2018 Abundances in Late-type Galaxies Spectra of HII Regions Offer a High-Precision Means for Measuring Abundance (of Gas) Emission lines arise from permitted (recombination) and forbidden

More information

Model of Hydrogen Deficient Nebulae in H II Regions at High Temperature

Model of Hydrogen Deficient Nebulae in H II Regions at High Temperature Journal of Materials Science and Chemical Engineering, 2015, 3, 21-29 Published Online August 2015 in SciRes. http://www.scirp.org/journal/msce http://dx.doi.org/10.4236/msce.2015.38004 Model of Hydrogen

More information

Astr 2310 Thurs. March 23, 2017 Today s Topics

Astr 2310 Thurs. March 23, 2017 Today s Topics Astr 2310 Thurs. March 23, 2017 Today s Topics Chapter 16: The Interstellar Medium and Star Formation Interstellar Dust and Dark Nebulae Interstellar Dust Dark Nebulae Interstellar Reddening Interstellar

More information

2. Basic assumptions for stellar atmospheres

2. Basic assumptions for stellar atmospheres . Basic assumptions for stellar atmospheres 1. geometry, stationarity. conservation of momentum, mass 3. conservation of energy 4. Local Thermodynamic Equilibrium 1 1. Geometry Stars as gaseous spheres

More information

Ordinary differential equations - Initial value problems

Ordinary differential equations - Initial value problems Education has produced a vast population able to read but unable to distinguish what is worth reading. G.M. TREVELYAN Chapter 6 Ordinary differential equations - Initial value problems In this chapter

More information

Astrophysics with the Computer: Propagation of Ionization Fronts in Interstellar Gas

Astrophysics with the Computer: Propagation of Ionization Fronts in Interstellar Gas Astrophysics with the Computer: Propagation of Ionization Fronts in Interstellar Gas Joachim Köppen Heidelberg 1992 1 Astrophysics A hot star is born in an interstellar gas cloud. At first all the gas

More information

CHAPTER 27. Continuum Emission Mechanisms

CHAPTER 27. Continuum Emission Mechanisms CHAPTER 27 Continuum Emission Mechanisms Continuum radiation is any radiation that forms a continuous spectrum and is not restricted to a narrow frequency range. In what follows we briefly describe five

More information

Atomic Physics 3 ASTR 2110 Sarazin

Atomic Physics 3 ASTR 2110 Sarazin Atomic Physics 3 ASTR 2110 Sarazin Homework #5 Due Wednesday, October 4 due to fall break Test #1 Monday, October 9, 11-11:50 am Ruffner G006 (classroom) You may not consult the text, your notes, or any

More information

Computational Astrophysics

Computational Astrophysics 16 th Chris Engelbrecht Summer School, January 2005 3: 1 Computational Astrophysics Lecture 3: Magnetic fields Paul Ricker University of Illinois at Urbana-Champaign National Center for Supercomputing

More information

New Results from 3-D supernova models with spectral neutrino diffusion

New Results from 3-D supernova models with spectral neutrino diffusion New Results from 3-D supernova models with spectral neutrino diffusion Stuart C. Whitehouse and Matthias Liebendörfer Department of Physics, University of Basel, Switzerland Overview Introduction The Isotropic

More information

Advanced Stellar Astrophysics

Advanced Stellar Astrophysics v Advanced Stellar Astrophysics William K. Rose University of Maryland College Park CAMBRIDGE UNIVERSITY PRESS Contents Preface xiii Star formation and stellar evolution: an overview 1 1 A short history

More information

The Virial Theorem for Stars

The Virial Theorem for Stars The Virial Theorem for Stars Stars are excellent examples of systems in virial equilibrium. To see this, let us make two assumptions: 1) Stars are in hydrostatic equilibrium 2) Stars are made up of ideal

More information

Radiative & Magnetohydrodynamic Shocks

Radiative & Magnetohydrodynamic Shocks Chapter 4 Radiative & Magnetohydrodynamic Shocks I have been dealing, so far, with non-radiative shocks. Since, as we have seen, a shock raises the density and temperature of the gas, it is quite likely,

More information

Riemann Solvers and Numerical Methods for Fluid Dynamics

Riemann Solvers and Numerical Methods for Fluid Dynamics Eleuterio R Toro Riemann Solvers and Numerical Methods for Fluid Dynamics A Practical Introduction With 223 Figures Springer Table of Contents Preface V 1. The Equations of Fluid Dynamics 1 1.1 The Euler

More information

MOX EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS. Innsbruck Workshop October

MOX EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS. Innsbruck Workshop October Innsbruck Workshop October 29 21 EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS Luca Bonaventura - Modellistica e Calcolo Scientifico Dipartimento di Matematica

More information

Supernovae. Supernova basics Supernova types Light Curves SN Spectra after explosion Supernova Remnants (SNRs) Collisional Ionization

Supernovae. Supernova basics Supernova types Light Curves SN Spectra after explosion Supernova Remnants (SNRs) Collisional Ionization Supernovae Supernova basics Supernova types Light Curves SN Spectra after explosion Supernova Remnants (SNRs) Collisional Ionization 1 Supernova Basics Supernova (SN) explosions in our Galaxy and others

More information

Stellar evolution Part I of III Star formation

Stellar evolution Part I of III Star formation Stellar evolution Part I of III Star formation The interstellar medium (ISM) The space between the stars is not completely empty, but filled with very dilute gas and dust, producing some of the most beautiful

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

ASTRONOMY QUALIFYING EXAM August Possibly Useful Quantities

ASTRONOMY QUALIFYING EXAM August Possibly Useful Quantities L = 3.9 x 10 33 erg s 1 M = 2 x 10 33 g M bol = 4.74 R = 7 x 10 10 cm 1 A.U. = 1.5 x 10 13 cm 1 pc = 3.26 l.y. = 3.1 x 10 18 cm a = 7.56 x 10 15 erg cm 3 K 4 c= 3.0 x 10 10 cm s 1 σ = ac/4 = 5.7 x 10 5

More information

Plasma Spectroscopy Inferences from Line Emission

Plasma Spectroscopy Inferences from Line Emission Plasma Spectroscopy Inferences from Line Emission Ø From line λ, can determine element, ionization state, and energy levels involved Ø From line shape, can determine bulk and thermal velocity and often

More information

80 2 Observational Cosmology L and the mean energy

80 2 Observational Cosmology L and the mean energy 80 2 Observational Cosmology fluctuations, short-wavelength modes have amplitudes that are suppressed because these modes oscillated as acoustic waves during the radiation epoch whereas the amplitude of

More information

AG Draconis. A high density plasma laboratory. Dr Peter Young Collaborators A.K. Dupree S.J. Kenyon B. Espey T.B.

AG Draconis. A high density plasma laboratory. Dr Peter Young Collaborators A.K. Dupree S.J. Kenyon B. Espey T.B. AG Draconis A high density plasma laboratory Collaborators A.K. Dupree S.J. Kenyon B. Espey T.B. Ake p.r.young@rl.ac.uk Overview CHIANTI database Symbiotic Stars AG Draconis FUSE FUSE observations of AG

More information

Star Formation and Protostars

Star Formation and Protostars Stellar Objects: Star Formation and Protostars 1 Star Formation and Protostars 1 Preliminaries Objects on the way to become stars, but extract energy primarily from gravitational contraction are called

More information

Chapter 9. The Formation and Structure of Stars

Chapter 9. The Formation and Structure of Stars Chapter 9 The Formation and Structure of Stars The Interstellar Medium (ISM) The space between the stars is not completely empty, but filled with very dilute gas and dust, producing some of the most beautiful

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 33 Almost Done! Last

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

More information

Lecture 4: Absorption and emission lines

Lecture 4: Absorption and emission lines Lecture 4: Absorption and emission lines Senior Astrophysics 2018-03-13 Senior Astrophysics () Lecture 4: Absorption and emission lines 2018-03-13 1 / 35 Outline 1 Absorption and emission line spectra

More information

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information

CHAPTER 4. Basics of Fluid Dynamics

CHAPTER 4. Basics of Fluid Dynamics CHAPTER 4 Basics of Fluid Dynamics What is a fluid? A fluid is a substance that can flow, has no fixed shape, and offers little resistance to an external stress In a fluid the constituent particles (atoms,

More information

Joint ICTP-IAEA Workshop on Fusion Plasma Modelling using Atomic and Molecular Data January 2012

Joint ICTP-IAEA Workshop on Fusion Plasma Modelling using Atomic and Molecular Data January 2012 2327-4 Joint ICTP- Workshop on Fusion Plasma Modelling using Atomic and Molecular Data 23-27 January 2012 Atomic Processes Modeling in Plasmas Modeling Spectroscopic Observables from Plasmas Hyun-Kyung

More information

Emitted Spectrum Summary of emission processes Emissivities for emission lines: - Collisionally excited lines - Recombination cascades Emissivities

Emitted Spectrum Summary of emission processes Emissivities for emission lines: - Collisionally excited lines - Recombination cascades Emissivities Emitted Spectrum Summary of emission processes Emissivities for emission lines: - Collisionally excited lines - Recombination cascades Emissivities for continuum processes - recombination - brehmsstrahlung

More information

CS520: numerical ODEs (Ch.2)

CS520: numerical ODEs (Ch.2) .. CS520: numerical ODEs (Ch.2) Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca people.cs.ubc.ca/ ascher/520.html Uri Ascher (UBC) CPSC 520: ODEs (Ch. 2) Fall

More information

The Role of a Strong Far-Infrared Radiation Field in Line Excitation and Cooling of Photodissociation Regions and Molecular Clouds

The Role of a Strong Far-Infrared Radiation Field in Line Excitation and Cooling of Photodissociation Regions and Molecular Clouds J. Astrophys. Astr. (1987) 8, 169 181 The Role of a Strong Far-Infrared Radiation Field in Line Excitation and Cooling of Photodissociation Regions and Molecular Clouds Abdul Qaiyum & S. M. R. Ansari Department

More information

9.1 Introduction. 9.2 Static Models STELLAR MODELS

9.1 Introduction. 9.2 Static Models STELLAR MODELS M. Pettini: Structure and Evolution of Stars Lecture 9 STELLAR MODELS 9.1 Introduction Stars are complex physical systems, but not too complex to be modelled numerically and, with some simplifying assumptions,

More information

(c) (a) 3kT/2. Cascade

(c) (a) 3kT/2. Cascade 1 AY30-HIITemp IV. Temperature of HII Regions A. Motivations B. History In star-forming galaxies, most of the heating + cooling occurs within HII regions Heating occurs via the UV photons from O and B

More information

THIRD-YEAR ASTROPHYSICS

THIRD-YEAR ASTROPHYSICS THIRD-YEAR ASTROPHYSICS Problem Set: Stellar Structure and Evolution (Dr Ph Podsiadlowski, Michaelmas Term 2006) 1 Measuring Stellar Parameters Sirius is a visual binary with a period of 4994 yr Its measured

More information

Astronomy 1504 Section 002 Astronomy 1514 Section 10 Midterm 2, Version 1 October 19, 2012

Astronomy 1504 Section 002 Astronomy 1514 Section 10 Midterm 2, Version 1 October 19, 2012 Astronomy 1504 Section 002 Astronomy 1514 Section 10 Midterm 2, Version 1 October 19, 2012 Choose the answer that best completes the question. Read each problem carefully and read through all the answers.

More information

Atomic Transitions II & Molecular Structure

Atomic Transitions II & Molecular Structure Atomic Transitions II & Molecular Structure Atomic Transitions II Transition Probability Dipole Approximation Line Broadening Transition Probability: The Hamiltonian To calculate explicitly the transition

More information

7. Non-LTE basic concepts

7. Non-LTE basic concepts 7. Non-LTE basic concepts LTE vs NLTE occupation numbers rate equation transition probabilities: collisional and radiative examples: hot stars, A supergiants 10/13/2003 Spring 2016 LTE LTE vs NLTE each

More information

Numerical Methods for Engineers and Scientists

Numerical Methods for Engineers and Scientists Numerical Methods for Engineers and Scientists Second Edition Revised and Expanded Joe D. Hoffman Department of Mechanical Engineering Purdue University West Lafayette, Indiana m MARCEL D E К К E R MARCEL

More information

[Toward] Simulating Cosmological Reionization with Enzo

[Toward] Simulating Cosmological Reionization with Enzo [Toward] Simulating Cosmological Reionization with Enzo Texas Cosmology Network Meeting 2009 29 October 2009 Daniel R. Reynolds M.L. Norman, P. Paschos, G. So [UCSD] J.C. Hayes [LLNL] Sponsor: NSF Astronomy

More information