class Workshop CANTATA Summer School

Size: px
Start display at page:

Download "class Workshop CANTATA Summer School"

Transcription

1 class Workshop CANTATA Summer School Thomas Tram Aarhus University (Denmark) 12/9/2017 Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

2 Programme Programme of the class workshop 12/9 Overview of class and its Python wrapper. Compute and plot output. 13/9 Modifying class. The hiclass extension and exercises on modified gravity. 14/9 Cosmological parameter extraction using MontePython. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

3 Programme Programme of the class workshop 12/9 Overview of class and its Python wrapper. Compute and plot output. 13/9 Modifying class. The hiclass extension and exercises on modified gravity. 14/9 Cosmological parameter extraction using MontePython. Today Overview of class Installing software and starting exercises Coffee break Exercises. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

4 What is CLASS? An Einstein-Boltzmann code! Solves the coupled Einstein-Boltzmann equations for many types of matter in the Universe to first order in perturbation theory. Computes CMB observables such as temperature and polarisation correlations Cl TT, Cl TE, Cl EE, Cl BB. Computes LSS observables such as the total matter power spectrum P(k) and individual density and velocity transfer functions i δ (k, τ), i θ (k, τ). Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

5 Other Boltzmann codes A history of Boltzmann codes 1995 COSMICS by Ed Bertschinger in Fortran Seljak&Zaldarriaga adds a few functions to COSMICS for implementing the line-of-sight formalism. The new code is much faster and is called CMBFAST CMBFAST improved with RECFAST and nonzero curvature Antony Lewis translates CMBFAST into Fortran90, adds nonzero curvature and other improvements. Released as camb Similar restructuring and translation of CMBFAST done by Michael Doran in C++, called CMBEASY Only camb maintained class 1.0 released. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

6 The classy module classy, the class wrapper All the functionality of classy is found in the Python class called Class. Import Class in In Python by: from classy import Class Running class from Python from classy import Class import numpy as np import matplotlib. pyplot as plt cosmo = Class () cosmo. set ({ ' output ':'tcl,pcl, lcl ',' lensing ':' yes ','modes ':'s,t','r':'0.2 '}) cosmo. compute () Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

7 The Jupyter Notebook Jupyter Notebook Jupyter Notebook is a cell-based interface to IPython. Has Tab-completion of variables and function names. Nicely presents the documentation of each function. Easy way to get started on Python. Launching Jupyter Notebook Write the following command to launch the notebook: $> jupyter notebook Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

8 The notebook Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

9 Tab: Available class methods Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

10 Shift+Tab: Help on method Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

11 Shift+Tab: More help Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

12 What can it do? What is available in the wrapper? get_background() returns the information normally found in _background.dat. get_thermodynamics() returns the information of _thermodynamics.dat. get_primordial() corresponds to _primordial_pk.dat. get_perturbations() returns everything found in _perturbations*.dat get_transfer(z,format) returns the density and velocity transfer functions at any redshift z. (Format can be either 'camb' or 'class'). Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

13 And even more... What is available in the wrapper? raw_cl() returns unlensed C l. lensed_cl() returns lensed C l. density_cl() returns density C l. pk(k, z) returns the P(k) at redshift z. Many other small functions. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

14 Running a single instance of class Running class cosmo = Class()#Initiate one instance of the class Class cosmo.set({'output':'tcl lcl mpk','omega_cdm':0.25}) cosmo.compute()#run CLASS rawcl = cosmo.raw_cl()#get C_l^XY from CLASS print rawcl.keys()#print keys in dictionary Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

15 Ressources Useful links Exercises and slides for this course: GitHub repository for class: Help forum for class: Official homepage, lecture notes and online documentation: Some Jupyter Notebooks using class: Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

16 The CLASS directory Files and subdirectories The directory class/ contains subdirectories: include / # header files (*. h) source / # modules (*. c) main / # main CLASS function tools / # tools (*. c) output / # output files python / # python wrapper cpp / # C++ wrapper plus examples of input files,explanatory.ini, README.rst, Makefile, and few other directories containing data files (bbn/) or external code (hyrec/) Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

17 CLASS modules Structure of modules in class A module in class is: a file include/xxx.h containing some declarations a file source/xxx.c containing some functions a structure xx of the information that must be propagated to other modules Some fields in the structure are filled in the input.c module, and the rest are filled by a function xxx_init(...). executing a module calling xxx_init(...) Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

18 All modules in CLASS module structure ab. * main content input.c precision pr ppr prec. params. background.c background ba pba a(τ),... thermodynamics.c thermodynamics th pth x e (z),... perturbations.c perturbs pt ppt sources S(k, t) primordial.c primordial pm ppm prim. spectra P(k) nonlinear.c nonlinear nl pnl NL corr. α NL (k, τ) transfer.c transfers tr ptr trnsf. func. l (k) spectra.c spectra sp psp P(k, z), C l s lensing.c lensing le ple lensed C l s output.c output op pop output format Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

19 The main CLASS function int main () { input_init_..(.., ppr,pba,pth,ppt,ptr,ppm,psp,pnl,ple, pop ); background_init (ppr, pba ); thermodynamics_init (ppr,pba, pth ); perturb_init (ppr,pba,pth, ppt ); primordial_init (ppr,ppt, ppm ); nonlinear_init (ppr,pba,pth,ppt,ppm, pnl ); transfer_init (ppr,pba,pth,ppt,pnl, ptr ); spectra_init (ppr,pba,ppt,ppm,pnl,ptr, psp ); lensing_init (ppr,ppt,psp,pnl, ple ); output_init (pba,pth,ppt,ppm,ptr,psp,pnl,ple, pop ); lensing_free ( ple ); spectra_free ( psp ); transfer_free ( ptr ); nonlinear_free ( pnl ); primordial_free ( ppm ); perturb_free ( ppt ); thermodynamics_free ( pth ); background_free ( pba ); } Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

20 Background module Unit system We set = c = k B = 1, and all dimensionful quantities have unit Mpc n Friedmann equation a = a 2 H = a 2 α ρ α K a 2, where we have defined ρ α 8πG 3 ρphysical α. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

21 Background module background_functions() Most quantities can be immediately inferred from a given value of a without integrating any differential equations: ( ) ρ i = Ω 0 i H0 2 3(1+wi ) a a0 p i = w i ρ i ( ) 1/2 H = i ρ i K a ( 2 ) H = 3 2 i (ρ i + p i ) + K a a 2 ρ crit = H 2 Ω i = ρ i /ρ crit Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

22 Thermodynamics module Free electron fraction We must solve recombination and reionisation, to compute: the free electron fraction x e n e /n p. the optical depth κ(τ) where κ = σ T an p x e the visibility function g(τ) = κ e κ. x e Optical depth g Redshift z Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

23 Thermodynamics module Recombination Proper calculation requires out-of-equilibrium treatment of thousands of excited states in both hydrogen and helium. Fast computation by using effective 3-level atoms with fudged coefficients: RECFAST and HyRec. Priomordial helium fraction Y He Used to be a fixed input parameter for Boltzmann codes. BBN imposes a (non-analytic) relationship between N eff, ω b and Y He. By default class will find Y He by interpolation in a table computed by the BBN code Parthenope. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

24 Perturbations module Einstein and Boltzmann equations We must solve 2 of the 4 first order Einstein equations: k 2 η 1 a 2 a h = 4πGa 2 δρ, k 2 η = 4πGa 2 (ρ + p)θ, h + 2 a a h 2k 2 η = 24πGa 2 δp, h + 6η + 2 a ( h + 6η ) 2k 2 η = 24πGa 2 (ρ + p)σ a together with the Boltzmann equation for each species present in the Universe. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

25 Perturbations module The Boltzmann equation At an abstract level we can write: L [f α (τ, x, p)] = C [f i, f j ] (= 0). (1) The last equal sign is true for a collisionless species. We expand f α to first order: f α (τ, x, p) f 0 (q)(1 + Ψ(τ, x, q, ˆn)). (2) Plugging equation (2) into equation (1) gives a Boltzmann equation for Ψ in Fourier space: Ψ τ + i qk ɛ (k ˆn)Ψ + d ln f [ 0 η ḣ + 6 η ] (ˆk ˆn) 2 = C d ln q 2 Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

26 Perturbations module A few missing definitions We have defined the comoving momentum q and comoving energy ɛ by q p p T α and ɛ 2 +mα 2 T α. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

27 Perturbations module A few missing definitions We have defined the comoving momentum q and comoving energy ɛ by q p p T α and ɛ 2 +mα 2 T α. Why do we use Fourier-space? The Liouville operator L [f i (τ, x, p)] contains the gradient operator j......so in real space, the Boltzmann equation is a Partial Differential Equation (PDE). But since j e ik x = ik j e ik x, the PDE decouples and become a set of ordinary differential equations for each mode k. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

28 Perturbations module Legendre expansion of Ψ Since ˆk ˆn = cos θ, the equation from before Ψ τ + i qk ɛ (k ˆn)Ψ + d ln f [ 0 η ḣ + 6 η ] (ˆk ˆn) 2 = C d ln q 2 has no dependence on the angle φ. Thus we can expand the angular dependence of Ψ in Legendre multipoles: Ψ(τ, k, q, ˆk ˆn) = (2l + 1)Ψ l (τ, k, q)p l (ˆk ˆn) (3) l Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

29 Perturbations module The Boltzmann hierarchy Ψ 0 = qk ɛ + 1 6ḣ d ln f 0 d ln q + C 0, Ψ 1 = qk 3ɛ (Ψ 0 2Ψ 2 ) + C 1, Ψ 2 = qk 5ɛ (2Ψ 1 3Ψ 3 ) Ψ l = ( 1 15ḣ η ) d ln f0 d ln q + C 2, qk (2l + 1)ɛ (lψ l 1 (l + 1)Ψ l+1 ), l 3. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

30 Perturbations module Simplifications for different species Massive neutrinos and Dark Matter usually have no interactions, so C = 0. Photons, massless neutrinos, baryons and Cold Dark Matter have no momentum dependence, so we can integrate out q. Baryons and Cold Dark Matter have negligible shear, so we only need to consider l = 0 and l = 1. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

31 Perturbations module Simplifications for different species Massive neutrinos and Dark Matter usually have no interactions, so C = 0. Photons, massless neutrinos, baryons and Cold Dark Matter have no momentum dependence, so we can integrate out q. Baryons and Cold Dark Matter have negligible shear, so we only need to consider l = 0 and l = 1. Complications for photons Photons are not completely described by a single distribution function but the three Stoke s parameters Θ, Q and U. (Note that Θ Tγ T γ = 1 4 δ γ) Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

32 Perturbations module The line-of-sight formalism The Boltzmann equation has a formal solution in terms of an integral along the line-of-sight: Θ l (τ 0, k) = τ0 τ ini dτ S T (τ, k) j l (k(τ 0 τ)) ) S T (τ, k) g (Θ 0 + ψ) + (g k 2 θ b + e κ (φ + ψ ) + pol.. }{{}}{{}}{{} SW Doppler ISW Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

33 Perturbations module Relevant sources sources for CMB temperature (decomposed in 1 to 3 terms) sources for CMB polarisation (only 1 term) metric perturbations φ and ψ and derivatives, used for lensing and galaxy number counts. density perturbations of all components {δ i } velocity perturbations of all components {θ i } Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

34 Transfer module Purpose of the transfer module The goal is to compute harmonic transfer functions by performing several integrals of the type X l (q) = dτ S X (k(q), τ) φ X l (q, (τ 0 τ)) for each mode, initial conditions, and several types of source functions. In flat space k = q. Sparse l-sampling Calculation done for few values of l (controlled by precision parameters). C l s are interpolated later. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

35 Transfer module Overview of transfer_init interpolate all sources along k. (k grid is finer in transfer module than in perturbation module.) compute all flat Bessel functions loop over q (or k in flat space). : if non-flat, compute hyperspherical Bessels for this q : loop over modes, initial conditions, types : : loop over l : : : integrate transfer function (or Limber approx.) Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

36 Primordial module The primordial power spectrum class have a number of different ways to infer the primordial power spectrum of perturbations: Analytic parametrisation: ( P(k) = A exp (n 1) log(k/k pivot ) + α log(k/k pivot ) 2). Taylor expansion of inflationary potential V (φ φ ) or H (φ φ ). (See astro-ph/ and astro-ph/ for details.) Parametrisation of V (φ) in the whole region between the observable part and the end of inflation. Primordial powerspectra from external code. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

37 Spectra module Linear matter power spectra P(k, z) = (δ m (k, τ(z))) 2 P(k) or in the case of several initial conditions, P(k, z) = ij δ i m(k, τ(z)) δ j m(k, τ(z))p ij (k), Angular power spectra C XY l = 4π ij dk k X l (k) Y l (k)p(k) ( or its generalisation to several ICs). We have: { TT, TE, EE, BB, PP, TP, EP, XY N i N j, TN i, PN i, L i L j, TL i, N i L j }. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

38 Installing class and Jupyter Notebook Obtaining the codes $> git clone class If git is not installed: download from class-code.net or github.com/lesgourg/class_public. Download Anaconda Python 2.7: Installing class Should be as easy as writing make, since class does not require any external libraries. Note that the builtin C-compiler in OSX does not support OpenMP. class is compatible with Python3, but not yet MontePython. Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

39 Installation details Obtaining the codes This PDF is available at in the Day1 folder. $>git clone https :// github. com / lesgourg / class_ public class $>cd class $ > which python # Is it Anaconda Python? $ > which gcc # Is it the correct compiler? $ > make clean ; make -j $ > python -c ' from classy import Class ' Problems and solutions Not Anaconda Python: $>source ANACONDA_FOLDER/bin/activate undefined symbol: _ZGVbN2v_sin Follow the instructions at Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

40 Exercise 0: Plot the CMB temperature power spectrum Launch the Jupyter Notebook: $> jupyter notebook Run these lines in the notebook: % matplotlib inline # Plots inside cells % config InlineBackend. figure_ format = ' svg ' import matplotlib import matplotlib. pyplot as plt import numpy as np from classy import Class cosmo = Class () cosmo. set ({ ' output ':'tcl,pcl, lcl '}) cosmo. compute () cl = cosmo. raw_cl () l = cl['ell '] plt. loglog (l, l*(l+1) /(2.* np.pi)*cl['tt ']) Thomas Tram (AU) class Workshop CANTATA Summer School 12/9/ / 37

Lecture VI: nonlinear & transfer

Lecture VI: nonlinear & transfer Lecture VI: Nonlinear & Transfer EPFL & CERN London, 15.05.2014 Where are we? int main () { # done : input_init (pfc,ppr,pba,pth,ppt,ptr,ppm,psp,pnl,ple, pop ); background_init (ppr, pba ); thermodynamics_init

More information

The Cosmic Linear Anisotropy Solving System:

The Cosmic Linear Anisotropy Solving System: a most classy way from Fundamental Physics to Cosmology Nordic Institute for Theoretical Physics and UC Berkeley IFT School on Cosmology Tools March 2017 DISCLAIMER: Short time! 2h course overview and

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

A brief Introduction to CAMB and CosmoMC

A brief Introduction to CAMB and CosmoMC A brief Introduction to CAMB and CosmoMC Georgios Zacharegkas University of Chicago Monday, November 26 2018 Introduction In the current era of Cosmology, the very good agreement between theoretical predictions

More information

PAPER 71 COSMOLOGY. Attempt THREE questions There are seven questions in total The questions carry equal weight

PAPER 71 COSMOLOGY. Attempt THREE questions There are seven questions in total The questions carry equal weight MATHEMATICAL TRIPOS Part III Friday 31 May 00 9 to 1 PAPER 71 COSMOLOGY Attempt THREE questions There are seven questions in total The questions carry equal weight You may make free use of the information

More information

Lecture II: Background

Lecture II: Background Lecture II: The Background EPFL & CERN London, 13.05.2014 Homogeneous cosmology treated by the module background.c. So this lecture will refer mainly to the content of input/background.h, source/background.c,

More information

Modern Cosmology / Scott Dodelson Contents

Modern Cosmology / Scott Dodelson Contents Modern Cosmology / Scott Dodelson Contents The Standard Model and Beyond p. 1 The Expanding Universe p. 1 The Hubble Diagram p. 7 Big Bang Nucleosynthesis p. 9 The Cosmic Microwave Background p. 13 Beyond

More information

MATHEMATICAL TRIPOS PAPER 67 COSMOLOGY

MATHEMATICAL TRIPOS PAPER 67 COSMOLOGY MATHEMATICA TRIPOS Part III Wednesday 6 June 2001 9 to 11 PAPER 67 COSMOOGY Attempt THREE questions. The questions are of equal weight. Candidates may make free use of the information given on the accompanying

More information

MontePython Exercises IFT School on Cosmology Tools

MontePython Exercises IFT School on Cosmology Tools MontePython Exercises IFT School on Cosmology Tools Miguel Zumalacarregui March 16, 2017 The exercises have been ranked by level of difficulty (boring = v, interesting = challenging = and whether they

More information

CMB Anisotropies Episode II :

CMB Anisotropies Episode II : CMB Anisotropies Episode II : Attack of the C l ones Approximation Methods & Cosmological Parameter Dependencies By Andy Friedman Astronomy 200, Harvard University, Spring 2003 Outline Elucidating the

More information

Concordance Cosmology and Particle Physics. Richard Easther (Yale University)

Concordance Cosmology and Particle Physics. Richard Easther (Yale University) Concordance Cosmology and Particle Physics Richard Easther (Yale University) Concordance Cosmology The standard model for cosmology Simplest model that fits the data Smallest number of free parameters

More information

Efficient calculation of cosmological neutrino clustering

Efficient calculation of cosmological neutrino clustering Efficient calculation of cosmological neutrino clustering MARIA ARCHIDIACONO RWTH AACHEN UNIVERSITY ARXIV:50.02907 MA, STEEN HANNESTAD COSMOLOGY SEMINAR HELSINKI INSTITUTE OF PHYSICS 06.04.206 Cosmic history

More information

Galaxies 626. Lecture 3: From the CMBR to the first star

Galaxies 626. Lecture 3: From the CMBR to the first star Galaxies 626 Lecture 3: From the CMBR to the first star Galaxies 626 Firstly, some very brief cosmology for background and notation: Summary: Foundations of Cosmology 1. Universe is homogenous and isotropic

More information

Summary of equations for CMB power spectrum calculations

Summary of equations for CMB power spectrum calculations Summary of equations for CMB power spectrum calculations Hans Kristian Eriksen 9. april 2010 1 Definitions and background cosmology Four time variables: t = physical time, η = t 0 ca 1 (t)dt = conformal

More information

Lecture 3+1: Cosmic Microwave Background

Lecture 3+1: Cosmic Microwave Background Lecture 3+1: Cosmic Microwave Background Structure Formation and the Dark Sector Wayne Hu Trieste, June 2002 Large Angle Anisotropies Actual Temperature Data Really Isotropic! Large Angle Anisotropies

More information

Introduction to hi class

Introduction to hi class CLASSy Tests of Gravity and Dark Energy Nordic Institute for Theoretical Physics and UC Berkeley Cosmology in Theory and Practice September 2017 Fundamental physics and cosmology Initial conditions, Dark

More information

Astro 448 Lecture Notes Set 1 Wayne Hu

Astro 448 Lecture Notes Set 1 Wayne Hu Astro 448 Lecture Notes Set 1 Wayne Hu Recombination Equilibrium number density distribution of a non-relativistic species n i = g i ( mi T 2π ) 3/2 e m i/t Apply to the e + p H system: Saha Equation n

More information

Monte Python. the way back from cosmology to Fundamental Physics. Miguel Zumalacárregui. Nordic Institute for Theoretical Physics and UC Berkeley

Monte Python. the way back from cosmology to Fundamental Physics. Miguel Zumalacárregui. Nordic Institute for Theoretical Physics and UC Berkeley the way back from cosmology to Fundamental Physics Nordic Institute for Theoretical Physics and UC Berkeley IFT School on Cosmology Tools March 2017 Related Tools Version control and Python interfacing

More information

CMB Anisotropies: The Acoustic Peaks. Boom98 CBI Maxima-1 DASI. l (multipole) Astro 280, Spring 2002 Wayne Hu

CMB Anisotropies: The Acoustic Peaks. Boom98 CBI Maxima-1 DASI. l (multipole) Astro 280, Spring 2002 Wayne Hu CMB Anisotropies: The Acoustic Peaks 80 T (µk) 60 40 20 Boom98 CBI Maxima-1 DASI 500 1000 1500 l (multipole) Astro 280, Spring 2002 Wayne Hu Physical Landscape 100 IAB Sask 80 Viper BAM TOCO Sound Waves

More information

Cosmological Constraints on Newton s Gravitational Constant for Matter and Dark Matter

Cosmological Constraints on Newton s Gravitational Constant for Matter and Dark Matter Cosmological Constraints on Newton s Gravitational Constant for Matter and Dark Matter Jordi Salvadó Instituto de Física Corpuscular Talk based on: JCAP 1510 (2015) no.10, 029 [arxiv:1505.04789] In collaboration

More information

Observational Cosmology

Observational Cosmology The Cosmic Microwave Background Part I: CMB Theory Kaustuv Basu Course website: http://www.astro.uni-bonn.de/~kbasu/obscosmo CMB parameter cheat sheet 2 Make your own CMB experiment! Design experiment

More information

An Acoustic Primer. Wayne Hu Astro 448. l (multipole) BOOMERanG MAXIMA Previous COBE. W. Hu Dec. 2000

An Acoustic Primer. Wayne Hu Astro 448. l (multipole) BOOMERanG MAXIMA Previous COBE. W. Hu Dec. 2000 An Acoustic Primer 100 BOOMERanG MAXIMA Previous 80 T (µk) 60 40 20 COBE W. Hu Dec. 2000 10 100 l (multipole) Wayne Hu Astro 448 CMB Anisotropies COBE Maxima Hanany, et al. (2000) BOOMERanG de Bernardis,

More information

Physical Cosmology 6/6/2016

Physical Cosmology 6/6/2016 Physical Cosmology 6/6/2016 Alessandro Melchiorri alessandro.melchiorri@roma1.infn.it slides can be found here: oberon.roma1.infn.it/alessandro/cosmo2016 CMB anisotropies The temperature fluctuation in

More information

Probing Primordial Magnetic Fields with Cosmic Microwave Background Radiation

Probing Primordial Magnetic Fields with Cosmic Microwave Background Radiation Probing Primordial Magnetic Fields with Cosmic Microwave Background Radiation Department of Physics and Astrophysics University of Delhi IIT Madras, May 17, 2012 Collaborators: K. Subramanian, Pranjal

More information

UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences

UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences Exam for AST5220 Cosmology II Date: Tuesday, June 4th, 2013 Time: 09.00 13.00 The exam set consists of 13 pages. Appendix: Equation summary

More information

CMB quadrupole depression from early fast-roll inflation:

CMB quadrupole depression from early fast-roll inflation: CMB quadrupole depression from early fast-roll inflation: MCMC analysis of current experimental data Claudio Destri claudio.destri@mib.infn.it Dipartimento di Fisica G. Occhialini Università Milano Bicocca

More information

Polarization from Rayleigh scattering

Polarization from Rayleigh scattering Polarization from Rayleigh scattering Blue sky thinking for future CMB observations Previous work: Takahara et al. 91, Yu, et al. astro-ph/0103149 http://en.wikipedia.org/wiki/rayleigh_scattering Antony

More information

Dark Forces and the ISW Effect

Dark Forces and the ISW Effect Dark Forces and the ISW Effect Finn Ravndal, University of Oslo Introduction Chaplygin gases Cardassian fluids The integrated Sachs-Wolfe effect Demise of unified dark models Modified gravity: A resurrection?

More information

The ultimate measurement of the CMB temperature anisotropy field UNVEILING THE CMB SKY

The ultimate measurement of the CMB temperature anisotropy field UNVEILING THE CMB SKY The ultimate measurement of the CMB temperature anisotropy field UNVEILING THE CMB SKY PARAMETRIC MODEL 16 spectra in total C(θ) = CMB theoretical spectra plus physically motivated templates for the

More information

Testing vector-tensor gravity with current cosmological observations

Testing vector-tensor gravity with current cosmological observations Journal of Physics: Conference Series PAPER OPEN ACCESS Testing vector-tensor gravity with current cosmological observations To cite this article: Roberto Dale and Diego Sáe 15 J. Phys.: Conf. Ser. 1 View

More information

CMB studies with Planck

CMB studies with Planck CMB studies with Planck Antony Lewis Institute of Astronomy & Kavli Institute for Cosmology, Cambridge http://cosmologist.info/ Thanks to Anthony Challinor & Anthony Lasenby for a few slides (almost) uniform

More information

Gravitational Lensing of the CMB

Gravitational Lensing of the CMB Gravitational Lensing of the CMB SNAP Planck 1 Ω DE 1 w a.5-2 -1.5 w -1 -.5 Wayne Hu Leiden, August 26-1 Outline Gravitational Lensing of Temperature and Polarization Fields Cosmological Observables from

More information

Physics 463, Spring 07. Formation and Evolution of Structure: Growth of Inhomogenieties & the Linear Power Spectrum

Physics 463, Spring 07. Formation and Evolution of Structure: Growth of Inhomogenieties & the Linear Power Spectrum Physics 463, Spring 07 Lecture 3 Formation and Evolution of Structure: Growth of Inhomogenieties & the Linear Power Spectrum last time: how fluctuations are generated and how the smooth Universe grows

More information

We finally come to the determination of the CMB anisotropy power spectrum. This set of lectures will be divided into five parts:

We finally come to the determination of the CMB anisotropy power spectrum. This set of lectures will be divided into five parts: Primary CMB anisotropies We finally come to the determination of the CMB anisotropy power spectrum. This set of lectures will be divided into five parts: CMB power spectrum formalism. Radiative transfer:

More information

Cosmology & CMB. Set6: Polarisation & Secondary Anisotropies. Davide Maino

Cosmology & CMB. Set6: Polarisation & Secondary Anisotropies. Davide Maino Cosmology & CMB Set6: Polarisation & Secondary Anisotropies Davide Maino Polarisation How? Polarisation is generated via Compton/Thomson scattering (angular dependence of the scattering term M) Who? Only

More information

TESTING GRAVITY WITH COSMOLOGY

TESTING GRAVITY WITH COSMOLOGY 21 IV. TESTING GRAVITY WITH COSMOLOGY We now turn to the different ways with which cosmological observations can constrain modified gravity models. We have already seen that Solar System tests provide

More information

CMB bispectrum. Takashi Hiramatsu. Collaboration with Ryo Saito (YITP), Atsushi Naruko (TITech), Misao Sasaki (YITP)

CMB bispectrum. Takashi Hiramatsu. Collaboration with Ryo Saito (YITP), Atsushi Naruko (TITech), Misao Sasaki (YITP) Workshop, 03 Aug 2016 @ Hirosaki Univ. CMB bispectrum Takashi Hiramatsu Yukawa Institute for Theoretical Physics (YITP) Kyoto University Collaboration with Ryo Saito (YITP), Atsushi Naruko (TITech), Misao

More information

The Once and Future CMB

The Once and Future CMB The Once and Future CMB DOE, Jan. 2002 Wayne Hu The On(c)e Ring Original Power Spectra of Maps 64º Band Filtered Ringing in the New Cosmology Gravitational Ringing Potential wells = inflationary seeds

More information

Dark Matter Properties and the CMB. Michael Kopp in collaboration with Dan Thomas and Costas Skordis

Dark Matter Properties and the CMB. Michael Kopp in collaboration with Dan Thomas and Costas Skordis Dark Matter Properties and the CMB Michael Kopp in collaboration with Dan Thomas and Costas Skordis Outline Generalized dark matter, ΛGDM Connection to thermodynamics and fluids Initial conditions and

More information

The cosmic background radiation II: The WMAP results. Alexander Schmah

The cosmic background radiation II: The WMAP results. Alexander Schmah The cosmic background radiation II: The WMAP results Alexander Schmah 27.01.05 General Aspects - WMAP measures temperatue fluctuations of the CMB around 2.726 K - Reason for the temperature fluctuations

More information

NeoClassical Probes. of the Dark Energy. Wayne Hu COSMO04 Toronto, September 2004

NeoClassical Probes. of the Dark Energy. Wayne Hu COSMO04 Toronto, September 2004 NeoClassical Probes in of the Dark Energy Wayne Hu COSMO04 Toronto, September 2004 Structural Fidelity Dark matter simulations approaching the accuracy of CMB calculations WMAP Kravtsov et al (2003) Equation

More information

Introduction to COSMOMC

Introduction to COSMOMC Introduction to COSMOMC SCHOOL ON COSMOLOGY TOOLS Madrid, 12-15 November 2013. José Alberto Rubiño Martín (Email: jalberto@iac.es) (http://www.iac.es/galeria/jalberto) COSMOlogical Monte-Carlo I. Introduction.

More information

Week 10: Theoretical predictions for the CMB temperature power spectrum

Week 10: Theoretical predictions for the CMB temperature power spectrum Week 10: Theoretical predictions for the CMB temperature power spectrum April 5, 2012 1 Introduction Last week we defined various observable quantities to describe the statistics of CMB temperature fluctuations,

More information

Ringing in the New Cosmology

Ringing in the New Cosmology Ringing in the New Cosmology 80 T (µk) 60 40 20 Boom98 CBI Maxima-1 DASI 500 1000 1500 l (multipole) Acoustic Peaks in the CMB Wayne Hu Temperature Maps CMB Isotropy Actual Temperature Data COBE 1992 Dipole

More information

CMB beyond a single power spectrum: Non-Gaussianity and frequency dependence. Antony Lewis

CMB beyond a single power spectrum: Non-Gaussianity and frequency dependence. Antony Lewis CMB beyond a single power spectrum: Non-Gaussianity and frequency dependence Antony Lewis http://cosmologist.info/ Evolution of the universe Opaque Transparent Hu & White, Sci. Am., 290 44 (2004) CMB temperature

More information

isocurvature modes Since there are two degrees of freedom in

isocurvature modes Since there are two degrees of freedom in isocurvature modes Since there are two degrees of freedom in the matter-radiation perturbation, there must be a second independent perturbation mode to complement the adiabatic solution. This clearly must

More information

PAPER 310 COSMOLOGY. Attempt no more than THREE questions. There are FOUR questions in total. The questions carry equal weight.

PAPER 310 COSMOLOGY. Attempt no more than THREE questions. There are FOUR questions in total. The questions carry equal weight. MATHEMATICAL TRIPOS Part III Wednesday, 1 June, 2016 9:00 am to 12:00 pm PAPER 310 COSMOLOGY Attempt no more than THREE questions. There are FOUR questions in total. The questions carry equal weight. STATIONERY

More information

The Cosmic Microwave Background and Dark Matter. Wednesday, 27 June 2012

The Cosmic Microwave Background and Dark Matter. Wednesday, 27 June 2012 The Cosmic Microwave Background and Dark Matter Constantinos Skordis (Nottingham) Itzykson meeting, Saclay, 19 June 2012 (Cold) Dark Matter as a model Dark Matter: Particle (microphysics) Dust fluid (macrophysics)

More information

Week 3: Sub-horizon perturbations

Week 3: Sub-horizon perturbations Week 3: Sub-horizon perturbations February 12, 2017 1 Brief Overview Until now we have considered the evolution of a Universe that is homogeneous. Our Universe is observed to be quite homogeneous on large

More information

Structure formation. Yvonne Y. Y. Wong Max-Planck-Institut für Physik, München

Structure formation. Yvonne Y. Y. Wong Max-Planck-Institut für Physik, München Structure formation Yvonne Y. Y. Wong Max-Planck-Institut für Physik, München Structure formation... Random density fluctuations, grow via gravitational instability galaxies, clusters, etc. Initial perturbations

More information

Priming the BICEP. Wayne Hu Chicago, March BB

Priming the BICEP. Wayne Hu Chicago, March BB Priming the BICEP 0.05 0.04 0.03 0.02 0.01 0 0.01 BB 0 50 100 150 200 250 300 Wayne Hu Chicago, March 2014 A BICEP Primer How do gravitational waves affect the CMB temperature and polarization spectrum?

More information

Rayleigh scattering:

Rayleigh scattering: Rayleigh scattering: blue sky thinking for future CMB observations arxiv:1307.8148; previous work: Takahara et al. 91, Yu, et al. astro-ph/0103149 http://en.wikipedia.org/wiki/rayleigh_scattering Antony

More information

The Effects of Inhomogeneities on the Universe Today. Antonio Riotto INFN, Padova

The Effects of Inhomogeneities on the Universe Today. Antonio Riotto INFN, Padova The Effects of Inhomogeneities on the Universe Today Antonio Riotto INFN, Padova Frascati, November the 19th 2004 Plan of the talk Short introduction to Inflation Short introduction to cosmological perturbations

More information

The Silk Damping Tail of the CMB l. Wayne Hu Oxford, December 2002

The Silk Damping Tail of the CMB l. Wayne Hu Oxford, December 2002 The Silk Damping Tail of the CMB 100 T (µk) 10 10 100 1000 l Wayne Hu Oxford, December 2002 Outline Damping tail of temperature power spectrum and its use as a standard ruler Generation of polarization

More information

Introduction to CosmoMC

Introduction to CosmoMC Introduction to CosmoMC Part I: Motivation & Basic concepts Institut de Ciències del Cosmos - Universitat de Barcelona Dept. de Física Teórica y del Cosmos, Universidad de Granada, 1-3 Marzo 2016 What

More information

Chapter 4. COSMOLOGICAL PERTURBATION THEORY

Chapter 4. COSMOLOGICAL PERTURBATION THEORY Chapter 4. COSMOLOGICAL PERTURBATION THEORY 4.1. NEWTONIAN PERTURBATION THEORY Newtonian gravity is an adequate description on small scales (< H 1 ) and for non-relativistic matter (CDM + baryons after

More information

Neutrino Mass Limits from Cosmology

Neutrino Mass Limits from Cosmology Neutrino Physics and Beyond 2012 Shenzhen, September 24th, 2012 This review contains limits obtained in collaboration with: Emilio Ciuffoli, Hong Li and Xinmin Zhang Goal of the talk Cosmology provides

More information

From inflation to the CMB to today s universe. I - How it all begins

From inflation to the CMB to today s universe. I - How it all begins From inflation to the CMB to today s universe I - How it all begins Raul Abramo Physics Institute - University of São Paulo abramo@fma.if.usp.br redshift Very brief cosmic history 10 9 200 s BBN 1 MeV

More information

Second Order CMB Perturbations

Second Order CMB Perturbations Second Order CMB Perturbations Looking At Times Before Recombination September 2012 Evolution of the Universe Second Order CMB Perturbations 1/ 23 Observations before recombination Use weakly coupled particles

More information

Lecture 4. - Cosmological parameter dependence of the temperature power spectrum (continued) - Polarisation

Lecture 4. - Cosmological parameter dependence of the temperature power spectrum (continued) - Polarisation Lecture 4 - Cosmological parameter dependence of the temperature power spectrum (continued) - Polarisation Planck Collaboration (2016) Let s understand the peak heights Silk+Landau Damping Sachs-Wolfe

More information

A5682: Introduction to Cosmology Course Notes. 11. CMB Anisotropy

A5682: Introduction to Cosmology Course Notes. 11. CMB Anisotropy Reading: Chapter 8, sections 8.4 and 8.5 11. CMB Anisotropy Gravitational instability and structure formation Today s universe shows structure on scales from individual galaxies to galaxy groups and clusters

More information

Investigation of CMB Power Spectra Phase Shifts

Investigation of CMB Power Spectra Phase Shifts Investigation of CMB Power Spectra Phase Shifts Brigid Mulroe Fordham University, Bronx, NY, 1458 Lloyd Knox, Zhen Pan University of California, Davis, CA, 95616 ABSTRACT Analytical descriptions of anisotropies

More information

PAPER 73 PHYSICAL COSMOLOGY

PAPER 73 PHYSICAL COSMOLOGY MATHEMATICAL TRIPOS Part III Wednesday 4 June 2008 1.30 to 4.30 PAPER 73 PHYSICAL COSMOLOGY Attempt no more than THREE questions. There are FOUR questions in total. The questions carry equal weight. STATIONERY

More information

UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences

UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences Exam for AST5/94 Cosmology II Date: Thursday, June 11th, 15 Time: 9. 13. The exam set consists of 11 pages. Appendix: Equation summary Allowed

More information

Fisher Matrix Analysis of the Weak Lensing Spectrum

Fisher Matrix Analysis of the Weak Lensing Spectrum Fisher Matrix Analysis of the Weak Lensing Spectrum Manuel Rabold Institute for Theoretical Physics, University of Zurich Fisher Matrix Analysis of the Weak Lensing Spectrum Manuel Rabold Aarhus University,

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

Dark Energy in Light of the CMB. (or why H 0 is the Dark Energy) Wayne Hu. February 2006, NRAO, VA

Dark Energy in Light of the CMB. (or why H 0 is the Dark Energy) Wayne Hu. February 2006, NRAO, VA Dark Energy in Light of the CMB (or why H 0 is the Dark Energy) Wayne Hu February 2006, NRAO, VA If its not dark, it doesn't matter! Cosmic matter-energy budget: Dark Energy Dark Matter Dark Baryons Visible

More information

Galaxy Formation Seminar 2: Cosmological Structure Formation as Initial Conditions for Galaxy Formation. Prof. Eric Gawiser

Galaxy Formation Seminar 2: Cosmological Structure Formation as Initial Conditions for Galaxy Formation. Prof. Eric Gawiser Galaxy Formation Seminar 2: Cosmological Structure Formation as Initial Conditions for Galaxy Formation Prof. Eric Gawiser Cosmic Microwave Background anisotropy and Large-scale structure Cosmic Microwave

More information

Cosmology. Introduction Geometry and expansion history (Cosmic Background Radiation) Growth Secondary anisotropies Large Scale Structure

Cosmology. Introduction Geometry and expansion history (Cosmic Background Radiation) Growth Secondary anisotropies Large Scale Structure Cosmology Introduction Geometry and expansion history (Cosmic Background Radiation) Growth Secondary anisotropies Large Scale Structure Cosmology from Large Scale Structure Sky Surveys Supernovae Ia CMB

More information

Physics of the hot universe!

Physics of the hot universe! Cosmology Winter School 5/12/2011! Lecture 2:! Physics of the hot universe! Jean-Philippe UZAN! The standard cosmological models! a 0!! Eq. state! Scaling Scale factor! radiation! w=1/3! a -4! t 1/2! Matter

More information

The AfterMap Wayne Hu EFI, February 2003

The AfterMap Wayne Hu EFI, February 2003 The AfterMap Wayne Hu EFI, February 2003 Connections to the Past Outline What does MAP alone add to the cosmology? What role do other anisotropy experiments still have to play? How do you use the MAP analysis

More information

Modified gravity as an alternative to dark energy. Lecture 3. Observational tests of MG models

Modified gravity as an alternative to dark energy. Lecture 3. Observational tests of MG models Modified gravity as an alternative to dark energy Lecture 3. Observational tests of MG models Observational tests Assume that we manage to construct a model How well can we test the model and distinguish

More information

Examining the Viability of Phantom Dark Energy

Examining the Viability of Phantom Dark Energy Examining the Viability of Phantom Dark Energy Kevin J. Ludwick LaGrange College 12/20/15 (11:00-11:30) Kevin J. Ludwick (LaGrange College) Examining the Viability of Phantom Dark Energy 12/20/15 (11:00-11:30)

More information

Cosmology & CMB. Set2: Linear Perturbation Theory. Davide Maino

Cosmology & CMB. Set2: Linear Perturbation Theory. Davide Maino Cosmology & CMB Set2: Linear Perturbation Theory Davide Maino Covariant Perturbation Theory Covariant = takes same form in all coordinate systems Invariant = takes the same value in all coordinate systems

More information

Physical Cosmology 18/5/2017

Physical Cosmology 18/5/2017 Physical Cosmology 18/5/2017 Alessandro Melchiorri alessandro.melchiorri@roma1.infn.it slides can be found here: oberon.roma1.infn.it/alessandro/cosmo2017 Summary If we consider perturbations in a pressureless

More information

Microwave Background Polarization: Theoretical Perspectives

Microwave Background Polarization: Theoretical Perspectives Microwave Background Polarization: Theoretical Perspectives Department of Physics and Astronomy University of Pittsburgh CMBpol Technology Workshop Outline Tensor Perturbations and Microwave Polarization

More information

Astronomy 422. Lecture 20: Cosmic Microwave Background

Astronomy 422. Lecture 20: Cosmic Microwave Background Astronomy 422 Lecture 20: Cosmic Microwave Background Key concepts: The CMB Recombination Radiation and matter eras Next time: Astro 422 Peer Review - Make sure to read all 6 proposals and send in rankings

More information

Cosmology. Jörn Wilms Department of Physics University of Warwick.

Cosmology. Jörn Wilms Department of Physics University of Warwick. Cosmology Jörn Wilms Department of Physics University of Warwick http://astro.uni-tuebingen.de/~wilms/teach/cosmo Contents 2 Old Cosmology Space and Time Friedmann Equations World Models Modern Cosmology

More information

Cosmology with CMB & LSS:

Cosmology with CMB & LSS: Cosmology with CMB & LSS: the Early universe VSP08 lecture 4 (May 12-16, 2008) Tarun Souradeep I.U.C.A.A, Pune, India Ω +Ω +Ω +Ω + Ω +... = 1 0 0 0 0... 1 m DE K r r The Cosmic Triangle (Ostriker & Steinhardt)

More information

BAO & RSD. Nikhil Padmanabhan Essential Cosmology for the Next Generation VII December 2017

BAO & RSD. Nikhil Padmanabhan Essential Cosmology for the Next Generation VII December 2017 BAO & RSD Nikhil Padmanabhan Essential Cosmology for the Next Generation VII December 2017 Overview Introduction Standard rulers, a spherical collapse picture of BAO, the Kaiser formula, measuring distance

More information

Introduction. How did the universe evolve to what it is today?

Introduction. How did the universe evolve to what it is today? Cosmology 8 1 Introduction 8 2 Cosmology: science of the universe as a whole How did the universe evolve to what it is today? Based on four basic facts: The universe expands, is isotropic, and is homogeneous.

More information

Introduction to Inflation

Introduction to Inflation Introduction to Inflation Miguel Campos MPI für Kernphysik & Heidelberg Universität September 23, 2014 Index (Brief) historic background The Cosmological Principle Big-bang puzzles Flatness Horizons Monopoles

More information

Inflation and the origin of structure in the Universe

Inflation and the origin of structure in the Universe Phi in the Sky, Porto 0 th July 004 Inflation and the origin of structure in the Universe David Wands Institute of Cosmology and Gravitation University of Portsmouth outline! motivation! the Primordial

More information

Really, really, what universe do we live in?

Really, really, what universe do we live in? Really, really, what universe do we live in? Fluctuations in cosmic microwave background Origin Amplitude Spectrum Cosmic variance CMB observations and cosmological parameters COBE, balloons WMAP Parameters

More information

Large Scale Structure After these lectures, you should be able to: Describe the matter power spectrum Explain how and why the peak position depends on

Large Scale Structure After these lectures, you should be able to: Describe the matter power spectrum Explain how and why the peak position depends on Observational cosmology: Large scale structure Filipe B. Abdalla Kathleen Lonsdale Building G.22 http://zuserver2.star.ucl.ac.uk/~hiranya/phas3136/phas3136 Large Scale Structure After these lectures, you

More information

Astronomy 182: Origin and Evolution of the Universe

Astronomy 182: Origin and Evolution of the Universe Astronomy 182: Origin and Evolution of the Universe Prof. Josh Frieman Lecture 11 Nov. 13, 2015 Today Cosmic Microwave Background Big Bang Nucleosynthesis Assignments This week: read Hawley and Holcomb,

More information

Cosmological neutrinos

Cosmological neutrinos Cosmological neutrinos Yvonne Y. Y. Wong CERN & RWTH Aachen APCTP Focus Program, June 15-25, 2009 2. Neutrinos and structure formation: the linear regime Relic neutrino background: Temperature: 4 T,0 =

More information

CONSTRAINTS AND TENSIONS IN MG CFHTLENS AND OTHER DATA SETS PARAMETERS FROM PLANCK, INCLUDING INTRINSIC ALIGNMENTS SYSTEMATICS.

CONSTRAINTS AND TENSIONS IN MG CFHTLENS AND OTHER DATA SETS PARAMETERS FROM PLANCK, INCLUDING INTRINSIC ALIGNMENTS SYSTEMATICS. CONSTRAINTS AND TENSIONS IN MG PARAMETERS FROM PLANCK, CFHTLENS AND OTHER DATA SETS INCLUDING INTRINSIC ALIGNMENTS SYSTEMATICS 1 Mustapha Ishak The University of Texas at Dallas Jason Dossett INAF Osservatorio

More information

arxiv: v2 [astro-ph.co] 14 Jun 2017

arxiv: v2 [astro-ph.co] 14 Jun 2017 Lorentz invariance violation in the neutrino sector: a joint analysis from big bang nucleosynthesis and the cosmic microwave background Wei-Ming Dai 1,3, Zong-Kuan Guo 1,2, Rong-Gen Cai 1,3, and Yuan-Zhong

More information

Clusters: Context and Background

Clusters: Context and Background Clusters: Context and Background We re about to embark on a subject rather different from what we ve treated before, so it is useful to step back and think again about what we want to accomplish in this

More information

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator.

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator. MATHEMATICAL TRIPOS Part III Thursday 3 June, 2004 9 to 12 PAPER 67 PHYSICAL COSMOLOGY Attempt THREE questions. There are four questions in total. The questions carry equal weight. You may not start to

More information

Power spectrum exercise

Power spectrum exercise Power spectrum exercise In this exercise, we will consider different power spectra and how they relate to observations. The intention is to give you some intuition so that when you look at a microwave

More information

IoP. An Introduction to the Science of Cosmology. Derek Raine. Ted Thomas. Series in Astronomy and Astrophysics

IoP. An Introduction to the Science of Cosmology. Derek Raine. Ted Thomas. Series in Astronomy and Astrophysics Series in Astronomy and Astrophysics An Introduction to the Science of Cosmology Derek Raine Department of Physics and Astronomy University of Leicester, UK Ted Thomas Department of Physics and Astronomy

More information

Astro-2: History of the Universe

Astro-2: History of the Universe Astro-2: History of the Universe Lecture 8; May 7 2013 Previously on astro-2 Wherever we look in the sky there is a background of microwaves, the CMB. The CMB is very close to isotropic better than 0.001%

More information

neutrinos (ν) } ν energy ~ K ν + proton e + + neutron! e - + proton neutron + ν Freeze-out temperatures

neutrinos (ν) } ν energy ~ K ν + proton e + + neutron! e - + proton neutron + ν Freeze-out temperatures kt ~ mparticle c 2 neutrinos (ν) kt < mparticle c 2 kt > mparticle c 2 Freeze-out temperatures particle /! T (K) time since BB antiparticle 6x10 e 20 sec 1.2x10 μ 1 sec 1x10 p 10 NOTE: after freeze-out,

More information

Lecture 3. - Cosmological parameter dependence of the temperature power spectrum. - Polarisation of the CMB

Lecture 3. - Cosmological parameter dependence of the temperature power spectrum. - Polarisation of the CMB Lecture 3 - Cosmological parameter dependence of the temperature power spectrum - Polarisation of the CMB Planck Collaboration (2016) Let s understand the peak heights Silk+Landau Damping Sachs-Wolfe Sound

More information

AST5220 Recombination. Hans Kristian Eriksen

AST5220 Recombination. Hans Kristian Eriksen AST5220 Recombination Hans Kristian Eriksen Overview Some important points: Photons scatter on free electrons In the early universe, the temperature was very hot Too hot for neutral hydrogen to exist;

More information

Theoretical Astrophysics and Cosmology

Theoretical Astrophysics and Cosmology Theoretical Astrophysics and Cosmology What is COSMOLOGY? -The study of the Universe as a whole, namely as the collection of its matter/energy components and its constituent phenomena, and of its evolution.

More information

N-body Simulations and Dark energy

N-body Simulations and Dark energy N-Body Simulations and models of Dark Energy Elise Jennings Supported by a Marie Curie Early Stage Training Fellowship N-body Simulations and Dark energy elise jennings Introduction N-Body simulations

More information

Anisotropy in the CMB

Anisotropy in the CMB Anisotropy in the CMB Antony Lewis Institute of Astronomy & Kavli Institute for Cosmology, Cambridge http://cosmologist.info/ Hanson & Lewis: 0908.0963 Evolution of the universe Opaque Transparent Hu &

More information