Skip to content

Commit

Permalink
commit docs dev version
Browse files Browse the repository at this point in the history
  • Loading branch information
actions-user committed Oct 11, 2023
1 parent 821e6cc commit 32647da
Show file tree
Hide file tree
Showing 827 changed files with 1,570 additions and 1,535 deletions.
Binary file modified docs/dev/.doctrees/api/gammapy.data.FixedPointingInfo.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/api/gammapy.stats.CashCountsStatistic.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/environment.pickle
Binary file not shown.
Binary file modified docs/dev/.doctrees/index.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-1d/cta_sensitivity.doctree
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-1d/sed_fitting.doctree
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-2d/detect.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-2d/modeling_2D.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-2d/ring_background.doctree
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-3d/analysis_3d.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-3d/analysis_mwl.doctree
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-3d/event_sampling.doctree
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-3d/flux_profiles.doctree
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-3d/simulate_3d.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/analysis-time/light_curve.doctree
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/astro_dark_matter.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/catalog.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/datasets.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/fitting.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/makers.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/maps.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/mask_maps.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/model_management.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/models.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/api/sg_execution_times.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/data/cta.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/data/fermi_lat.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/data/hawc.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/data/hess.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/data/sg_execution_times.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/scripts/sg_execution_times.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/starting/analysis_1.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/starting/analysis_2.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/starting/overview.doctree
Binary file not shown.
Binary file modified docs/dev/.doctrees/tutorials/starting/sg_execution_times.doctree
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Original file line number Diff line number Diff line change
Expand Up @@ -33,7 +33,7 @@
},
"outputs": [],
"source": [
"from pathlib import Path\nimport numpy as np\nimport astropy.units as u\nfrom astropy.coordinates import Angle, SkyCoord\nfrom astropy.io import fits\nfrom astropy.time import Time\nfrom regions import CircleSkyRegion\nimport matplotlib.pyplot as plt\n\n# %matplotlib inline\nfrom IPython.display import display\nfrom gammapy.data import DataStore, Observation, observatory_locations\nfrom gammapy.datasets import MapDataset, MapDatasetEventSampler\nfrom gammapy.irf import load_irf_dict_from_file\nfrom gammapy.makers import MapDatasetMaker\nfrom gammapy.maps import Map, MapAxis, WcsGeom\nfrom gammapy.modeling import Fit\nfrom gammapy.modeling.models import (\n ExpDecayTemporalModel,\n FoVBackgroundModel,\n Models,\n PointSpatialModel,\n PowerLawNormSpectralModel,\n PowerLawSpectralModel,\n SkyModel,\n TemplateSpatialModel,\n)"
"from pathlib import Path\nimport numpy as np\nimport astropy.units as u\nfrom astropy.coordinates import Angle, SkyCoord\nfrom astropy.io import fits\nfrom astropy.time import Time\nfrom regions import CircleSkyRegion\nimport matplotlib.pyplot as plt\nfrom IPython.display import display\nfrom gammapy.data import (\n DataStore,\n FixedPointingInfo,\n Observation,\n observatory_locations,\n)\nfrom gammapy.datasets import MapDataset, MapDatasetEventSampler\nfrom gammapy.irf import load_irf_dict_from_file\nfrom gammapy.makers import MapDatasetMaker\nfrom gammapy.maps import Map, MapAxis, WcsGeom\nfrom gammapy.modeling import Fit\nfrom gammapy.modeling.models import (\n ExpDecayTemporalModel,\n FoVBackgroundModel,\n Models,\n PointSpatialModel,\n PowerLawNormSpectralModel,\n PowerLawSpectralModel,\n SkyModel,\n TemplateSpatialModel,\n)"
]
},
{
Expand All @@ -58,7 +58,7 @@
"cell_type": "markdown",
"metadata": {},
"source": [
"### Define an Observation\n\nYou can firstly create a `~gammapy.data.Observations` object that\ncontains the pointing position, the GTIs and the IRF you want to\nconsider.\n\nHereafter, we chose the IRF of the South configuration used for the CTA\nDC1 and we set the pointing position of the simulated field at the\nGalactic Center. We also fix the exposure time to 1 hr.\n\nLet\u2019s start with some initial settings:\n\n\n"
"## Define an Observation\n\nYou can firstly create a `~gammapy.data.Observations` object that\ncontains the pointing position, the GTIs and the IRF you want to\nconsider.\n\nHereafter, we chose the IRF of the South configuration used for the CTA\nDC1 and we set the pointing position of the simulated field at the\nGalactic Center. We also fix the exposure time to 1 hr.\n\nLet\u2019s start with some initial settings:\n\n"
]
},
{
Expand All @@ -69,7 +69,7 @@
},
"outputs": [],
"source": [
"path = Path(\"$GAMMAPY_DATA/cta-caldb\")\nirf_filename = \"Prod5-South-20deg-AverageAz-14MSTs37SSTs.180000s-v0.1.fits.gz\"\n\npointing = SkyCoord(0.0, 0.0, frame=\"galactic\", unit=\"deg\")\nlivetime = 1 * u.hr"
"path = Path(\"$GAMMAPY_DATA/cta-caldb\")\nirf_filename = \"Prod5-South-20deg-AverageAz-14MSTs37SSTs.180000s-v0.1.fits.gz\"\n\n# telescope is pointing at a fixed position in ICRS for the observation\npointing = FixedPointingInfo(\n fixed_icrs=SkyCoord(0.0, 0.0, frame=\"galactic\", unit=\"deg\").icrs,\n)\nlivetime = 1 * u.hr\nlocation = observatory_locations[\"cta_south\"]\n\n\nirfs = load_irf_dict_from_file(path / irf_filename)"
]
},
{
Expand All @@ -87,14 +87,14 @@
},
"outputs": [],
"source": [
"irfs = load_irf_dict_from_file(path / irf_filename)\nlocation = observatory_locations[\"cta_south\"]\n\nobservation = Observation.create(\n obs_id=1001,\n pointing=pointing,\n livetime=livetime,\n irfs=irfs,\n location=location,\n)"
"observation = Observation.create(\n obs_id=1001,\n pointing=pointing,\n livetime=livetime,\n irfs=irfs,\n location=location,\n)\nprint(observation)"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"### Define the MapDataset\n\nLet\u2019s generate the `~gammapy.datasets.Dataset` object (for more info\non `~gammapy.datasets.Dataset` objects, please checkout\n:doc:`/tutorials/api/datasets` tutorial):\nwe define the energy axes (true and reconstructed), the migration axis\nand the geometry of the observation.\n\n*This is a crucial point for the correct configuration of the event\nsampler. Indeed, the spatial and energetic binning should be treated\ncarefully and\u2026 the finer the better. For this reason, we suggest to\ndefine the energy axes (true and reconstructed) by setting a minimum\nbinning of least 10-20 bins per decade for all the sources of interest.\nThe spatial binning may instead be different from source to source and,\nat first order, it should be adopted a binning significantly smaller\nthan the expected source size.*\n\nFor the examples that will be shown hereafter, we set the geometry of\nthe dataset to a field of view of 2degx2deg and we bin the spatial map\nwith pixels of 0.02 deg.\n\n\n"
"## Define the MapDataset\n\nLet\u2019s generate the `~gammapy.datasets.Dataset` object (for more info\non `~gammapy.datasets.Dataset` objects, please checkout\n:doc:`/tutorials/api/datasets` tutorial):\nwe define the energy axes (true and reconstructed), the migration axis\nand the geometry of the observation.\n\n*This is a crucial point for the correct configuration of the event\nsampler. Indeed, the spatial and energetic binning should be treated\ncarefully and\u2026 the finer the better. For this reason, we suggest to\ndefine the energy axes (true and reconstructed) by setting a minimum\nbinning of least 10-20 bins per decade for all the sources of interest.\nThe spatial binning may instead be different from source to source and,\nat first order, it should be adopted a binning significantly smaller\nthan the expected source size.*\n\nFor the examples that will be shown hereafter, we set the geometry of\nthe dataset to a field of view of 2degx2deg and we bin the spatial map\nwith pixels of 0.02 deg.\n\n\n"
]
},
{
Expand All @@ -105,7 +105,7 @@
},
"outputs": [],
"source": [
"energy_axis = MapAxis.from_energy_bounds(\"0.1 TeV\", \"100 TeV\", nbin=10, per_decade=True)\nenergy_axis_true = MapAxis.from_energy_bounds(\n \"0.03 TeV\", \"300 TeV\", nbin=20, per_decade=True, name=\"energy_true\"\n)\nmigra_axis = MapAxis.from_bounds(0.5, 2, nbin=150, node_type=\"edges\", name=\"migra\")\n\ngeom = WcsGeom.create(\n skydir=pointing,\n width=(2, 2),\n binsz=0.02,\n frame=\"galactic\",\n axes=[energy_axis],\n)"
"energy_axis = MapAxis.from_energy_bounds(\"0.1 TeV\", \"100 TeV\", nbin=10, per_decade=True)\nenergy_axis_true = MapAxis.from_energy_bounds(\n \"0.03 TeV\", \"300 TeV\", nbin=20, per_decade=True, name=\"energy_true\"\n)\nmigra_axis = MapAxis.from_bounds(0.5, 2, nbin=150, node_type=\"edges\", name=\"migra\")\n\ngeom = WcsGeom.create(\n skydir=pointing.fixed_icrs,\n width=(2, 2),\n binsz=0.02,\n frame=\"galactic\",\n axes=[energy_axis],\n)"
]
},
{
Expand All @@ -130,7 +130,7 @@
"cell_type": "markdown",
"metadata": {},
"source": [
"### Define the Sky model: a point-like source\n\nNow let\u2019s define a sky model for a point-like source centered 0.5\ndeg far from the Galactic Center and with a power-law spectrum. We then\nsave the model into a yaml file.\n\n\n"
"## Define the Sky model: a point-like source\n\nNow let\u2019s define a sky model for a point-like source centered 0.5\ndeg far from the Galactic Center and with a power-law spectrum. We then\nsave the model into a yaml file.\n\n\n"
]
},
{
Expand Down Expand Up @@ -274,7 +274,7 @@
"cell_type": "markdown",
"metadata": {},
"source": [
"### Fit the simulated data\n\nWe can now check the sake of the event sampling by fitting the data.\n We make use of the same\n`~gammapy.modeling.models.Models` adopted for the simulation. Hence,\nwe firstly read the `~gammapy.datasets.Dataset` and the model file,\nand we fill the `~gammapy.datasets.Dataset` with the sampled events.\nWe set the `counts` map to the `dataset`:\n\n\n"
"## Fit the simulated data\n\nWe can now check the sake of the event sampling by fitting the data.\n We make use of the same\n`~gammapy.modeling.models.Models` adopted for the simulation. Hence,\nwe firstly read the `~gammapy.datasets.Dataset` and the model file,\nand we fill the `~gammapy.datasets.Dataset` with the sampled events.\nWe set the `counts` map to the `dataset`:\n\n\n"
]
},
{
Expand Down Expand Up @@ -450,7 +450,7 @@
},
"outputs": [],
"source": [
"template_model = TemplateSpatialModel.read(\n \"$GAMMAPY_DATA/fermi-3fhl-gc/gll_iem_v06_gc.fits.gz\", normalize=False\n)\n# we make the model brighter artificially so that it becomes visible over the background\ndiffuse = SkyModel(\n spectral_model=PowerLawNormSpectralModel(norm=5),\n spatial_model=template_model,\n name=\"template-model\",\n)\n\nbkg_model = FoVBackgroundModel(dataset_name=\"my-dataset\")\n\nmodels_diffuse = Models([diffuse, bkg_model])\n\nfile_model = \"./event_sampling/diffuse.yaml\"\nmodels_diffuse.write(file_model, overwrite=True)\n\ndataset.models = models_diffuse\nprint(dataset.models)"
"template_model = TemplateSpatialModel.read(\n \"$GAMMAPY_DATA/fermi-3fhl-gc/gll_iem_v06_gc.fits.gz\", normalize=False\n)\n# we make the model brighter artificially so that it becomes visible over the background\ndiffuse = SkyModel(\n spectral_model=PowerLawNormSpectralModel(norm=5),\n spatial_model=template_model,\n name=\"template-model\",\n)\n\nbkg_model = FoVBackgroundModel(dataset_name=\"my-dataset\")\n\nmodels_diffuse = Models([diffuse, bkg_model])\n\nfile_model = \"./event_sampling/diffuse.yaml\"\nmodels_diffuse.write(file_model, overwrite=True)\n\ndataset.models = models_diffuse\nprint(dataset.models)\n\n\"\""
]
},
{
Expand Down
Binary file not shown.
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file not shown.
Original file line number Diff line number Diff line change
Expand Up @@ -74,7 +74,6 @@
- `~gammapy.data.EventList`
"""


######################################################################
# Setup
# -----
Expand All @@ -90,10 +89,13 @@
from astropy.time import Time
from regions import CircleSkyRegion
import matplotlib.pyplot as plt

# %matplotlib inline
from IPython.display import display
from gammapy.data import DataStore, Observation, observatory_locations
from gammapy.data import (
DataStore,
FixedPointingInfo,
Observation,
observatory_locations,
)
from gammapy.datasets import MapDataset, MapDatasetEventSampler
from gammapy.irf import load_irf_dict_from_file
from gammapy.makers import MapDatasetMaker
Expand All @@ -117,10 +119,9 @@

check_tutorials_setup()


######################################################################
# Define an Observation
# ~~~~~~~~~~~~~~~~~~~~~
# ---------------------
#
# You can firstly create a `~gammapy.data.Observations` object that
# contains the pointing position, the GTIs and the IRF you want to
Expand All @@ -131,34 +132,36 @@
# Galactic Center. We also fix the exposure time to 1 hr.
#
# Let’s start with some initial settings:
#

path = Path("$GAMMAPY_DATA/cta-caldb")
irf_filename = "Prod5-South-20deg-AverageAz-14MSTs37SSTs.180000s-v0.1.fits.gz"

pointing = SkyCoord(0.0, 0.0, frame="galactic", unit="deg")
# telescope is pointing at a fixed position in ICRS for the observation
pointing = FixedPointingInfo(
fixed_icrs=SkyCoord(0.0, 0.0, frame="galactic", unit="deg").icrs,
)
livetime = 1 * u.hr
location = observatory_locations["cta_south"]


irfs = load_irf_dict_from_file(path / irf_filename)

######################################################################
# Now you can create the observation:
#

irfs = load_irf_dict_from_file(path / irf_filename)
location = observatory_locations["cta_south"]

observation = Observation.create(
obs_id=1001,
pointing=pointing,
livetime=livetime,
irfs=irfs,
location=location,
)

print(observation)

######################################################################
# Define the MapDataset
# ~~~~~~~~~~~~~~~~~~~~~
# ---------------------
#
# Let’s generate the `~gammapy.datasets.Dataset` object (for more info
# on `~gammapy.datasets.Dataset` objects, please checkout
Expand Down Expand Up @@ -187,14 +190,13 @@
migra_axis = MapAxis.from_bounds(0.5, 2, nbin=150, node_type="edges", name="migra")

geom = WcsGeom.create(
skydir=pointing,
skydir=pointing.fixed_icrs,
width=(2, 2),
binsz=0.02,
frame="galactic",
axes=[energy_axis],
)


######################################################################
# In the following, the dataset is created by selecting the effective
# area, background model, the PSF and the Edisp from the IRF. The dataset
Expand All @@ -215,10 +217,9 @@
Path("event_sampling").mkdir(exist_ok=True)
dataset.write("./event_sampling/dataset.fits", overwrite=True)


######################################################################
# Define the Sky model: a point-like source
# ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
# -----------------------------------------
#
# Now let’s define a sky model for a point-like source centered 0.5
# deg far from the Galactic Center and with a power-law spectrum. We then
Expand Down Expand Up @@ -257,7 +258,6 @@
dataset.models = models
print(dataset.models)


######################################################################
# The next step shows how to sample the events with the
# `~gammapy.datasets.MapDatasetEventSampler` class. The class requests a
Expand All @@ -272,7 +272,6 @@
sampler = MapDatasetEventSampler(random_state=0)
events = sampler.run(dataset, observation)


######################################################################
# The output of the event-sampler is an event list with coordinates,
# energies (true and reconstructed) and time of arrivals of the source and
Expand All @@ -285,15 +284,13 @@
print(f"Source events: {(events.table['MC_ID'] == 1).sum()}")
print(f"Background events: {(events.table['MC_ID'] == 0).sum()}")


######################################################################
# We can inspect the properties of the simulated events as follows:
#

events.select_offset([0, 1] * u.deg).peek()
plt.show()


######################################################################
# By default, the `~gammapy.datasets.MapDatasetEventSampler` fills the
# metadata keyword `OBJECT` in the event list using the first model of
Expand All @@ -302,7 +299,6 @@

events.table.meta["OBJECT"] = dataset.models[0].name


######################################################################
# Let’s write the event list and its GTI extension to a FITS file. We make
# use of `fits` library in `astropy`:
Expand All @@ -314,7 +310,6 @@
hdu_all = fits.HDUList([primary_hdu, hdu_evt, hdu_gti])
hdu_all.writeto("./event_sampling/events_0001.fits", overwrite=True)


######################################################################
# Generate a skymap
# ~~~~~~~~~~~~~~~~~
Expand All @@ -327,10 +322,9 @@
counts.sum_over_axes().plot(add_cbar=True)
plt.show()


######################################################################
# Fit the simulated data
# ~~~~~~~~~~~~~~~~~~~~~~
# ----------------------
#
# We can now check the sake of the event sampling by fitting the data.
# We make use of the same
Expand All @@ -345,7 +339,6 @@
dataset.counts = counts
dataset.models = models_fit


######################################################################
# Let’s fit the data and look at the results:
#
Expand All @@ -355,12 +348,10 @@
result = fit.run(dataset)
print(result)


######################################################################
# The results looks great!
#


######################################################################
# Time variable source using a lightcurve
# ---------------------------------------
Expand All @@ -379,15 +370,13 @@
times = t_ref + livetime * np.linspace(0, 1, 100)
expdecay_model = ExpDecayTemporalModel(t_ref=t_ref.mjd * u.d, t0=t0)


######################################################################
# where we defined the time axis starting from the reference time
# `t_ref` up to the requested exposure (`livetime`). The bin size of
# the time-axis is quite arbitrary but, as above for spatial and energy
# binning, the finer the better.
#


######################################################################
# Then, we can create the sky model. Just for the sake of the example,
# let’s boost the flux of the simulated source of an order of magnitude:
Expand Down Expand Up @@ -418,7 +407,6 @@
dataset.models = models
print(dataset.models)


######################################################################
# And now, let’s simulate the variable source:
#
Expand All @@ -430,7 +418,6 @@
print(f"Source events: {(events.table['MC_ID'] == 1).sum()}")
print(f"Background events: {(events.table['MC_ID'] == 0).sum()}")


######################################################################
# We can now inspect the properties of the simulated source. To do that,
# we adopt the `select_region` function that extracts only the events
Expand All @@ -444,21 +431,18 @@

src_events = events.select_region(on_region)


######################################################################
# Then we can have a quick look to the data with the `peek` function:
#

src_events.peek()
plt.show()


######################################################################
# In the right figure of the bottom panel, it is shown the source
# lightcurve that follows a decay trend as expected.
#


######################################################################
# Extended source using a template
# --------------------------------
Expand Down Expand Up @@ -491,14 +475,14 @@
dataset.models = models_diffuse
print(dataset.models)

""
# %%time
sampler = MapDatasetEventSampler(random_state=0)
events = sampler.run(dataset, observation)

events.select_offset([0, 1] * u.deg).peek()
plt.show()


######################################################################
# Simulate multiple event lists
# -----------------------------
Expand Down Expand Up @@ -540,7 +524,6 @@
events_paths.append(path)
events.table.write(path, overwrite=True)


######################################################################
# You can now load the event list and the corresponding IRFs with
# `DataStore.from_events_files` :
Expand All @@ -562,7 +545,6 @@
observations[0].peek()
plt.show()


######################################################################
# Exercises
# ---------
Expand Down
Binary file not shown.
Binary file modified docs/dev/_downloads/432ee3a608125ae95df2e8d950f07716/dl3-1.pdf
Binary file not shown.
Binary file not shown.
Binary file not shown.
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/_downloads/84424d59ec624940199b69d87a792d50/index-1.pdf
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/_downloads/c6bad13b7bd034ce07497e4d5025d5d2/edisp-1.pdf
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file not shown.
Binary file modified docs/dev/_images/plot_spiral_arms.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_002.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_003.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_004.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_005.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_event_sampling_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_light_curve_simulation_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_light_curve_simulation_002.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_light_curve_simulation_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_constant_temporal_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_constant_temporal_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_linear_temporal_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_linear_temporal_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_powerlaw_temporal_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_powerlaw_temporal_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_sine_temporal_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_plot_sine_temporal_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_simulate_3d_001.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_simulate_3d_002.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_simulate_3d_thumb.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
Binary file modified docs/dev/_images/sphx_glr_spectral_analysis_rad_max_005.png
Loading
Sorry, something went wrong. Reload?
Sorry, we cannot display this file.
Sorry, this file is invalid so it cannot be displayed.
2 changes: 1 addition & 1 deletion docs/dev/_modules/gammapy/analysis/config.html
Original file line number Diff line number Diff line change
Expand Up @@ -188,7 +188,7 @@

$("#version_switcher_menu").append(node);
// replace dropdown button text with the preferred display name of
// this version, rather than using sphinx's 1.2.dev611+gb038566e9 variable.
// this version, rather than using sphinx's 1.2.dev622+g40cb08231 variable.
// also highlight the dropdown entry for the currently-viewed
// version's entry
if (entry.version == "dev") {
Expand Down
2 changes: 1 addition & 1 deletion docs/dev/_modules/gammapy/analysis/core.html
Original file line number Diff line number Diff line change
Expand Up @@ -188,7 +188,7 @@

$("#version_switcher_menu").append(node);
// replace dropdown button text with the preferred display name of
// this version, rather than using sphinx's 1.2.dev611+gb038566e9 variable.
// this version, rather than using sphinx's 1.2.dev622+g40cb08231 variable.
// also highlight the dropdown entry for the currently-viewed
// version's entry
if (entry.version == "dev") {
Expand Down
2 changes: 1 addition & 1 deletion docs/dev/_modules/gammapy/astro/darkmatter/profiles.html
Original file line number Diff line number Diff line change
Expand Up @@ -188,7 +188,7 @@

$("#version_switcher_menu").append(node);
// replace dropdown button text with the preferred display name of
// this version, rather than using sphinx's 1.2.dev611+gb038566e9 variable.
// this version, rather than using sphinx's 1.2.dev622+g40cb08231 variable.
// also highlight the dropdown entry for the currently-viewed
// version's entry
if (entry.version == "dev") {
Expand Down
Loading

0 comments on commit 32647da

Please sign in to comment.