Flux Limited Diffusion in Enzo

Size: px
Start display at page:

Download "Flux Limited Diffusion in Enzo"

Transcription

1 Flux Limited Diffusion in Enzo Daniel R. Reynolds Department of Mathematics Southern Methodist University Enzo User Workshop, 29 June 2010

2 Reading The slides (Enzo2010 talk1 reynolds.pdf) are on the workshop page, These give a subset of the information from the FLD solver module user guides, located in the enzo-2.0 directories: doc/implicit fld gfldproblem class user guide doc/split fld gfldsplit class user guide In either directory, type make to build the PDF. The implicit solver is described in some detail in the paper D.R. Reynolds, J.C. Hayes, P. Paschos and M.L. Norman, J. Comput. Phys., 228: , 2009.

3 Flux-limited diffusion radiation model We consider cosmological flux-limited diffusion radiative transfer, t E + 1 a (Ev b) = (D E) ȧ a E cκe + η, E(x, t) is the comoving radiation energy density [erg cm 3 ], η(x, t) is the emissivity [erg cm 3 s 1 ], κ(x, t) is the opacity [cm 1 ], The flux-limiter D transitions between streaming and opaque limits, D(E) = diag (D 1 (E), D 2 (E), D 3 (E)), where the directional D i (E) are given by the Larsen n=2 limiter, { } c i E D i (E) =, R (3κ)2 + Ri 2 i (E) = max E, [see Morel 2000; Hayes & Norman 2003; Reynolds, Hayes, Paschos & Norman, 2009]

4 Assumed Radiation Spectrum Frequency-dependence of the radiation field has been integrated out, using an assumed radiation spectrum, χ E (ν): E ν (ν, x, t) = Ẽ(x, t)χ E (ν), E(x, t) ν HI E ν (ν, x, t) dν = Ẽ(x, t) ν HI χ E (ν) dν, Ẽ is an intermediate quantity (for analysis) that is never computed, Choices of χ E (ν) include [monochromatic, power law, blackbody]: ( ) 1.5 ν 8πh ( ν χ E (ν) = δ νhi (ν), χ E (ν) = ν HI, c χe (ν) = ( ). hν exp k b η(x, t) relates to the true emissivity η ν (ν, x, t) via η(x, t) = ν HI η ν (ν, x, t) dν. ) 3

5 Local Thermodynamic Equilibrium Coupling (model 10) For problems without chemistry, we couple E to the specific gas energy, t e + 1 a v b e = 2ȧ a e 1 aρ b (pv b ) 1 a v b φ + G Λ. (1) All but the final two terms are already handled by Enzo s hydrodynamics solvers, so we consider only a correction equation G = cκ ρ b E is the local heating rate, Λ = η ρ b t e c = 2ȧ a e c + G Λ, (2) is the local cooling rate, κ = C 0 ( ρb C 1 ) C2 is the opacity (C0 C 2 are inputs), η = 4κ σ SB T 4 is a black-body emissivity, σ SB is the Stefan-Boltzmann constant, T is the gas temperature.

6 Chemistry-Dependent Coupling (models 1 & 4) Enzo s FLD solvers currently allow hydrogen chemistry, using the model t e c = 2ȧ a e c + G Λ, t n HI + 1 a (n HI v b ) = α rec n e n HII n HI Γ ph HI. n HI is the comoving HI number density [cm 3 ], α rec is the case-b recombination rate, Heating and cooling are computed as G = c n HI ρ b ν HI ( E ν σ ν νhi ) HI ν dν, Λ = ne ρ b [ cehi n HI + ci HI n HI + re HII n HII + brem n HII + m h ρ units a 3 (comp 1 (T comp 2 ) + comp X (T comp T )) ]. The temperature-dependent cooling rates ce HI, ci HI, re HII, brem and comp are all taken from Enzo s built-in rate tables.

7 Chemistry-Dependent Coupling (models 1 & 4) The photo-ionization rate is computed as Γ ph HI = c ν HI E ν σ HI hν dν. The frequency-integrated opacity is now chemistry-dependent, [ ] / [ ] κ = n HI E ν σ HI dν E ν dν, ν HI where all simplify to integrals with χ E (computed at startup). The difference between models 1 and 4 is: Model 1 implements all of the above terms, Model 4 assumes an isothermal gas. ν HI

8 Enzo Operator-Split Numerics We discretize space with a finite volume approach, and evolve the coupled system in an operator-split framework, solving one component at a time: (i) FLD system, (ii) Gravity, (iii) Hydrodynamics (also advects n HI and E), (iv) Dark-matter, star particles, etc. The FLD system is evolved using either: gfldproblem fully-implicit reaction-diffusion PDE system to evolve (E, e c, n HI ), or gfldsplit separate implicit steps evolve E and then {e c, n HI }.

9 Split Solver Radiation Subsystem We discretize t E in time using a two-level θ-method: E n E n 1 θ t ( (D E n ) ȧ a E n cκe n + η ) (1 θ) t ( (D E n 1) ȧ a E n 1 cκe n 1 + η ) = 0, The input parameter 0 θ 1 defines the time-discretization: θ = 1 gives implicit Euler [O( t)-accurate], θ = 0.5 gives trapezoidal [O( t 2 )-accurate]. For θ > 0 this equation is linearly implicit in s = E n E n 1. We approximately solve this linear system Js = b to a tolerance δ, Js b 2 δ, using a scalable, multigrid-preconditioned, CG iteration [HYPRE].

10 Split Solver Chemistry & Gas Subsystem We solve {ec n, n n HI } using an implicit version of the quasi-steady-state approximation, where we freeze inter-variable couplings and solve each ODE exactly. Writing these analytical solvers as e n c = sol e ( E, e n 1 c, n HI, t ), n n HI = sol HI ( E, e, n n 1 HI, t ), we couple these implicitly through defining the nonlinear equations ( ) f e (e c, n HI ) = ec n E sol n 1 +E n e 2, ec n 1, nn 1 HI +n n HI 2, t = 0, ( ) f HI (e c, n HI ) = n n E HI sol n 1 +E n HI 2, en 1 +e n 2, n n 1 HI, t = 0, and solve this nonlinear system using a robust fixed-point iteration.

11 Adaptive Time Step Selection We estimate the time error in a variable u as ( 1 N ( u n err = i u n 1 )p ) 1/p i N ω i i=1 where ω i = { u n i un 1 i , e i The input p defines the norm. An input tolerance τ i,tol then defines t n i = (τ i,tol /err) t n 1, i {E, e, HI }. Since evolved separately, {e c, n HI } may subcycle faster than E. Users may override t E & t e,hi with the inputs t max & t min. All physics modules will limit their step to t min{ t E, t CFL }.

12 Variable Rescaling The solvers and time step controls work best when the internal values of {E, e c, n HI } are properly normalized. If Enzo s DensityUnits, LengthUnits and TimeUnits are insufficient, the user may input additional variable scaling factors for use in the solver: RadiationScaling sets the value s E, EnergyCorrectionScaling sets the value s e, ChemistryScaling sets the value s n. These are used to rescale {E, e c, n HI } to solver variables {Ẽ, ẽ c, ñ HI }: Ẽ = E s E, ẽ c = e c s e, ñ HI = n HI s n.

13 Radiation Boundary Conditions We currently allow 3 boundary condition types for E: 0. Periodic, 1. Dirichlet, i.e. E(x, t) = g(x), x Ω, and 2. Neumann, i.e. E(x, t) n = g(x), x Ω. Notes: In most cases, the BC types (and g) are problem-dependent. If left unspecified, these default to periodic. If a non-periodic type is set but values are not, we use g = 0. When adding new FLD problems, custom conditions should be set in gfldsplit Initialize.C or gfldproblem Initialize.C.

14 Build Configuration To use any FLD solver module, Enzo must be configured with: gmake photon-yes gmake hypre-yes gmake use-mpi-yes [enables all radiation solvers] [enables HYPRE solver interface] [enables MPI] Moreover, the machine Makefile must specify how to include and link with an available HYPRE library (version 2.4.0b). If you must compile HYPRE yourself, use the configuration option --with-no-global-partition for runs using over 1000 tasks. Optional/recommended Enzo configuration options include: gmake emissivity-yes [enables coupling with star-maker] gmake precision-64 [the solvers prefer double precision]

15 Startup Parameters The main problem parameter file must have the following parameters: RadiativeTransferFLD [0] this must be 2. ImplicitProblem [0] use 3 for gfldsplit, 1 for gfldproblem. ProblemType [0] FLD-based solvers use values in the 400 s. RadHydroParamfile [NULL] the filename containing all FLD-specific solver parameters (next slide). RadiativeTransferOpticallyThinH2 [1] this must be 0. RadiationFieldType [0] can be any value except 10 or 11. RadiativeTransferFLDCallOnLevel [0] must currently be 0. RadiativeTransfer [0] this must be be 0. RadiativeCooling [0] must currently be 0.

16 FLD Solver Parameters (separate input file) The following parameters control various aspects of gfldsplit: RadHydroESpectrum [1] form for radiation spectrum χ E (ν): -1. is monochromatic at hν = 13.6 ev, 0. is power law, 1. is T = 10 5 blackbody. RadHydroChemistry [1] controls whether to use n HI (1 yes, 0 no) RadHydroHFraction [1] controls the fraction of baryonic matter comprised of Hydrogen (RadHydroHFraction [0, 1]). RadHydroModel [1] determines which model for radiation-matter coupling we wish to use: 1. Chemistry-dependent model with case B recombination coeff. 4. Same as model 1, with an isothermal gas energy. 10. Local thermodynamic equilibrium model (no n HI ).

17 FLD Solver Parameters continued RadHydroMaxDt [10 20 ] sets t max in scaled time units. RadHydroMinDt [0] sets t min in scaled time units. RadHydroInitDt [10 20 ] sets the initial t E in scaled time units. RadHydroDtNorm [2] sets p in computing the time error estimate. RadHydroDtRadFac, RadHydroDtGasFac, RadHydroDtChemFac [10 20 ] the values of τ i,tol in computing t E, t e and t HI. RadiationScaling, EnergyCorrectionScaling, ChemistryScaling [1.0] the scaling factors s E, s e and s n. RadHydroTheta [1.0] the t E discretization parameter, θ. RadHydroSolTolerance [10 8 ] linear solver tolerance δ.

18 FLD Solver Parameters continued RadiationBoundaryX0Faces, RadiationBoundaryX1Faces, RadiationBoundaryX2Faces [0 0] BC types at each face: 0. periodic (must match on both faces in a given direction) 1. Dirichlet 2. Neumann EnergyOpacityC0-EnergyOpacityC2 [1, 1, 0] the opacity-defining constants C 0 -C 2 for the LTE model. RadHydroMaxMGIters [50] max number of MG-CG iterations. RadHydroMGRelaxType [1] - the MG relaxation method: 0. Jacobi 1. Weighted Jacobi 2. Red/Black Gauss-Seidel (symmetric) 3. Red/Black Gauss-Seidel (nonsymmetric) RadHydroMGPreRelax [1] number of pre-relaxation MG sweeps. RadHydroMGPostRelax [1] number of post-relaxation MG sweeps.

19 Customization To set up a new FLD problem: Allocate a baryon field with FieldType set to RadiationFreq0. Set η(x, t) by either: Edit gfldsplit RadiationSource.src90 or gfldproblem RadiationSource.src90, Fill in the baryon field Emissivity0, and edit logic in gfldsplit Evolve.C or gfldproblem Evolve.C to use that field (emulate logic for StarMakerEmissivityField). Edit gfldsplit Initialize.C or gfldproblem Initialize.C to call the problem initializer and set BCs. All other requirements for setting up a new ProblemType in Enzo are like normal (InitializeNew.C, problem initialization files, etc.).

20 Iliev Test 5 Example Dynamic I-front Expansion [on Triton: /home/enzo-1/ilievetal5] Dynamic ionization test of an initially-neutral hydrogen region: Box size L = 15 kpc; Run time T f = 500 Myr. T = 10 5 blackbody spectrum, at rate Ṅγ = photon/s. Initial conditions: n = 10 3 cm 3, T = 100 K, E = No available analytical solution, but: erg cm 3. Front transitions from R- to D-type as it reaches Strömgren radius, r R I = r S [ 1 e tα B (T i )n H ] 1/3, r D I = r S [1 + (7c s t)/(4r S )] 4/7, Eventually stalls at r f = r S ( 2Ti T e ) 2/3, where Ti and T e are the temperatures behind and ahead of the I-front. [Whalen & Norman, ApJS, 2006; Iliev et al., MNRAS, 2009]

21 Hydrodynamic Radiative Ionization Results 2.5 Convergence in I front Position 16 3 mesh 4.5 Temperature profile, t = 175 Myr 32 3 mesh mesh mesh NW: I-front position history r I /r S log(t) NE: T profile (175 Myr) r I r I * /rs t/t rec Error in I front Position 16 3 mesh 32 3 mesh 64 3 mesh t/t rec SW: r I conv. wrt x SE: T convergence wrt t relative error r/l box e 4 2e 4 1e 4 5e 5 2e 5 1e 5 Temperature error profile, t = 175 Myr r/l box

22 Shapiro & Giroux [Isothermal, Static Cosmic Ionization] [in enzo-2.0: run/radiationtransportfld/sg q5z4 sp] Repeat of previous test, but in a cosmologically expanding universe, with a static, isothermal gas, using a monochromatic radiation spectrum. Four tests: q 0 z i L i [kpc] ρ b,i [g cm 3 ] H 0 Ω m Ω Λ Ω b e e e e Analytical solution given by r I (t) = r S,i ( 1/3 a(t) λe τ(t) e τ(b) [1 2q 0 + 2q 0 (1 + z i )/b] db) 1/2, τ(a) = λ [F (a) F (1)] [ 6q 2 0(1 + z i ) 2] 1, F (a) = [ 2 4q 0 2q 0 1+z i a 1 ] [ 1 2q0 + 2q 0 1+z i a α λ = B n H,i ] 1/2. H 0(1+z i ), [Shapiro & Giroux, ApJ, 1987]

23 Cosmological Ionization Results r i (t)/r s (t) vs redshift q0=0.5, z0=4 q0=0.05, z0=4 q0=0.5, z0=10 q0=0.05, z0=10 NW: I-front radii vs scaled z Error in r 11 x i (t)/r s (t) vs scaled redshift, q 0 = 0.5, z 0 = mesh mesh 64 3 mesh 9 8 r/r s NE: I-front error vs scaled z (r true r)/r s r/r s log[(1+z)/(1+z i )] r i (t)/r s (t) vs redshift, z i =4 q0=0.5 (computed) q0=0.5 (analytic) q0=0.05 (computed) q0=0.05 (analytic) log[(1+z)/(1+z )] i SW: I-front radii for z i = 4. SE: Weak CPU scaling (N src N CPU ) NICS: O(N log N) scaling Average wall time / step (s) log[(1+z)/(1+z 0 )] Cosmology Weak Scaling (Kraken): Tavg vs Cores Cores

24 Reionization Simulations (FLD + StarMaker) [in enzo-2.0: run/radiationtransportfld/cosmologyfld RT] Geoffrey So has constructed an interface to StarMaker to seed η(x, t): Requires Enzo configuration with EMISSIVITY enabled, Adds StarMakerEmissivityField=1 to main parameter file, The interface fills the Emissivity0 baryon field based on emission from star particles; the FLD modules copy this field into η(x, t). Utilizes identical startup machinery as typical cosmology runs, via CosmologySimulationInitialize.C [ProblemType 30], with additional input file options to enable the FLD solver module.

25 Model Solution Approach Configuration Non-Cosmological Problems Cosmological Problems Reionization Simulations (FLD + StarMaker) ρ E xhi End

26 Summary of Current Results The gfldsplit and gfldproblem solver modules implement a grey, field-based, flux-limited diffusion radiation approximation for unigrid runs: Implicit MG-CG solvers enable scalable solution on many thousands of cores, independently of the number of ionization sources. Accurately solves couplings between radiation, ionization and gas energy, due to implicit formulation and coupled solvers. Split and implicit formulations allow for tradeoffs between robustness/efficiency and accuracy. However, this approximation has its shortcomings: Single radiation field allows full absorption by hydrogen, even though higher-frequency radiation should pass through. Though better than simpler approximations, grey approach cannot accurately handle multi-species problems (hence H-only restriction). Currently limited to unigrid Enzo simulations.

27 Continuing Work Extending radiation approximation to multi-frequency case, E E ν : New interpolation of ν-space, based off of [Gnedin & Abel, 2001; Ricotti et al., 2002], in collaboration with Pascal Paschos. Approach is designed to characterize underlying radiation spectrum for cosmology problems, with a minimal amount of extra overhead. Extending grey FLD solvers to AMR grids: HYPRE-FAC gravity solver already completed by James Bordner. Radiation solver will piggyback off of self-gravity developments. Extending gfldsplit to allow He, molecular gases, metal chemistry.

28 Acknowledgements We gratefully acknowledge support by NSF AAG program and point out contributions by collaborators Michael Norman, UCSD John Hayes, LLNL (B-Division) Pascal Paschos, UCSD Geoffrey So, UCSD

[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

Scalable Radiation-Induced Chemical Ionization Simulating Cosmological Reionization

Scalable Radiation-Induced Chemical Ionization Simulating Cosmological Reionization Scalable Radiation-Induced Chemical Ionization Simulating Cosmological Reionization Daniel R. Reynolds reynolds@smu.edu Department of Mathematics Southern Methodist University KAUST Seminar, March 2011

More information

Cosmological Radiation Hydrodynamics with Enzo

Cosmological Radiation Hydrodynamics with Enzo Cosmological Radiation Hydrodynamics with Enzo Michael L. Norman,, Daniel R. Reynolds and Geoffrey C. So Physics Department, U.C. San Diego, La Jolla, CA 92093 Ctr. for Astrophysics and Space Sciences,

More information

Black Hole Formation in the Early Universe

Black Hole Formation in the Early Universe 1 Black Hole Formation in the Early Universe Luo Yang (Osaka University) XC30 2 1. Introduction Observations of high-redshift quasars reveal that some supermassive black holes (SMBH) with masses exceeding

More information

Radiative Transfer in a Clumpy Universe: the UVB. Piero Madau UC Santa Cruz

Radiative Transfer in a Clumpy Universe: the UVB. Piero Madau UC Santa Cruz Radiative Transfer in a Clumpy Universe: the UVB Piero Madau UC Santa Cruz The cosmic UVB originates from the integrated emission of starforming galaxies and QSOs. It determines the thermal and ionization

More information

II. HII Regions (Ionization State)

II. HII Regions (Ionization State) 1 AY230-HIIReg II. HII Regions (Ionization State) A. Motivations Theoretical: HII regions are intamitely linked with past, current and future starforming regions in galaxies. To build theories of star-formation

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

Advanced Cosmological Simulations

Advanced Cosmological Simulations Advanced Cosmological Simulations John Wise (Georgia Tech) Enzo Workshop 19 Oct 2013 1 Outline We will consider additional physics in Thursday s AMR (no nested grids) cosmology simulation. Refresher on

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

Interstellar Medium Physics

Interstellar Medium Physics Physics of gas in galaxies. Two main parts: atomic processes & hydrodynamic processes. Atomic processes deal mainly with radiation Hydrodynamics is large scale dynamics of gas. Start small Radiative transfer

More information

FORMATION OF PRIMORDIAL STARS

FORMATION OF PRIMORDIAL STARS Talk@INT, UW, July 5, 2006 FORMATION OF PRIMORDIAL STARS Naoki Yoshida Department of Physics Nagoya University Outline Thermal evolution of a primordial gas - Physics at high densities (cooling, chem.

More information

Cosmology Simulations with Enzo

Cosmology Simulations with Enzo Cosmology Simulations with Enzo John Wise (Georgia Tech) Enzo Workshop 17 May 2012 Outline Based on the simulation setup of Abel, Wise, & Bryan (2007), The HII Region of a Primordial Star Introduction

More information

Opacity and Optical Depth

Opacity and Optical Depth Opacity and Optical Depth Absorption dominated intensity change can be written as di λ = κ λ ρ I λ ds with κ λ the absorption coefficient, or opacity The initial intensity I λ 0 of a light beam will be

More information

Radiation-hydrodynamics from Mpc to sub-pc scales with RAMSES-RT

Radiation-hydrodynamics from Mpc to sub-pc scales with RAMSES-RT Radiation-hydrodynamics from Mpc to sub-pc scales with RAMSES-RT Joki Rosdahl Centre de Recherche Astrophysique de Lyon With Aubert, Blaizot, Bieri, Biernacki, Commercon, Costa, Dubois, Geen, Katz, Kimm,

More information

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.

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. 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

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Core Collapse Supernovae An Emerging Picture Stephen W. Bruenn

Core Collapse Supernovae An Emerging Picture Stephen W. Bruenn Core Collapse Supernovae An Emerging Picture Stephen W. Bruenn 19th Rencontres de Blois Matter and Energy in the Universe: from nucleosynthesis to cosmology Collaborators Anthony Mezzacappa John M. Blondin

More information

HII regions. Massive (hot) stars produce large numbers of ionizing photons (energy above 13.6 ev) which ionize hydrogen in the vicinity.

HII regions. Massive (hot) stars produce large numbers of ionizing photons (energy above 13.6 ev) which ionize hydrogen in the vicinity. HII regions Massive (hot) stars produce large numbers of ionizing photons (energy above 13.6 ev) which ionize hydrogen in the vicinity. Detailed nebular structure depends on density distribution of surrounding

More information

The Stellar Opacity. F ν = D U = 1 3 vl n = 1 3. and that, when integrated over all energies,

The Stellar Opacity. F ν = D U = 1 3 vl n = 1 3. and that, when integrated over all energies, The Stellar Opacity The mean absorption coefficient, κ, is not a constant; it is dependent on frequency, and is therefore frequently written as κ ν. Inside a star, several different sources of opacity

More information

Lecture 27 The Intergalactic Medium

Lecture 27 The Intergalactic Medium Lecture 27 The Intergalactic Medium 1. Cosmological Scenario 2. The Ly Forest 3. Ionization of the Forest 4. The Gunn-Peterson Effect 5. Comment on HeII Reionization References J Miralda-Escude, Science

More information

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

Preliminary Examination: Astronomy

Preliminary Examination: Astronomy Preliminary Examination: Astronomy Department of Physics and Astronomy University of New Mexico Spring 2017 Instructions: Answer 8 of the 10 questions (10 points each) Total time for the test is three

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

New Multigrid Solver Advances in TOPS

New Multigrid Solver Advances in TOPS New Multigrid Solver Advances in TOPS R D Falgout 1, J Brannick 2, M Brezina 2, T Manteuffel 2 and S McCormick 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, P.O.

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

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

6. Cosmology. (same at all points) probably true on a sufficiently large scale. The present. ~ c. ~ h Mpc (6.1)

6. Cosmology. (same at all points) probably true on a sufficiently large scale. The present. ~ c. ~ h Mpc (6.1) 6. 6. Cosmology 6. Cosmological Principle Assume Universe is isotropic (same in all directions) and homogeneous (same at all points) probably true on a sufficiently large scale. The present Universe has

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

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

AST242 LECTURE NOTES PART 7

AST242 LECTURE NOTES PART 7 AST242 LECTURE NOTES PART 7 Contents 1. HII regions and Ionization Fronts 1 1.1. The Strömgren Sphere 2 1.2. Early Evolution 3 1.3. Achieving Pressure equilibrium 3 1.4. Jump conditions on an ionization

More information

TRANSFER OF RADIATION

TRANSFER OF RADIATION TRANSFER OF RADIATION Under LTE Local Thermodynamic Equilibrium) condition radiation has a Planck black body) distribution. Radiation energy density is given as U r,ν = 8πh c 3 ν 3, LTE), tr.1) e hν/kt

More information

The first stars and primordial IMBHs

The first stars and primordial IMBHs The first stars and primordial IMBHs Ab initio predictions of black hole merger rates by the time LISA flies? Tom Abel Penn State Initial Conditions Time Evolution z=100 z=24 z=20.4 10 comoving kpc Cosmological

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

Astrochemistry. Lecture 10, Primordial chemistry. Jorma Harju. Department of Physics. Friday, April 5, 2013, 12:15-13:45, Lecture room D117

Astrochemistry. Lecture 10, Primordial chemistry. Jorma Harju. Department of Physics. Friday, April 5, 2013, 12:15-13:45, Lecture room D117 Astrochemistry Lecture 10, Primordial chemistry Jorma Harju Department of Physics Friday, April 5, 2013, 12:15-13:45, Lecture room D117 The first atoms (1) SBBN (Standard Big Bang Nucleosynthesis): elements

More information

Journal of Computational Physics

Journal of Computational Physics Journal of Computational Physics 228 (29) 6833 6854 Contents lists available at ScienceDirect Journal of Computational Physics journal homepage: www.elsevier.com/locate/jcp Self-consistent solution of

More information

Reionization constraints post Planck-15

Reionization constraints post Planck-15 Reionization constraints post Planck-15 Tirthankar Roy Choudhury National Centre for Radio Astrophysics Tata Institute of Fundamental Research Pune CMB Spectral Distortions from Cosmic Baryon Evolution

More information

An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations

An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations Institute of Applied Physics and Computational Mathematics, Beijing NUS, Singapore, March 2-6, 2015 (joint

More information

1. Why photons? 2. Photons in a vacuum

1. Why photons? 2. Photons in a vacuum Photons and Other Messengers 1. Why photons? Ask class: most of our information about the universe comes from photons. What are the reasons for this? Let s compare them with other possible messengers,

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

Numerically Solving Partial Differential Equations

Numerically Solving Partial Differential Equations Numerically Solving Partial Differential Equations Michael Lavell Department of Applied Mathematics and Statistics Abstract The physics describing the fundamental principles of fluid dynamics can be written

More information

Drift-Diffusion Simulation of the Ephaptic Effect in the Triad Synapse of the Retina

Drift-Diffusion Simulation of the Ephaptic Effect in the Triad Synapse of the Retina Drift-Diffusion Simulation of the Ephaptic Effect in the Triad Synapse of the Retina Jeremiah Jones PhD Thesis Defense, Applied Mathematics SCHOOL OF MATHEMATICAL AND STATISTICAL SCIENCES April 5, 2013

More information

(c) Sketch the ratio of electron to gas pressure for main sequence stars versus effective temperature. [1.5]

(c) Sketch the ratio of electron to gas pressure for main sequence stars versus effective temperature. [1.5] 1. (a) The Saha equation may be written in the form N + n e N = C u+ u T 3/2 exp ( ) χ kt where C = 4.83 1 21 m 3. Discuss its importance in the study of stellar atmospheres. Carefully explain the meaning

More information

The improvement of START

The improvement of START The improvement of START Kenji Hasegawa (U. Tsukuba, CCS Kobe branch) Takashi Okamoto (U. Tsukuba, CCS Kobe branch) Cosmological Radiative Transfer Comparison Project Workshop IV @ Austin, Texas, Dec 11-14,

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

Cosmic Dawn (CoDa): Radiation-hydrodynamics of galaxy formation during the EoR

Cosmic Dawn (CoDa): Radiation-hydrodynamics of galaxy formation during the EoR Cosmic Dawn (CoDa): Radiation-hydrodynamics of galaxy formation during the EoR Ocvirk+2015: arxiv:1511.00011 P. Ocvirk Observatoire astronomique de Strasbourg Universite de Strasbourg D. Aubert, N. Gillet,

More information

Research Statement Daniel R. Reynolds

Research Statement Daniel R. Reynolds Research Statement Daniel R. Reynolds My research is in applied mathematics, specifically the sub-disciplines of scientific computation and numerical analysis. In the ever-evolving field of scientific

More information

If light travels past a system faster than the time scale for which the system evolves then t I ν = 0 and we have then

If light travels past a system faster than the time scale for which the system evolves then t I ν = 0 and we have then 6 LECTURE 2 Equation of Radiative Transfer Condition that I ν is constant along rays means that di ν /dt = 0 = t I ν + ck I ν, (29) where ck = di ν /ds is the ray-path derivative. This is equation is the

More information

Probing dark matter and the physical state of the IGM with the Lyα forest

Probing dark matter and the physical state of the IGM with the Lyα forest Probing dark matter and the physical state of the IGM with the Lyα forest Martin Haehnelt in collaboration with: George Becker, James Bolton, Jonathan Chardin, Laura Keating, Ewald Puchwein, Debora Sijacki,

More information

Effects of Massive Stars

Effects of Massive Stars Effects of Massive Stars Classical HII Regions Ultracompact HII Regions Stahler Palla: Sections 15.1, 15. HII Regions The salient characteristic of any massive star is its extreme energy output, much of

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 1 Equilibrium: LTE vs NLTE LTE each volume

More information

CMFGEN. Associate every atomic species with a given identification number

CMFGEN. Associate every atomic species with a given identification number CMFGEN Associate every atomic species with a given identification number For each species, set: atomic mass atomic number solar abundance species abbreviations species identification Read in MODEL_SPEC

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

Brief Introduction to Cosmology

Brief Introduction to Cosmology Brief Introduction to Cosmology Matias Zaldarriaga Harvard University August 2006 Basic Questions in Cosmology: How does the Universe evolve? What is the universe made off? How is matter distributed? How

More information

Protostars 1. Early growth and collapse. First core and main accretion phase

Protostars 1. Early growth and collapse. First core and main accretion phase Protostars 1. First core and main accretion phase Stahler & Palla: Chapter 11.1 & 8.4.1 & Appendices F & G Early growth and collapse In a magnetized cloud undergoing contraction, the density gradually

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

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

Baryon Acoustic Oscillations in the Lyman Alpha Forest

Baryon Acoustic Oscillations in the Lyman Alpha Forest Baryon Acoustic Oscillations in the Lyman Alpha Forest Michael L. Norman, Pascal Paschos & Robert Harkness Laboratory for Computational Astrophysics, SERF 0424, University of California San Diego, 9500

More information

Some HI is in reasonably well defined clouds. Motions inside the cloud, and motion of the cloud will broaden and shift the observed lines!

Some HI is in reasonably well defined clouds. Motions inside the cloud, and motion of the cloud will broaden and shift the observed lines! Some HI is in reasonably well defined clouds. Motions inside the cloud, and motion of the cloud will broaden and shift the observed lines Idealized 21cm spectra Example observed 21cm spectra HI densities

More information

Stellar Atmospheres. University of Denver, Department of Physics and Astronomy. Physics 2052 Stellar Physics, Winter 2008.

Stellar Atmospheres. University of Denver, Department of Physics and Astronomy. Physics 2052 Stellar Physics, Winter 2008. Stellar Atmospheres University of Denver, Department of Physics and Astronomy Physics 2052 Stellar Physics, Winter 2008 By Kathy Geise Introduction A star does not have a solid surface, so the definition

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

Outline. Walls, Filaments, Voids. Cosmic epochs. Jeans length I. Jeans length II. Cosmology AS7009, 2008 Lecture 10. λ =

Outline. Walls, Filaments, Voids. Cosmic epochs. Jeans length I. Jeans length II. Cosmology AS7009, 2008 Lecture 10. λ = Cosmology AS7009, 2008 Lecture 10 Outline Structure formation Jeans length, Jeans mass Structure formation with and without dark matter Cold versus hot dark matter Dissipation The matter power spectrum

More information

THE ROLE OF RADIATION PRESSURE IN HIGH-Z DWARF GALAXIES

THE ROLE OF RADIATION PRESSURE IN HIGH-Z DWARF GALAXIES THE ROLE OF RADIATION PRESSURE IN HIGH-Z DWARF GALAXIES John Wise (Georgia Tech) Tom Abel (Stanford), Michael Norman (UC San Diego), Britton Smith (Michigan State), Matthew Turk (Columbia) 14 Dec 2012

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

P M 2 R 4. (3) To determine the luminosity, we now turn to the radiative diffusion equation,

P M 2 R 4. (3) To determine the luminosity, we now turn to the radiative diffusion equation, Astronomy 715 Final Exam Solutions Question 1 (i). The equation of hydrostatic equilibrium is dp dr GM r r 2 ρ. (1) This corresponds to the scaling P M R ρ, (2) R2 where P and rho represent the central

More information

Physics Oct A Quantum Harmonic Oscillator

Physics Oct A Quantum Harmonic Oscillator Physics 301 5-Oct-2005 9-1 A Quantum Harmonic Oscillator The quantum harmonic oscillator (the only kind there is, really) has energy levels given by E n = (n + 1/2) hω, where n 0 is an integer and the

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

Problem Set 2 Solutions

Problem Set 2 Solutions Problem Set 2 Solutions Problem 1: A A hot blackbody will emit more photons per unit time per unit surface area than a cold blackbody. It does not, however, necessarily need to have a higher luminosity,

More information

Addition of Opacities and Absorption

Addition of Opacities and Absorption Addition of Opacities and Absorption If the only way photons could interact was via simple scattering, there would be no blackbodies. We ll go into that in much more detail in the next lecture, but the

More information

Lecture III: The Thermal History

Lecture III: The Thermal History Lecture III: The Thermal History EPFL & CERN London, 14.05.2014 Thermal history treated by the module thermodynamics.c. So this lecture will refer mainly to the content of input/thermodynamics.h, source/thermodynamics.c,

More information

ARIZONA STATE UNIVERSITY TEMPE, ARIZONA Obtaining a Cold IGM through Modification of the Residual Ionization Fraction Following Recombination

ARIZONA STATE UNIVERSITY TEMPE, ARIZONA Obtaining a Cold IGM through Modification of the Residual Ionization Fraction Following Recombination ARIZONA STATE UNIVERSITY TEMPE, ARIZONA 85287 LOCO EDGES REPORT #098 Obtaining a Cold IGM through Modification of the Residual Ionization Fraction Following Recombination Judd Bowman July 16, 2017 1. Calculation

More information

II. The Universe Around Us. ASTR378 Cosmology : II. The Universe Around Us 23

II. The Universe Around Us. ASTR378 Cosmology : II. The Universe Around Us 23 II. The Universe Around Us ASTR378 Cosmology : II. The Universe Around Us 23 Some Units Used in Astronomy 1 parsec distance at which parallax angle is 1 ; 1 pc = 3.086 10 16 m ( 3.26 light years; 1 kpc

More information

Problem Set 5 - Solution

Problem Set 5 - Solution Problem Set 5 - Solution E.S. Phinney, and J. Sebastian Pineda March 4, 212 1. a) We consider a source at rest in comoving coordinates at redshift z = a(t )/a(t e ) 1. We want to find out how this redshift

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

Cosmology. Thermal history of the universe Primordial nucleosynthesis WIMPs as dark matter Recombination Horizon problem Flatness problem Inflation

Cosmology. Thermal history of the universe Primordial nucleosynthesis WIMPs as dark matter Recombination Horizon problem Flatness problem Inflation Cosmology Thermal history of the universe Primordial nucleosynthesis WIMPs as dark matter Recombination Horizon problem Flatness problem Inflation Energy density versus scale factor z=1/a-1 Early times,

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

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

Diffuse Interstellar Medium

Diffuse Interstellar Medium Diffuse Interstellar Medium Basics, velocity widths H I 21-cm radiation (emission) Interstellar absorption lines Radiative transfer Resolved Lines, column densities Unresolved lines, curve of growth Abundances,

More information

1/30/11. Astro 300B: Jan. 26, Thermal radia+on and Thermal Equilibrium. Thermal Radia0on, and Thermodynamic Equilibrium

1/30/11. Astro 300B: Jan. 26, Thermal radia+on and Thermal Equilibrium. Thermal Radia0on, and Thermodynamic Equilibrium Astro 300B: Jan. 26, 2011 Thermal radia+on and Thermal Equilibrium Thermal Radia0on, and Thermodynamic Equilibrium 1 Thermal radiation is radiation emitted by matter in thermodynamic equilibrium. When

More information

The Black Body Radiation

The Black Body Radiation The Black Body Radiation = Chapter 4 of Kittel and Kroemer The Planck distribution Derivation Black Body Radiation Cosmic Microwave Background The genius of Max Planck Other derivations Stefan Boltzmann

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

Numerical Models of the high-z Universe

Numerical Models of the high-z Universe Texte Numerical Models of the high-z Universe Dominique AUBERT Observatoire Astronomique, Université de Strasbourg EOR Robertson et al. 2010 Epoch of Reionization ~200 Myrs - 1Gyr z~30-6! Challenge : Multiple

More information

Chandra-HETGS Observations of LMC X-1. Michael Nowak, Ron Remillard, Norbert Schulz (MIT-Kavli) & Jörn Wilms (University of Bamberg)

Chandra-HETGS Observations of LMC X-1. Michael Nowak, Ron Remillard, Norbert Schulz (MIT-Kavli) & Jörn Wilms (University of Bamberg) Chandra-HETGS Observations of LMC X-1 Michael Nowak, Ron Remillard, Norbert Schulz (MIT-Kavli) & Jörn Wilms (University of Bamberg) One of the few persistent BHC HMXB: Focused Wind-Fed Soft X-ray Dominated

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

Why is the Universe Expanding?

Why is the Universe Expanding? Why is the Universe Expanding? In general relativity, mass warps space. Warped space makes matter move, which changes the structure of space. Thus the universe should be dynamic! Gravity tries to collapse

More information

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

More information

ASTR-1010: Astronomy I Course Notes Section IV

ASTR-1010: Astronomy I Course Notes Section IV ASTR-1010: Astronomy I Course Notes Section IV Dr. Donald G. Luttermoser Department of Physics and Astronomy East Tennessee State University Edition 2.0 Abstract These class notes are designed for use

More information

Cosmology: Building the Universe.

Cosmology: Building the Universe. Cosmology: Building the Universe. The term has several different meanings. We are interested in physical cosmology - the study of the origin and development of the physical universe, and all the structure

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Multi-scale and multi-physics numerical models of galaxy formation

Multi-scale and multi-physics numerical models of galaxy formation Multi-scale and multi-physics numerical models of galaxy formation M. Rieder and RT, 2016, MNRAS, 457, 1722 J. Rosdahl, J. Schaye, RT and O. Agertz, 2015, MNRAS, 451, 34 RAMSES: parallel Adaptive Mesh

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

(Numerical) study of the collapse and of the fragmentation of prestellar dense core

(Numerical) study of the collapse and of the fragmentation of prestellar dense core (Numerical) study of the collapse and of the fragmentation of prestellar dense core Benoît Commerçon Supervisors: E. Audit, G. Chabrier and P. Hennebelle Collaborator: R. Teyssier (3D - AMR) CEA/DSM/IRFU/SAp

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

Thermodynamics in Cosmology Nucleosynthesis

Thermodynamics in Cosmology Nucleosynthesis Thermodynamics in Cosmology Nucleosynthesis Thermodynamics Expansion Evolution of temperature Freeze out Nucleosynthesis Production of the light elements Potential barrier Primordial synthesis calculations

More information

Lya as a Probe of the (High-z) Universe

Lya as a Probe of the (High-z) Universe Lya as a Probe of the (High-z) Universe Mark Dijkstra (CfA) Main Collaborators: Adam Lidz, Avi Loeb (CfA) Stuart Wyithe (Melbourne), Zoltan Haiman (Columbia) Lya as a Probe of the (High-z) Universe Outline

More information

Introduction and Fundamental Observations

Introduction and Fundamental Observations Notes for Cosmology course, fall 2005 Introduction and Fundamental Observations Prelude Cosmology is the study of the universe taken as a whole ruthless simplification necessary (e.g. homogeneity)! Cosmology

More information

Components of Galaxies Gas The Importance of Gas

Components of Galaxies Gas The Importance of Gas Components of Galaxies Gas The Importance of Gas Fuel for star formation (H 2 ) Tracer of galaxy kinematics/mass (HI) Tracer of dynamical history of interaction between galaxies (HI) The Two-Level Atom

More information

Radiation hydrodynamics of tin targets for laser-plasma EUV sources

Radiation hydrodynamics of tin targets for laser-plasma EUV sources Radiation hydrodynamics of tin targets for laser-plasma EUV sources M. M. Basko, V. G. Novikov, A. S. Grushin Keldysh Institute of Applied Mathematics, Moscow, Russia RnD-ISAN, Troitsk, Moscow, Russia

More information

The Pop III IMF: A Progress Report. Michael L. Norman University of California, San Diego & San Diego Supercomputer Center

The Pop III IMF: A Progress Report. Michael L. Norman University of California, San Diego & San Diego Supercomputer Center The Pop III IMF: A Progress Report Michael L. Norman University of California, San Diego & San Diego Supercomputer Center Disclaimer Notion of Pop III IMF is not well-defined We don t observe Pop III stars

More information