MapDataset¶
- 
class gammapy.datasets.MapDataset(models=None, counts=None, exposure=None, background=None, psf=None, edisp=None, mask_safe=None, mask_fit=None, gti=None, meta_table=None, name=None)[source]¶
- Bases: - gammapy.datasets.Dataset- Perform sky model likelihood fit on maps. - If an - HDULocationis passed the map is loaded lazily. This means the map data is only loaded in memory as the corresponding data attribute on the MapDataset is accessed. If it was accessed once it is cached for the next time.- Parameters
- modelsModels
- Source sky models. 
- countsWcsNDMaporHDULocation
- Counts cube 
- exposureWcsNDMaporHDULocation
- Exposure cube 
- backgroundWcsNDMaporHDULocation
- Background cube 
- mask_fitWcsNDMaporHDULocation
- Mask to apply to the likelihood for fitting. 
- psfPSFMaporHDULocation
- PSF kernel 
- edispEDispKernelorEDispMaporHDULocation
- Energy dispersion kernel 
- mask_safeWcsNDMaporHDULocation
- Mask defining the safe data range. 
- gtiGTI
- GTI of the observation or union of GTI if it is a stacked observation 
- meta_tableTable
- Table listing information on observations used to create the dataset. One line per observation for stacked datasets. 
 
- models
 - See also - Attributes Summary - A lazy FITS data descriptor. - A lazy FITS data descriptor. - Shape of the counts or background data (tuple) - A lazy FITS data descriptor. - Energy range maps defined by the full mask (mask_safe and mask_fit). - Energy range maps defined by the mask_fit only. - Energy range maps defined by the mask_safe only. - Model evaluators - Excess - A lazy FITS data descriptor. - Map geometries - Combined fit and safe mask - A lazy FITS data descriptor. - Reduced mask fit - Reduced mask - A lazy FITS data descriptor. - Mask safe for edisp maps - Reduced mask safe - Mask safe for psf maps - Models ( - Models).- A lazy FITS data descriptor. - Methods Summary - copy([name])- A deep copy. - create(geom[, energy_axis_true, migra_axis, …])- Create a MapDataset object with zero filled maps. - cutout(position, width[, mode, name])- Cutout map dataset. - downsample(factor[, axis_name, name])- Downsample map dataset. - fake([random_state])- Simulate fake counts for the current model and reduced IRFs. - from_dict(data[, lazy, cache])- Create from dicts and models list generated from YAML serialization. - from_geoms(geom[, geom_exposure, geom_psf, …])- Create a MapDataset object with zero filled maps according to the specified geometries - from_hdulist(hdulist[, name, lazy, format])- Create map dataset from list of HDUs. - info_dict([in_safe_data_range])- Info dict with summary statistics, summed over energy - npred()- Predicted source and background counts - Predicted background counts - npred_signal([model_name])- “Model predicted signal counts. - pad(pad_width[, mode, name])- Pad the spatial dimensions of the dataset. - peek([figsize])- Quick-look summary plots. - plot_residuals([ax_spatial, ax_spectral, …])- Plot spatial and spectral residuals in two panels. - plot_residuals_spatial([ax, method, …])- Plot spatial residuals. - plot_residuals_spectral([ax, method, region])- Plot spectral residuals. - read(filename[, name, lazy, cache, format])- Read map dataset from file. - resample_energy_axis(energy_axis[, name])- Resample MapDataset over new reco energy axis. - Reset data cache to free memory space - residuals([method])- Compute residuals map. - slice_by_energy([energy_min, energy_max, name])- Select and slice datasets in energy range - slice_by_idx(slices[, name])- Slice sub dataset. - stack(other[, nan_to_num])- Stack another dataset in place. - Likelihood per bin given the current model parameters - stat_sum()- Total likelihood given the current model parameters. - to_dict()- Convert to dict for YAML serialization. - Convert map dataset to list of HDUs. - to_image([name])- Create images by summing over the reconstructed energy axis. - to_masked([name, nan_to_num])- Return masked dataset - to_region_map_dataset(region[, name])- Integrate the map dataset in a given region. - to_spectrum_dataset(on_region[, …])- Return a ~gammapy.datasets.SpectrumDataset from on_region. - write(filename[, overwrite])- Write map dataset to file. - Attributes Documentation - 
background¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
background_model¶
 - 
counts¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
data_shape¶
- Shape of the counts or background data (tuple) 
 - 
edisp¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
energy_range¶
- Energy range maps defined by the full mask (mask_safe and mask_fit). 
 - 
energy_range_fit¶
- Energy range maps defined by the mask_fit only. 
 - 
energy_range_safe¶
- Energy range maps defined by the mask_safe only. 
 - 
evaluators¶
- Model evaluators 
 - 
excess¶
- Excess 
 - 
exposure¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
geoms¶
- Map geometries - Returns
- geomsdict
- Dict of map geometries involved in the dataset. 
 
 
 - 
mask¶
- Combined fit and safe mask 
 - 
mask_fit¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
mask_fit_image¶
- Reduced mask fit 
 - 
mask_image¶
- Reduced mask 
 - 
mask_safe¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
mask_safe_edisp¶
- Mask safe for edisp maps 
 - 
mask_safe_image¶
- Reduced mask safe 
 - 
mask_safe_psf¶
- Mask safe for psf maps 
 - 
name¶
 - 
psf¶
- A lazy FITS data descriptor. - Parameters
- cachebool
- Whether to cache the data. 
 
 
 - 
stat_type= 'cash'¶
 - 
tag= 'MapDataset'¶
 - Methods Documentation - 
copy(name=None)¶
- A deep copy. - Parameters
- namestr
- Name of the copied dataset 
 
- Returns
- datasetDataset
- Copied datasets. 
 
- dataset
 
 - 
classmethod create(geom, energy_axis_true=None, migra_axis=None, rad_axis=None, binsz_irf=None, reference_time='2000-01-01', name=None, meta_table=None, **kwargs)[source]¶
- Create a MapDataset object with zero filled maps. - Parameters
- geomWcsGeom
- Reference target geometry in reco energy, used for counts and background maps 
- energy_axis_trueMapAxis
- True energy axis used for IRF maps 
- migra_axisMapAxis
- If set, this provides the migration axis for the energy dispersion map. If not set, an EDispKernelMap is produced instead. Default is None 
- rad_axisMapAxis
- Rad axis for the psf map 
- binsz_irffloat
- IRF Map pixel size in degrees. 
- reference_timeTime
- the reference time to use in GTI definition 
- namestr
- Name of the returned dataset. 
- meta_tableTable
- Table listing information on observations used to create the dataset. One line per observation for stacked datasets. 
 
- geom
- Returns
- empty_mapsMapDataset
- A MapDataset containing zero filled maps 
 
- empty_maps
 
 - 
cutout(position, width, mode='trim', name=None)[source]¶
- Cutout map dataset. - Parameters
- positionSkyCoord
- Center position of the cutout region. 
- widthtuple of Angle
- Angular sizes of the region in (lon, lat) in that specific order. If only one value is passed, a square region is extracted. 
- mode{‘trim’, ‘partial’, ‘strict’}
- Mode option for Cutout2D, for details see - Cutout2D.
- namestr
- Name of the new dataset. 
 
- position
- Returns
- cutoutMapDataset
- Cutout map dataset. 
 
- cutout
 
 - 
downsample(factor, axis_name=None, name=None)[source]¶
- Downsample map dataset. - The PSFMap and EDispKernelMap are not downsampled, except if a corresponding axis is given. - Parameters
- factorint
- Downsampling factor. 
- axis_namestr
- Which non-spatial axis to downsample. By default only spatial axes are downsampled. 
- namestr
- Name of the downsampled dataset. 
 
- Returns
- datasetMapDatasetorSpectrumDataset
- Downsampled map dataset. 
 
- dataset
 
 - 
fake(random_state='random-seed')[source]¶
- Simulate fake counts for the current model and reduced IRFs. - This method overwrites the counts defined on the dataset object. - Parameters
- random_state{int, ‘random-seed’, ‘global-rng’, RandomState}
- Defines random number generator initialisation. Passed to - get_random_state.
 
- random_state{int, ‘random-seed’, ‘global-rng’, 
 
 - 
classmethod from_dict(data, lazy=False, cache=True)[source]¶
- Create from dicts and models list generated from YAML serialization. 
 - 
classmethod from_geoms(geom, geom_exposure=None, geom_psf=None, geom_edisp=None, reference_time='2000-01-01', name=None, **kwargs)[source]¶
- Create a MapDataset object with zero filled maps according to the specified geometries - Parameters
- geomGeom
- geometry for the counts and background maps 
- geom_exposureGeom
- geometry for the exposure map 
- geom_psfGeom
- geometry for the psf map 
- geom_edispGeom
- geometry for the energy dispersion kernel map. If geom_edisp has a migra axis, this will create an EDispMap instead. 
- reference_timeTime
- the reference time to use in GTI definition 
- namestr
- Name of the returned dataset. 
 
- geom
- Returns
- datasetMapDatasetorSpectrumDataset
- A dataset containing zero filled maps 
 
- dataset
 
 - 
classmethod from_hdulist(hdulist, name=None, lazy=False, format='gadf')[source]¶
- Create map dataset from list of HDUs. - Parameters
- hdulistHDUList
- List of HDUs. 
- namestr
- Name of the new dataset. 
- format{“gadf”}
- Format the hdulist is given in. 
 
- hdulist
- Returns
- datasetMapDataset
- Map dataset. 
 
- dataset
 
 - 
info_dict(in_safe_data_range=True)[source]¶
- Info dict with summary statistics, summed over energy - Parameters
- in_safe_data_rangebool
- Whether to sum only in the safe energy range 
 
- Returns
- info_dictdict
- Dictionary with summary info. 
 
 
 - 
npred_background()[source]¶
- Predicted background counts - The predicted background counts depend on the parameters of the - FoVBackgroundModeldefined in the dataset.- Returns
- npred_backgroundMap
- Predicted counts from the background. 
 
- npred_background
 
 - 
npred_signal(model_name=None)[source]¶
- “Model predicted signal counts. - If a model is passed, predicted counts from that component is returned. Else, the total signal counts are returned. - Parameters
- model_name: str
- Name of SkyModel for which to compute the npred for. If none, the sum of all components (minus the background model) is returned 
 
- Returns
- npred_sig: gammapy.maps.Map
- Map of the predicted signal counts 
 
- npred_sig: 
 
 - 
pad(pad_width, mode='constant', name=None)[source]¶
- Pad the spatial dimensions of the dataset. - The padding only applies to counts, masks, background and exposure. - Counts, background and masks are padded with zeros, exposure is padded with edge value. - Parameters
- pad_width{sequence, array_like, int}
- Number of pixels padded to the edges of each axis. 
- namestr
- Name of the padded dataset. 
 
- Returns
- datasetMapDataset
- Padded map dataset. 
 
- dataset
 
 - 
peek(figsize=(12, 10))[source]¶
- Quick-look summary plots. - Parameters
- figFigure
- Figure to add AxesSubplot on. 
 
- fig
- Returns
- ax1, ax2, ax3AxesSubplot
- Counts, excess and exposure. 
 
- ax1, ax2, ax3
 
 - 
plot_residuals(ax_spatial=None, ax_spectral=None, kwargs_spatial=None, kwargs_spectral=None)[source]¶
- Plot spatial and spectral residuals in two panels. - Calls - plot_residuals_spatialand- plot_residuals_spectral. The spectral residuals are extracted from the provided region, and the normalization used for its computation can be controlled using the method parameter. The region outline is overlaid on the residuals map.- Parameters
- ax_spatialWCSAxes
- Axes to plot spatial residuals on. 
- ax_spectralAxes
- Axes to plot spectral residuals on. 
- kwargs_spatialdict
- Keyword arguments passed to - plot_residuals_spatial.
- kwargs_spectraldict (regionrequired)
- Keyword arguments passed to - plot_residuals_spectral.
 
- ax_spatial
- Returns
 
 - 
plot_residuals_spatial(ax=None, method='diff', smooth_kernel='gauss', smooth_radius='0.1 deg', **kwargs)[source]¶
- Plot spatial residuals. - The normalization used for the residuals computation can be controlled using the method parameter. - Parameters
- axWCSAxes
- Axes to plot on. 
- method{“diff”, “diff/model”, “diff/sqrt(model)”}
- Normalization used to compute the residuals, see - MapDataset.residuals.
- smooth_kernel{“gauss”, “box”}
- Kernel shape. 
- smooth_radius: `~astropy.units.Quantity`, str or float
- Smoothing width given as quantity or float. If a float is given, it is interpreted as smoothing width in pixels. 
- **kwargsdict
- Keyword arguments passed to - imshow.
 
- ax
- Returns
- axWCSAxes
- WCSAxes object. 
 
- ax
 
 - 
plot_residuals_spectral(ax=None, method='diff', region=None, **kwargs)[source]¶
- Plot spectral residuals. - The residuals are extracted from the provided region, and the normalization used for its computation can be controlled using the method parameter. - Parameters
- axAxes
- Axes to plot on. 
- method{“diff”, “diff/sqrt(model)”}
- Normalization used to compute the residuals, see - SpectrumDataset.residuals.
- region: `~regions.SkyRegion` (required)
- Target sky region. 
- **kwargsdict
- Keyword arguments passed to - errorbar.
 
- ax
- Returns
- axAxes
- Axes object. 
 
- ax
 
 - 
classmethod read(filename, name=None, lazy=False, cache=True, format='gadf')[source]¶
- Read map dataset from file. - Parameters
- filenamestr
- Filename to read from. 
- namestr
- Name of the new dataset. 
- lazybool
- Whether to lazy load data into memory 
- cachebool
- Whether to cache the data after loading. 
- format{“gadf”}
- Format of the dataset file. 
 
- Returns
- datasetMapDataset
- Map dataset. 
 
- dataset
 
 - 
resample_energy_axis(energy_axis, name=None)[source]¶
- Resample MapDataset over new reco energy axis. - Counts are summed taking into account safe mask. - Parameters
- energy_axisMapAxis
- New reconstructed energy axis. 
- name: str
- Name of the new dataset. 
 
- energy_axis
- Returns
- dataset: MapDatasetorSpectrumDataset
- Resampled dataset. 
 
- dataset: 
 
 - 
residuals(method='diff', **kwargs)[source]¶
- Compute residuals map. - Parameters
- method: {“diff”, “diff/model”, “diff/sqrt(model)”}
- Method used to compute the residuals. Available options are:
- “diff” (default): data - model 
- “diff/model”: (data - model) / model 
- “diff/sqrt(model)”: (data - model) / sqrt(model) 
 
 
- **kwargsdict
- Keyword arguments forwarded to - Map.smooth()
 
- Returns
- residualsgammapy.maps.Map
- Residual map. 
 
- residuals
 
 - 
slice_by_energy(energy_min=None, energy_max=None, name=None)[source]¶
- Select and slice datasets in energy range - Parameters
- energy_min, energy_maxQuantity
- Energy bounds to compute the flux point for. 
- namestr
- Name of the sliced dataset. 
 
- energy_min, energy_max
- Returns
- datasetMapDataset
- Sliced Dataset 
 
- dataset
 
 - 
slice_by_idx(slices, name=None)[source]¶
- Slice sub dataset. - The slicing only applies to the maps that define the corresponding axes. - Parameters
- slicesdict
- Dict of axes names and integers or - sliceobject pairs. Contains one element for each non-spatial dimension. For integer indexing the corresponding axes is dropped from the map. Axes not specified in the dict are kept unchanged.
- namestr
- Name of the sliced dataset. 
 
- Returns
- datasetMapDatasetorSpectrumDataset
- Sliced dataset 
 
- dataset
 
 - 
stack(other, nan_to_num=True)[source]¶
- Stack another dataset in place. - Safe mask is applied to compute the stacked counts data. Counts outside each dataset safe mask are lost. - The stacking of 2 datasets is implemented as follows. Here, \(k\) denotes a bin in reconstructed energy and \(j = {1,2}\) is the dataset number - The - mask_safeof each dataset is defined as:\[\begin{split}\epsilon_{jk} =\left\{\begin{array}{cl} 1, & \mbox{if bin k is inside the thresholds}\\ 0, & \mbox{otherwise} \end{array}\right.\end{split}\]- Then the total - countsand model background- bkgare computed according to:\[ \begin{align}\begin{aligned}\overline{\mathrm{n_{on}}}_k = \mathrm{n_{on}}_{1k} \cdot \epsilon_{1k} + \mathrm{n_{on}}_{2k} \cdot \epsilon_{2k}\\\overline{bkg}_k = bkg_{1k} \cdot \epsilon_{1k} + bkg_{2k} \cdot \epsilon_{2k}\end{aligned}\end{align} \]- The stacked - safe_maskis then:\[\overline{\epsilon_k} = \epsilon_{1k} OR \epsilon_{2k}\]- Parameters
- other: `~gammapy.datasets.MapDataset` or `~gammapy.datasets.MapDatasetOnOff`
- Map dataset to be stacked with this one. If other is an on-off dataset alpha * counts_off is used as a background model. 
- nan_to_num: bool
- Non-finite values are replaced by zero if True (default). 
 
 
 - 
to_dict()¶
- Convert to dict for YAML serialization. 
 - 
to_hdulist()[source]¶
- Convert map dataset to list of HDUs. - Returns
- hdulistHDUList
- Map dataset list of HDUs. 
 
- hdulist
 
 - 
to_image(name=None)[source]¶
- Create images by summing over the reconstructed energy axis. - Parameters
- namestr
- Name of the new dataset. 
 
- Returns
- datasetMapDatasetorSpectrumDataset
- Dataset integrated over non-spatial axes. 
 
- dataset
 
 - 
to_masked(name=None, nan_to_num=True)[source]¶
- Return masked dataset - Parameters
- namestr
- Name of the masked dataset. 
 
- Returns
- datasetMapDatasetorSpectrumDataset
- Masked dataset 
 
- dataset
 
 - 
to_region_map_dataset(region, name=None)[source]¶
- Integrate the map dataset in a given region. - Counts and background of the dataset are integrated in the given region, taking the safe mask into accounts. The exposure is averaged in the region again taking the safe mask into account. The PSF and energy dispersion kernel are taken at the center of the region. - Parameters
- regionSkyRegion
- Region from which to extract the spectrum 
- namestr
- Name of the new dataset. 
 
- region
- Returns
- datasetMapDataset
- the resulting reduced dataset 
 
- dataset
 
 - 
to_spectrum_dataset(on_region, containment_correction=False, name=None)[source]¶
- Return a ~gammapy.datasets.SpectrumDataset from on_region. - Counts and background are summed in the on_region. Exposure is taken from the average exposure. - The energy dispersion kernel is obtained at the on_region center. Only regions with centers are supported. - The model is not exported to the ~gammapy.datasets.SpectrumDataset. It must be set after the dataset extraction. - Parameters
- on_regionSkyRegion
- the input ON region on which to extract the spectrum 
- containment_correctionbool
- Apply containment correction for point sources and circular on regions 
- namestr
- Name of the new dataset. 
 
- on_region
- Returns
- datasetSpectrumDataset
- the resulting reduced dataset 
 
- dataset