Hierarchical Bayesian Modeling with Approximate Bayesian Computation

Size: px
Start display at page:

Download "Hierarchical Bayesian Modeling with Approximate Bayesian Computation"

Transcription

1 Hierarchical Bayesian Modeling with Approximate Bayesian Computation Jessi Cisewski Carnegie Mellon University June 2014

2 Goal of lecture Bring the ideas of Hierarchical Bayesian Modeling (HBM), Approximate Bayesian Computation (ABC), importance sampling, and sequential ABC together in an astronomy-motivated application to exoplanets.

3 Collaborators Eric Ford Megan Shabram Chad Schafer SAMSI ExoStat Group

4 Planet detection Figure:

5 Kepler field of view

6 Kepler field of view (pre )

7 Each exoplanet, i, has the following parameters: w i (R sa, R pa, κ i, Π i, φ i, e i, ω i ) R si R pi = star radius = planet radius κ i = amplitude of velocity model Π i = orbital period φ i = orbital phase at fiducial time e i = orbital eccentricity ω i = longitude of perihelion (orientation of ellipse relative to the sky)

8 Each exoplanet, i, has the following parameters: w i (R sa, R pa, κ i, Π i, φ i, e i, ω i ) R si R pi = star radius = planet radius κ i = amplitude of velocity model Π i = orbital period φ i = orbital phase at fiducial time e i = orbital eccentricity ω i = longitude of perihelion (orientation of ellipse relative to the sky)

9 Orbital eccentricity Planet Eccentricity Mercury Venus Earth Mars Jupiter Saturn Uranus Neptune

10 Orbital eccentricity

11 Eccentricity: observables There is some true (h i, k i ) for planet i such that ( ) (( ) ( hi 0 σ 2 [some parameters] N, ci 0 k i 0 0 σc 2 i )) where h i = e i cos( ω i ), k i = e i sin( ω i ) = hi 2 + ki 2 ω i U[0, 2π) But we observe (h i, k i ) with measurement error ( ) (( ĥi hi [some parameters] N ˆk i k i ) ( σ 2, h 0 0 σk 2 = e 2 i ))

12 Eccentricity: [some parameters] Given a sample of exoplanets p 1,..., p n, we assume the following 1 N m populations (assume N m = 1, 2, or 3) 2 Classify each population as c 1,..., c Nm 3 Each population has a certain true proportion f j, j = 1,..., N m and N m j=1 f j = 1

13 Bayesian hierarchical model for eccentricity ( hi k i N m = # populations (fixed and known ) f Dirichlet(1 Nm ) c i f iid multinomial(f ) ) c i, σ 2 c i N ( ĥi ˆk i ) c i, σ 2 c i, h i, k i N iid σ ci U(0, 1) (( 0 0 (( hi k i ), ), ( σ 2 ci 0 0 σc 2 i ( ˆσ 2 h 0 0 ˆσ 2 k )) ))

14 3D Dirichlet Distribution Image:

15 Beta Distribution f (y α, β) = Γ(α + β) Γ(α)Γ(β) y α 1 (1 y) β 1 Image:

16 Recall the Basic ABC algorithm For the observed data y 1:n, prior π(θ) and distance function ρ: Algorithm 1 Sample θ from prior π(θ) 2 Generate x 1:n from forward process f (y θ ) 3 Accept θ if ρ(y 1:n, x 1:n ) < ɛ 4 Return to step 1 Generates a sample from an approximation of the posterior: f (x 1:n ρ(y 1:n, x 1:n, θ) < ɛ) π(θ) f (y 1:n θ)π(θ) π(θ y 1:n )

17 Summary of basic ABC Decisions that need to be made: 1 Distance function (ρ) 2 Summary statistic(s) 3 Tolerance (ɛ) Finding the right ɛ can be inefficient we end up throwing away many of the theories proposed from the selected priors use sequential sampling to improve efficiency

18 Each exoplanet, i, has the following parameters: w i (R sa, R pa, κ i, Π i, φ i, e i, ω i ) R si R pi = star radius = planet radius κ i = amplitude of velocity model Π i = orbital period φ i = orbital phase at fiducial time e i = orbital eccentricity ω i = longitude of perihelion (orientation of ellipse relative to the sky)

19 The observations The observations are simulated from the forward process (i.e. the hierarchical model) Two populations of exoplanets (N m = 2) True parameter values: 1 Standard deviations of h s and k s for each population: (σ 1, σ 2 ) = (0.05, 0.30) 2 Weights of each population: (f 1, f 2 ) = (.7,.3) n = 500 observations

20 for(i in 1:N){ while(d>epsilon0[t]) { # prior on (f1,f2) ~ Dirichlet(1) gamma0 = rgamma(nm,shape = alpha0,scale = 1) f.proposed0 = gamma0/sum(gamma0) # prior on (sig1, sig2) ~ Uniform(0,1) sigma.proposed0 = runif(nm) index0 = sample.int(nm, size = n, replace = TRUE, prob = f.proposed0) sigma.proposed = sigma.proposed0[index0] # generate the h s and k s theta1.h = sigma.proposed*rnorm(n) theta1.k = sigma.proposed*rnorm(n) # add measurement error theta1.hhat = theta1.h + sigma.hhat*rnorm(n) theta1.khat = theta1.k + sigma.khat*rnorm(n) # check the distance x[,1] = theta1.hhat x[,2] = theta1.khat d = distance.function(x, data0) } # if distance <= epsilon, then keep d0[i,t] = d sigma.final[i,,t]= sigma.proposed0 f.final[i,,t]= f.proposed0 gamma.sum[i,t] = sum(gamma0) }

21 Draw from the prior # prior on (f1,f2) ~ Dirichlet(1) gamma0 = rgamma(nm,shape = alpha0,scale = 1) f.proposed0 = gamma0/sum(gamma0) # prior on (sig1, sig2) ~ Uniform(0,1) sigma.proposed0 = runif(nm) index0 = sample.int(nm, size = n, replace = TRUE, prob = f.proposed0) sigma.proposed = sigma.proposed0[index0]

22 Draw from the prior # prior on (f1,f2) ~ Dirichlet(1) gamma0 = rgamma(nm,shape = alpha0,scale = 1) f.proposed0 = gamma0/sum(gamma0) # prior on (sig1, sig2) ~ Uniform(0,1) sigma.proposed0 = runif(nm) index0 = sample.int(nm, size = n, replace = TRUE, prob = f.proposed0) sigma.proposed = sigma.proposed0[index0]

23 Draw from the prior # prior on (f1,f2) ~ Dirichlet(1) gamma0 = rgamma(nm,shape = alpha0,scale = 1) f.proposed0 = gamma0/sum(gamma0) # prior on (sig1, sig2) ~ Uniform(0,1) sigma.proposed0 = runif(nm) index0 = sample.int(nm, size = n, replace = TRUE, prob = f.proposed0) sigma.proposed = sigma.proposed0[index0]

24 Forward model # generate the h s and k s theta1.h = sigma.proposed*rnorm(n) theta1.k = sigma.proposed*rnorm(n) # add measurement error theta1.hhat = theta1.h + sigma.hhat*rnorm(n) theta1.khat = theta1.k + sigma.khat*rnorm(n) # check the distance x[,1] = theta1.hhat x[,2] = theta1.khat d = distance.function(x, data0) }

25 Distance function: Kolmogorov-Smirnov distance

26 Distance function: Kolmogorov-Smirnov distance

27 Distance function: Kolmogorov-Smirnov distance

28 Does the distance function really matter?

29 KS distance on e 2 (left); mean difference of e 2 (right) Drawing 100 particles

30 KS distance on e 2 (left); mean difference of e 2 (right) Drawing 100 particles

31 KS distance on e 2 (left); mean difference of e 2 (right) Drawing 100 particles

32 KS distance on e 2 (left); mean difference of e 2 (right) Drawing 100 particles

33 N = 500 particles Mean difference of e 2

34 N = 500 particles Mean difference of e 2 KS distance

35 Decreasing tolerances ɛ 1 ɛ T ABC - Population Monte Carlo algorithm (ABC - PMC) 1 At t = 1 For i = 1,..., N particles Generate θ (1) i π(θ) and x f (y θi 1) until ρ(y, x) < ɛ 1 Set w (1) i = N 1 2 At t = 2,..., T ( ) Set τt 2 = 2 var θ (t 1) 1:N For i = 1,..., N particles Draw θ i multinomial ( ) θ (t 1) 1:N, w (t 1) 1:N Generate θ (t) i θi N(θi, τ t 2 ) and x f (y θ (t) i ) until ρ(y, x) < ɛ t Set w (t) i π(θ (t) i )/ N j φ[τt 1 (θ (t) i θ (t 1) j )] φ( ) is the density function of a N(0, 1) From Beaumont et al. (2009) j=1 w (t 1)

36 KS -distance with N = 500 particles

37 KS -distance with N = 500 particles

38 KS -distance with N = 500 particles

39 KS -distance with N = 500 particles

40 KS -distance with N = 500 particles

41 KS -distance with N = 500 particles

42 KS -distance with N = 500 particles

43 KS -distance with N = 500 particles

44 KS -distance with N = 500 particles

45 KS -distance with N = 500 particles

46 KS -distance with N = 500 particles

47 Transition kernels.

48 Moving particles: { } N f (J) 1,..., f (J) Nm J=1

49 Moving particles: { } N f (J) 1,..., f (J) Nm J=1 f old = (f 1, f 2,..., f Nm ) (original mixture weights) f old Dir(α = (α 1, α 2,..., α Nm )) ξ i Gamma(α i, 1) = ξ + = ξ ξ Nm Gamma(α + = α i, 1) ( ξ1 f old =,..., ξ ) Nm Dir(α) ξ + ξ +

50 Moving particles: { } N f (J) 1,..., f (J) Nm J=1 Given weighting parameter p B i Beta(pα i, (1 p)α i ) ζ i Gamma((1 p)α i, 1) ξ i where ξ + = Nm i=1 ξ i. = ξ i B i + ζ i, i = 1,..., N m = ξi Gamma(α i, 1) ( ) ξ = 1 ξ+,..., ξ Nm ξ+ Dir(α)

51 Moving particles: { } N σ (J) 1,..., σ(j) Nm J=1

52 Recall: In a nutshell The basic idea behind ABC is that using a representative (enough) summary statistic η coupled with a small (enough) tolerance ɛ should produce a good (enough) approximation to the posterior... Marin et al. (2012)

53 Concluding remarks We considered examples related to Type Ia Supernova, Stellar IMF, Exoplanet Eccentricity Three main ABC decisions: summary statistic, distance function, tolerance Sequential ABC: need to specify a transition kernel and determine importance weights Approximate Bayesian Computation could be a useful tool in astronomy, but it should be used with care.

54 Concluding remarks We considered examples related to Type Ia Supernova, Stellar IMF, Exoplanet Eccentricity Three main ABC decisions: summary statistic, distance function, tolerance Sequential ABC: need to specify a transition kernel and determine importance weights Approximate Bayesian Computation could be a useful tool in astronomy, but it should be used with care. THANK YOU!!!

55 Additional useful resources Csilléry et al. (2010): Approximate Bayesian Computation (ABC) in practice Csillery et al. (2012): abc: an R package for approximate Bayesian computation (ABC) Jabot et al. (2013): EasyABC: performing efficient approximate Bayesian computation sampling schemes (R package)

56 Bibliography Beaumont, M. A., Cornuet, J.-M., Marin, J.-M., and Robert, C. P. (2009), Adaptive approximate Bayesian computation, Biometrika, 96, Csilléry, K., Blum, M. G., Gaggiotti, O. E., and François, O. (2010), Approximate Bayesian Computation (ABC) in practice, Trends in ecology & evolution, 25, Csillery, K., Francois, O., and Blum, M. G. B. (2012), abc: an R package for approximate Bayesian computation (ABC), Methods in Ecology and Evolution. Jabot, F., Faure, T., and Dumoullin, N. (2013), EasyABC: performing efficient approximate Bayesian computation. Marin, J.-M., Pudlo, P., Robert, C. P., and Ryder, R. J. (2012), Approximate Bayesian computational methods, Statistics and Computing, 22,

Bayes via forward simulation. Approximate Bayesian Computation

Bayes via forward simulation. Approximate Bayesian Computation : Approximate Bayesian Computation Jessi Cisewski Carnegie Mellon University June 2014 What is Approximate Bayesian Computing? Likelihood-free approach Works by simulating from the forward process What

More information

Approximate Bayesian Computation

Approximate Bayesian Computation Approximate Bayesian Computation Jessi Cisewski Department of Statistics Yale University October 26, 2016 SAMSI Astrostatistics Course Our goals... Approximate Bayesian Computation (ABC) 1 Background:

More information

Approximate Bayesian Computation for Astrostatistics

Approximate Bayesian Computation for Astrostatistics Approximate Bayesian Computation for Astrostatistics Jessi Cisewski Department of Statistics Yale University October 24, 2016 SAMSI Undergraduate Workshop Our goals Introduction to Bayesian methods Likelihoods,

More information

Approximate Bayesian Computation for the Stellar Initial Mass Function

Approximate Bayesian Computation for the Stellar Initial Mass Function Approximate Bayesian Computation for the Stellar Initial Mass Function Jessi Cisewski Department of Statistics Yale University SCMA6 Collaborators: Grant Weller (Savvysherpa), Chad Schafer (Carnegie Mellon),

More information

Addressing the Challenges of Luminosity Function Estimation via Likelihood-Free Inference

Addressing the Challenges of Luminosity Function Estimation via Likelihood-Free Inference Addressing the Challenges of Luminosity Function Estimation via Likelihood-Free Inference Chad M. Schafer www.stat.cmu.edu/ cschafer Department of Statistics Carnegie Mellon University June 2011 1 Acknowledgements

More information

Introduction to Bayesian Methods

Introduction to Bayesian Methods Introduction to Bayesian Methods Jessi Cisewski Department of Statistics Yale University Sagan Summer Workshop 2016 Our goal: introduction to Bayesian methods Likelihoods Priors: conjugate priors, non-informative

More information

Observational Astronomy - Lecture 4 Orbits, Motions, Kepler s and Newton s Laws

Observational Astronomy - Lecture 4 Orbits, Motions, Kepler s and Newton s Laws Observational Astronomy - Lecture 4 Orbits, Motions, Kepler s and Newton s Laws Craig Lage New York University - Department of Physics craig.lage@nyu.edu February 24, 2014 1 / 21 Tycho Brahe s Equatorial

More information

1. The two triangles shown below are similar. This means that all the angles are equal and the sides are proportional.

1. The two triangles shown below are similar. This means that all the angles are equal and the sides are proportional. 1. The two triangles shown below are similar. This means that all the angles are equal and the sides are proportional. a. How many times bigger is the big triangle in comparison to the little triangle?

More information

Earth Science Unit 6: Astronomy Period: Date: Elliptical Orbits

Earth Science Unit 6: Astronomy Period: Date: Elliptical Orbits Earth Science Name: Unit 6: Astronomy Period: Date: Lab # 5 Elliptical Orbits Objective: To compare the shape of the earth s orbit (eccentricity) with the orbits of and with a circle. other planets Focus

More information

Tutorial on ABC Algorithms

Tutorial on ABC Algorithms Tutorial on ABC Algorithms Dr Chris Drovandi Queensland University of Technology, Australia c.drovandi@qut.edu.au July 3, 2014 Notation Model parameter θ with prior π(θ) Likelihood is f(ý θ) with observed

More information

Hierarchical Bayesian Modeling of Planet Populations. Angie Wolfgang NSF Postdoctoral Fellow, Penn State

Hierarchical Bayesian Modeling of Planet Populations. Angie Wolfgang NSF Postdoctoral Fellow, Penn State Hierarchical Bayesian Modeling of Planet Populations Angie Wolfgang NSF Postdoctoral Fellow, Penn State The Big Picture We ve found > 3000 planets, and counting. Earth s place in the Universe... We re

More information

Astronomy Test Review. 3 rd Grade

Astronomy Test Review. 3 rd Grade Astronomy Test Review 3 rd Grade Match the vocabulary word to its definition. Outer Planets The path a planet takes around the sun. Inner Planets Orbit Sun The center of our solar system. Small, rocky

More information

Investigating the Solar System

Investigating the Solar System Investigating the Solar System This Workbook belongs to: Our Local Star: The Sun Location in The Solar System Interesting Facts 1. 2. 3. 4. Name of Star: THE SUN 5. Draw and Color your own Sun in the blank

More information

Hierarchical Bayesian Modeling

Hierarchical Bayesian Modeling Hierarchical Bayesian Modeling Making scientific inferences about a population based on many individuals Angie Wolfgang NSF Postdoctoral Fellow, Penn State Astronomical Populations Once we discover an

More information

Weakness of Beta priors (or conjugate priors in general) They can only represent a limited range of prior beliefs. For example... There are no bimodal beta distributions (except when the modes are at 0

More information

Approximate Bayesian Computation: a simulation based approach to inference

Approximate Bayesian Computation: a simulation based approach to inference Approximate Bayesian Computation: a simulation based approach to inference Richard Wilkinson Simon Tavaré 2 Department of Probability and Statistics University of Sheffield 2 Department of Applied Mathematics

More information

Weakness of Beta priors (or conjugate priors in general) They can only represent a limited range of prior beliefs. For example... There are no bimodal beta distributions (except when the modes are at 0

More information

USEFUL PROPERTIES OF THE MULTIVARIATE NORMAL*

USEFUL PROPERTIES OF THE MULTIVARIATE NORMAL* USEFUL PROPERTIES OF THE MULTIVARIATE NORMAL* 3 Conditionals and marginals For Bayesian analysis it is very useful to understand how to write joint, marginal, and conditional distributions for the multivariate

More information

October 19, NOTES Solar System Data Table.notebook. Which page in the ESRT???? million km million. average.

October 19, NOTES Solar System Data Table.notebook. Which page in the ESRT???? million km million. average. Celestial Object: Naturally occurring object that exists in space. NOT spacecraft or man-made satellites Which page in the ESRT???? Mean = average Units = million km How can we find this using the Solar

More information

Hierarchical Bayesian Modeling

Hierarchical Bayesian Modeling Hierarchical Bayesian Modeling Making scientific inferences about a population based on many individuals Angie Wolfgang NSF Postdoctoral Fellow, Penn State Astronomical Populations Once we discover an

More information

The Doppler Method, or Radial Velocity Detection of Planets: I. Technique

The Doppler Method, or Radial Velocity Detection of Planets: I. Technique ASTs309L The Doppler Method, or Radial Velocity Detection of Planets: I. Technique 1. Keplerian Orbits 2. Spectrographs/Doppler shifts 3. Precise Radial Velocity measurements ASTs309L The Doppler Effect:

More information

Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds.

Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds. Proceedings of the 2012 Winter Simulation Conference C. Laroque, J. Himmelspach, R. Pasupathy, O. Rose, and A. M. Uhrmacher, eds. OPTIMAL PARALLELIZATION OF A SEQUENTIAL APPROXIMATE BAYESIAN COMPUTATION

More information

III The properties of extrasolar planets

III The properties of extrasolar planets III The properties of extrasolar planets (as of early 2016) http://sgoodwin.staff.shef.ac.uk/phy229.html 3.0 Introduction This lecture will discuss what we have found so far. It is important to remember

More information

Bayesian Model Selection & Extrasolar Planet Detection

Bayesian Model Selection & Extrasolar Planet Detection Bayesian Model Selection & Extrasolar Planet Detection Eric B. Ford UC Berkeley Astronomy Dept. Wednesday, June 14, 2006 SCMA IV SAMSI Exoplanets Working Group: Jogesh Babu, Susie Bayarri, Jim Berger,

More information

Importance of the study of extrasolar planets. Exoplanets Introduction. Importance of the study of extrasolar planets

Importance of the study of extrasolar planets. Exoplanets Introduction. Importance of the study of extrasolar planets Importance of the study of extrasolar planets Exoplanets Introduction Planets and Astrobiology (2017-2018) G. Vladilo Technological and scientific spin-offs Exoplanet observations are driving huge technological

More information

Probabilistic Catalogs and beyond...

Probabilistic Catalogs and beyond... Department of Statistics The University of Auckland https://www.stat.auckland.ac.nz/ brewer/ Probabilistic catalogs So, what is a probabilistic catalog? And what s beyond? Finite Mixture Models Finite

More information

1. Galaxy (a) the length of a planet s day. 2. Rotational Period (b) dust and gases floating in space

1. Galaxy (a) the length of a planet s day. 2. Rotational Period (b) dust and gases floating in space Vocabulary: Match the vocabulary terms on the left with the definitions on the right 1. Galaxy (a) the length of a planet s day 2. Rotational Period (b) dust and gases floating in space 3. Orbital Period

More information

Celeste: Variational inference for a generative model of astronomical images

Celeste: Variational inference for a generative model of astronomical images Celeste: Variational inference for a generative model of astronomical images Jerey Regier Statistics Department UC Berkeley July 9, 2015 Joint work with Jon McAulie (UCB Statistics), Andrew Miller, Ryan

More information

Yes, inner planets tend to be and outer planets tend to be.

Yes, inner planets tend to be and outer planets tend to be. 1. Planet Density Make some general comments about inner and outer planets density Inner Planets Density Outer Planets Density Is there a pattern or a trend in planet density? Yes, inner planets tend to

More information

NAME: PERIOD: DATE: LAB PARTNERS: LAB #39 ECCENTRICITY OF PLANETARY ORBITS

NAME: PERIOD: DATE: LAB PARTNERS: LAB #39 ECCENTRICITY OF PLANETARY ORBITS NAME: PERIOD: DATE: LAB PARTNERS: LAB #39 ECCENTRICITY OF PLANETARY ORBITS INTRODUCTION Our sun is not exactly in the center of the orbits of the planets, and therefore the planetary orbits are not circular.

More information

Asteroids, Comets and NEOs. (Answers) Solar System Impacts. Author: Sarah Roberts

Asteroids, Comets and NEOs. (Answers) Solar System Impacts. Author: Sarah Roberts Asteroids, Comets and NEOs (Answers) Author: Sarah Roberts Asteroids, Comets and NEOs - Impact craters on the Earth 1. Using the data given below for real impact craters on the Earth, investigate the effect

More information

In so many and such important. ways, then, do the planets bear witness to the earth's mobility. Nicholas Copernicus

In so many and such important. ways, then, do the planets bear witness to the earth's mobility. Nicholas Copernicus In so many and such important ways, then, do the planets bear witness to the earth's mobility Nicholas Copernicus What We Will Learn Today What did it take to revise an age old belief? What is the Copernican

More information

Tycho Brahe

Tycho Brahe Tycho Brahe 1546-1601 At the time of Shakespeare and Elizabeth I and Champlain Lost part of his nose in a duel over who was the best mathematician At 27 he measured the distance of a supernova and a comet

More information

Luminosity Functions

Luminosity Functions Department of Statistics, Harvard University May 15th, 2012 Introduction: What is a Luminosity Function? Figure: A galaxy cluster. Introduction: Project Goal The Luminosity Function specifies the relative

More information

18. Kepler as a young man became the assistant to A) Nicolaus Copernicus. B) Ptolemy. C) Tycho Brahe. D) Sir Isaac Newton.

18. Kepler as a young man became the assistant to A) Nicolaus Copernicus. B) Ptolemy. C) Tycho Brahe. D) Sir Isaac Newton. Name: Date: 1. The word planet is derived from a Greek term meaning A) bright nighttime object. B) astrological sign. C) wanderer. D) nontwinkling star. 2. The planets that were known before the telescope

More information

Name Class Date. Chapter 23 Touring Our Solar System Investigation 23

Name Class Date. Chapter 23 Touring Our Solar System Investigation 23 Chapter 23 Touring Our Solar System Investigation 23 Exploring Orbits Introduction In 1609, the German mathematician and astronomer Johannes Kepler deciphered a major puzzle of the solar system. The strange

More information

Tutorial on Approximate Bayesian Computation

Tutorial on Approximate Bayesian Computation Tutorial on Approximate Bayesian Computation Michael Gutmann https://sites.google.com/site/michaelgutmann University of Helsinki Aalto University Helsinki Institute for Information Technology 16 May 2016

More information

Approximate Bayesian Computation

Approximate Bayesian Computation Approximate Bayesian Computation Sarah Filippi Department of Statistics University of Oxford 09/02/2016 Parameter inference in a signalling pathway A RAS Receptor Growth factor Cell membrane Phosphorylation

More information

Computer intensive statistical methods

Computer intensive statistical methods Lecture 13 MCMC, Hybrid chains October 13, 2015 Jonas Wallin jonwal@chalmers.se Chalmers, Gothenburg university MH algorithm, Chap:6.3 The metropolis hastings requires three objects, the distribution of

More information

PHYS 155 Introductory Astronomy

PHYS 155 Introductory Astronomy PHYS 155 Introductory Astronomy - observing sessions: Sunday Thursday, 9pm, weather permitting http://www.phys.uconn.edu/observatory - Exam - Tuesday March 20, - Review Monday 6:30-9pm, PB 38 Marek Krasnansky

More information

Physics Unit 7: Circular Motion, Universal Gravitation, and Satellite Orbits. Planetary Motion

Physics Unit 7: Circular Motion, Universal Gravitation, and Satellite Orbits. Planetary Motion Physics Unit 7: Circular Motion, Universal Gravitation, and Satellite Orbits Planetary Motion Geocentric Models --Many people prior to the 1500 s viewed the! Earth and the solar system using a! geocentric

More information

Coriolis Effect - the apparent curved paths of projectiles, winds, and ocean currents

Coriolis Effect - the apparent curved paths of projectiles, winds, and ocean currents Regents Earth Science Unit 5: Astronomy Models of the Universe Earliest models of the universe were based on the idea that the Sun, Moon, and planets all orbit the Earth models needed to explain how the

More information

Planet Club. Version AUG-2005

Planet Club. Version AUG-2005 Planet Club Raleigh Astronomy Club Version 1.2 05-AUG-2005 Introduction Welcome to the RAC Planet Club! This is one of the entry-level observing clubs, but still has some challenges for more advanced observers.

More information

Horseshoe, Lasso and Related Shrinkage Methods

Horseshoe, Lasso and Related Shrinkage Methods Readings Chapter 15 Christensen Merlise Clyde October 15, 2015 Bayesian Lasso Park & Casella (JASA 2008) and Hans (Biometrika 2010) propose Bayesian versions of the Lasso Bayesian Lasso Park & Casella

More information

Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian Computation

Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian Computation 22nd International Congress on Modelling and Simulation, Hobart, Tasmania, Australia, 3 to 8 December 2017 mssanz.org.au/modsim2017 Fitting the Bartlett-Lewis rainfall model using Approximate Bayesian

More information

Unit: Planetary Science

Unit: Planetary Science Orbital Motion Kepler s Laws GETTING AN ACCOUNT: 1) go to www.explorelearning.com 2) click on Enroll in a class (top right hand area of screen). 3) Where it says Enter class Code enter the number: MLTWD2YAZH

More information

I. Introduction. II. An Introduction to Starry Night NAME: ORBITAL MOTION

I. Introduction. II. An Introduction to Starry Night NAME: ORBITAL MOTION NAME: ORBITAL MOTION What will you learn in this Lab? You will be using some special software to simulate the motion of planets in our Solar System and across the night sky. You will be asked to try and

More information

Hierarchical Bayesian Modeling of Planet Populations

Hierarchical Bayesian Modeling of Planet Populations Hierarchical Bayesian Modeling of Planet Populations You ve found planets in your data (or not)...... now what?! Angie Wolfgang NSF Postdoctoral Fellow, Penn State Why Astrostats? This week: a sample of

More information

t S 18. Determining Planetary Co-ordinates

t S 18. Determining Planetary Co-ordinates 8. Determining Planetary Co-ordinates θ θ 0 ω R In the heliocentric reference frame which rotates with the Earth s orbital motion, suppose that initially a planet s unplanet line makes an angle θ 0 with

More information

Lecture 13 Fundamentals of Bayesian Inference

Lecture 13 Fundamentals of Bayesian Inference Lecture 13 Fundamentals of Bayesian Inference Dennis Sun Stats 253 August 11, 2014 Outline of Lecture 1 Bayesian Models 2 Modeling Correlations Using Bayes 3 The Universal Algorithm 4 BUGS 5 Wrapping Up

More information

CONDITIONING ON PARAMETER POINT ESTIMATES IN APPROXIMATE BAYESIAN COMPUTATION

CONDITIONING ON PARAMETER POINT ESTIMATES IN APPROXIMATE BAYESIAN COMPUTATION CONDITIONING ON PARAMETER POINT ESTIMATES IN APPROXIMATE BAYESIAN COMPUTATION by Emilie Haon Lasportes Florence Carpentier Olivier Martin Etienne K. Klein Samuel Soubeyrand Research Report No. 45 July

More information

Lasso & Bayesian Lasso

Lasso & Bayesian Lasso Readings Chapter 15 Christensen Merlise Clyde October 6, 2015 Lasso Tibshirani (JRSS B 1996) proposed estimating coefficients through L 1 constrained least squares Least Absolute Shrinkage and Selection

More information

Lecture #5: Plan. The Beginnings of Modern Astronomy Kepler s Laws Galileo

Lecture #5: Plan. The Beginnings of Modern Astronomy Kepler s Laws Galileo Lecture #5: Plan The Beginnings of Modern Astronomy Kepler s Laws Galileo Geocentric ( Ptolemaic ) Model Retrograde Motion: Apparent backward (= East-to-West) motion of a planet with respect to stars Ptolemy

More information

Sequential Monte Carlo Methods

Sequential Monte Carlo Methods University of Pennsylvania Bradley Visitor Lectures October 23, 2017 Introduction Unfortunately, standard MCMC can be inaccurate, especially in medium and large-scale DSGE models: disentangling importance

More information

Key Concepts Solar System, Movements, Shadows Recall that Earth is one of many planets in the solar system that orbit the Sun.

Key Concepts Solar System, Movements, Shadows Recall that Earth is one of many planets in the solar system that orbit the Sun. Key Concepts Solar System, Movements, Shadows 4-3.1 Recall that Earth is one of many planets in the solar system that orbit the Sun. It is essential for students to know that Earth is a planet that orbits

More information

Assignment 1. Due Jan. 31, 2017

Assignment 1. Due Jan. 31, 2017 Assignment 1 Due Jan. 31, 2017 Show all work and turn in answers on separate pages, not on these pages. Circle your final answers for clarity. Be sure to show/explain all of your reasoning and that your

More information

Learning Objectives. one night? Over the course of several nights? How do true motion and retrograde motion differ?

Learning Objectives. one night? Over the course of several nights? How do true motion and retrograde motion differ? Kepler s Laws Learning Objectives! Do the planets move east or west over the course of one night? Over the course of several nights? How do true motion and retrograde motion differ?! What are geocentric

More information

Introduction to Probabilistic Machine Learning

Introduction to Probabilistic Machine Learning Introduction to Probabilistic Machine Learning Piyush Rai Dept. of CSE, IIT Kanpur (Mini-course 1) Nov 03, 2015 Piyush Rai (IIT Kanpur) Introduction to Probabilistic Machine Learning 1 Machine Learning

More information

Computer intensive statistical methods

Computer intensive statistical methods Lecture 11 Markov Chain Monte Carlo cont. October 6, 2015 Jonas Wallin jonwal@chalmers.se Chalmers, Gothenburg university The two stage Gibbs sampler If the conditional distributions are easy to sample

More information

Developing/Secure Pathway. End of Topic Assessment. Space

Developing/Secure Pathway. End of Topic Assessment. Space Name: Group: Year 8 Developing/Secure Pathway End of Topic Assessment Space Analysis and Targets No. Score Below/On/Above Target for next Assessment. How will you achieve it? 1 /6 2 /4 3 /6 4 /6 5 /4 6

More information

PHYS 160 Astronomy Test #1 Fall 2017 Version B

PHYS 160 Astronomy Test #1 Fall 2017 Version B PHYS 160 Astronomy Test #1 Fall 2017 Version B 1 I. True/False (1 point each) Circle the T if the statement is true, or F if the statement is false on your answer sheet. 1. An object has the same weight,

More information

2. Very generally, describe how the Milky Way Galaxy formed. (Words or labeled picture)

2. Very generally, describe how the Milky Way Galaxy formed. (Words or labeled picture) Potter Name: Date: Hour: Score: /11 Learning Check 2.1 LT 2.1 Galaxy Formation: I am able to describe the formation of the Milky Way Galaxy and our solar system and model earth s position in each. 1. Label

More information

Large and small planets

Large and small planets Large and small planets Journey through the Solar System C 41 time 50 minutes. Preparation For the activity Planets show the planets under each other on the board, as shown in the table. learning outcomes

More information

An introduction to Approximate Bayesian Computation methods

An introduction to Approximate Bayesian Computation methods An introduction to Approximate Bayesian Computation methods M.E. Castellanos maria.castellanos@urjc.es (from several works with S. Cabras, E. Ruli and O. Ratmann) Valencia, January 28, 2015 Valencia Bayesian

More information

Which of the following planets are all made up of gas? When a planets orbit around the Sun looks like an oval, it s called a(n)

Which of the following planets are all made up of gas? When a planets orbit around the Sun looks like an oval, it s called a(n) When a planets orbit around the Sun looks like an oval, it s called a(n) - ellipse - circle - axis - rotation Which of the following planets are all made up of gas? - Venus, Mars, Saturn and Pluto - Jupiter,

More information

Gravity and the Orbits of Planets

Gravity and the Orbits of Planets Gravity and the Orbits of Planets 1. Gravity Galileo Newton Earth s Gravity Mass v. Weight Einstein and General Relativity Round and irregular shaped objects 2. Orbits and Kepler s Laws ESO Galileo, Gravity,

More information

3. Period Law: Simplified proof for circular orbits Equate gravitational and centripetal forces

3. Period Law: Simplified proof for circular orbits Equate gravitational and centripetal forces Physics 106 Lecture 10 Kepler s Laws and Planetary Motion-continued SJ 7 th ed.: Chap 1., 1.6 Kepler s laws of planetary otion Orbit Law Area Law Period Law Satellite and planetary orbits Orbits, potential,

More information

Lecture XIX: Particle motion exterior to a spherical star

Lecture XIX: Particle motion exterior to a spherical star Lecture XIX: Particle motion exterior to a spherical star Christopher M. Hirata Caltech M/C 350-7, Pasadena CA 95, USA Dated: January 8, 0 I. OVERVIEW Our next objective is to consider the motion of test

More information

Ay 20: Basic Astronomy and the Galaxy Fall Term Solution Set 4 Kunal Mooley (based on solutions by Swarnima Manohar, TA 2009)

Ay 20: Basic Astronomy and the Galaxy Fall Term Solution Set 4 Kunal Mooley (based on solutions by Swarnima Manohar, TA 2009) Ay 20: Basic Astronomy and the Galaxy Fall Term 2010 Solution Set 4 Kunal Mooley (based on solutions by Swarnima Manohar, TA 2009) Reporting an answer to unnecesary number of decimal places should be avoided.

More information

Precession of perihelion of the planet with the critical photon orbit

Precession of perihelion of the planet with the critical photon orbit Mahgoub Salih Precession of perihelion of the planet with the critical photon orbit Department of Physics, Faculty of Science and Art at al-muznab, Qassim University, KSA Abstract The solution of geodesic

More information

Computer Practical: Metropolis-Hastings-based MCMC

Computer Practical: Metropolis-Hastings-based MCMC Computer Practical: Metropolis-Hastings-based MCMC Andrea Arnold and Franz Hamilton North Carolina State University July 30, 2016 A. Arnold / F. Hamilton (NCSU) MH-based MCMC July 30, 2016 1 / 19 Markov

More information

Extrasolar Planets. Materials Light source to mimic star Ball to mimic planet Light meter Interface

Extrasolar Planets. Materials Light source to mimic star Ball to mimic planet Light meter Interface Name: Date: Extrasolar Planets Objectives: Learn about Extrasolar planets planets orbiting other stars Explain how astronomers detect and characterize Extrasolar planets Materials Light source to mimic

More information

Introduction To Modern Astronomy II

Introduction To Modern Astronomy II ASTR 111 003 Fall 2006 Lecture 03 Sep. 18, 2006 Introduction To Modern Astronomy II Introducing Astronomy (chap. 1-6) Planets and Moons (chap. 7-17) Ch1: Astronomy and the Universe Ch2: Knowing the Heavens

More information

Sol o ar a r S yste t m e F o F r o m r at a i t on o The Ne N b e u b l u a a Hypothesis

Sol o ar a r S yste t m e F o F r o m r at a i t on o The Ne N b e u b l u a a Hypothesis Solar System Solar system- the sun and all objects that orbit the sun due to its gravity Solar System Formation The Nebula Hypothesis Parts of the Solar System Planet- a celestial body that is in orbit

More information

What is it like? When did it form? How did it form. The Solar System. Fall, 2005 Astronomy 110 1

What is it like? When did it form? How did it form. The Solar System. Fall, 2005 Astronomy 110 1 What is it like? When did it form? How did it form The Solar System Fall, 2005 Astronomy 110 1 Fall, 2005 Astronomy 110 2 The planets all orbit the sun in the same direction. The Sun spins in the same

More information

4 A(n) is a small, rocky object that orbits the sun; many of these objects are located in a band between the orbits of Mars and Jupiter.

4 A(n) is a small, rocky object that orbits the sun; many of these objects are located in a band between the orbits of Mars and Jupiter. Name Vocabulary Fill in the blank with the term that best completes the sentence., 6.11B 1 is the process in which energy is released as the nuclei of small atoms combine to form a larger nucleus., 6.11B

More information

Earth s Motions. Rotation -!! Period of Rotation - amount of time to make one complete rotation Example: Earth rotates in hours.

Earth s Motions. Rotation -!! Period of Rotation - amount of time to make one complete rotation Example: Earth rotates in hours. Name: Date: Period: Earth In the Solar System The Physical Setting: Earth Science CLASS NOTES! Rotation -! Period of Rotation - amount of time to make one complete rotation Example: Earth rotates in hours

More information

Future Opportunities for Collaborations: Exoplanet Astronomers & Statisticians

Future Opportunities for Collaborations: Exoplanet Astronomers & Statisticians Future Opportunities for Collaborations: Exoplanet Astronomers & Statisticians Eric B. Ford Penn State Astronomy & Astrophysics Center for Astrostatistics Center for Exoplanets & Habitable Worlds Institute

More information

astronomy A planet was viewed from Earth for several hours. The diagrams below represent the appearance of the planet at four different times.

astronomy A planet was viewed from Earth for several hours. The diagrams below represent the appearance of the planet at four different times. astronomy 2008 1. A planet was viewed from Earth for several hours. The diagrams below represent the appearance of the planet at four different times. 5. If the distance between the Earth and the Sun were

More information

Edmonds Community College ASTRONOMY 100 Sample Test #2 Fall Quarter 2006

Edmonds Community College ASTRONOMY 100 Sample Test #2 Fall Quarter 2006 Edmonds Community College ASTRONOMY 100 Sample Test #2 Fall Quarter 2006 Instructor: L. M. Khandro 10/19/06 Please Note: the following test derives from a course and text that covers the entire topic of

More information

Lecture 25: The Outer Planets

Lecture 25: The Outer Planets Lecture 25: The Outer Planets Neptune Uranus Pluto/Charon Uranus and three moons Neptune and two moons 1 The Outer Planets Uranus Discovered by William Herschel in 1781, who realized that this extended

More information

Additional Exercises for Chapter 4

Additional Exercises for Chapter 4 Additional Exercises for Chapter 4 Computations of Copernicus and Brahe The fact that any tangent to a circle is perpendicular to the radius to the point of tangency was verified in the Additional Exercises

More information

Hmms with variable dimension structures and extensions

Hmms with variable dimension structures and extensions Hmm days/enst/january 21, 2002 1 Hmms with variable dimension structures and extensions Christian P. Robert Université Paris Dauphine www.ceremade.dauphine.fr/ xian Hmm days/enst/january 21, 2002 2 1 Estimating

More information

Topic 1: Celestial Objects, phenomena, and interactions are important to people in many different ways.

Topic 1: Celestial Objects, phenomena, and interactions are important to people in many different ways. Topic 1: Celestial Objects, phenomena, and interactions are important to people in many different ways. To complete this booklet you must do the following: Define each term within this booklet Answer Each

More information

hundred millions ten millions millions

hundred millions ten millions millions Lesson Numeration Trillions Genesis :-9 And God said, Let there be lights in the epanse of the sky to separate the day from the night, and let them serve as signs to mark seasons and days and years, and

More information

Introduction to the Universe. What makes up the Universe?

Introduction to the Universe. What makes up the Universe? Introduction to the Universe What makes up the Universe? Objects in the Universe Astrophysics is the science that tries to make sense of the universe by - describing the Universe (Astronomy) - understanding

More information

ST 740: Multiparameter Inference

ST 740: Multiparameter Inference ST 740: Multiparameter Inference Alyson Wilson Department of Statistics North Carolina State University September 23, 2013 A. Wilson (NCSU Statistics) Multiparameter Inference September 23, 2013 1 / 21

More information

Chapter 14 Satellite Motion

Chapter 14 Satellite Motion 1 Academic Physics Mechanics Chapter 14 Satellite Motion The Mechanical Universe Kepler's Three Laws (Episode 21) The Kepler Problem (Episode 22) Energy and Eccentricity (Episode 23) Navigating in Space

More information

Attendance Quiz. Are you here today? (a) yes (b) no (c) Captain, the sensors indicate a class M planet orbiting this star. Here!

Attendance Quiz. Are you here today? (a) yes (b) no (c) Captain, the sensors indicate a class M planet orbiting this star. Here! Extrasolar Planets Attendance Quiz Are you here today? Here! (a) yes (b) no (c) Captain, the sensors indicate a class M planet orbiting this star Guest Lectures Thursday, May 4 Life in the Zooniverse:

More information

Markov Chain Monte Carlo methods

Markov Chain Monte Carlo methods Markov Chain Monte Carlo methods Tomas McKelvey and Lennart Svensson Signal Processing Group Department of Signals and Systems Chalmers University of Technology, Sweden November 26, 2012 Today s learning

More information

Finding Extra-Solar Earths with Kepler. William Cochran McDonald Observatory

Finding Extra-Solar Earths with Kepler. William Cochran McDonald Observatory Finding Extra-Solar Earths with Kepler William Cochran McDonald Observatory Who is Bill Cochran? Senior Research Scien;st McDonald Observatory Originally interested in outer planet atmospheres Started

More information

18 An Eclipsing Extrasolar Planet

18 An Eclipsing Extrasolar Planet Name: Date: 18 An Eclipsing Extrasolar Planet 18.1 Introduction One of the more recent new fields in astronomy is the search for (and discovery of) planets orbiting around stars other than our Sun, or

More information

Gravitation. Luis Anchordoqui

Gravitation. Luis Anchordoqui Gravitation Kepler's law and Newton's Synthesis The nighttime sky with its myriad stars and shinning planets has always fascinated people on Earth. Towards the end of the XVI century the astronomer Tycho

More information

Which of the following correctly describes the meaning of albedo?

Which of the following correctly describes the meaning of albedo? Which of the following correctly describes the meaning of albedo? A) The lower the albedo, the more light the surface reflects, and the less it absorbs. B) The higher the albedo, the more light the surface

More information

Kozai-Lidov oscillations

Kozai-Lidov oscillations Kozai-Lidov oscillations Kozai (1962 - asteroids); Lidov (1962 - artificial satellites) arise most simply in restricted three-body problem (two massive bodies on a Kepler orbit + a test particle) e.g.,

More information

ABCME: Summary statistics selection for ABC inference in R

ABCME: Summary statistics selection for ABC inference in R ABCME: Summary statistics selection for ABC inference in R Matt Nunes and David Balding Lancaster University UCL Genetics Institute Outline Motivation: why the ABCME package? Description of the package

More information

Non-parametric Clustering with Dirichlet Processes

Non-parametric Clustering with Dirichlet Processes Non-parametric Clustering with Dirichlet Processes Timothy Burns SUNY at Buffalo Mar. 31 2009 T. Burns (SUNY at Buffalo) Non-parametric Clustering with Dirichlet Processes Mar. 31 2009 1 / 24 Introduction

More information

9/12/2010. The Four Fundamental Forces of Nature. 1. Gravity 2. Electromagnetism 3. The Strong Nuclear Force 4. The Weak Nuclear Force

9/12/2010. The Four Fundamental Forces of Nature. 1. Gravity 2. Electromagnetism 3. The Strong Nuclear Force 4. The Weak Nuclear Force The Four Fundamental Forces of Nature 1. Gravity 2. Electromagnetism 3. The Strong Nuclear Force 4. The Weak Nuclear Force The Universe is made of matter Gravity the force of attraction between matter

More information

Foundations of Astrophysics

Foundations of Astrophysics Foundations of Astrophysics Barbara Ryden The Ohio State University Bradley M. Peterson The Ohio State University Preface xi 1 Early Astronomy 1 1.1 The Celestial Sphere 1 1.2 Coordinate Systems on a Sphere

More information

Kepler correctly determined the motion of the planets giving his 3 Laws which still hold today for the planets and other orbital motion: moons around

Kepler correctly determined the motion of the planets giving his 3 Laws which still hold today for the planets and other orbital motion: moons around Kepler correctly determined the motion of the planets giving his 3 Laws which still hold today for the planets and other orbital motion: moons around planets, exoplanets around other stars, stars in the

More information