Releases: spacetelescope/jwst
JWST Build 7.8 rc3
JWST Build 7.8 rc2
associations
-
Asn_Lv2WFSS: Add instrument constraint. [#6114]
-
Asn_Lv2NRSLAMPSpectral: Allow msaspec only if msametfl is available. [#6085]
combine_1d
- Added SRCTYPE to COMBINE1D output extension headers, propagated from
EXTRACT1D inputs [#6079]
cube_build
- Fix some typos in the the arguments documentation. [#6077]
datamodels
-
Updated enum lists for ENGQLPTG and PATTTYPE keywords [#6081]
-
Removed obsolete keyword NDITHPTS and updated attributes for NRIMDTPT [#6083]
-
Added units to
CombinedSpecModel
table output [#6082] -
Added keywords OSS_VER, DETMODE, CMD_TSEL, NOD_TYPE, and GS_V3_PA to
the core schema [#6086] -
Remove
ModelContainer
schema and refactor use of association table
metadata within. [#6094]
general
-
Make CRDS context reporting pytest plugin disabled by default. [#6070]
-
Removed all usage of sys.path, in associations and
jwst.stpipe
[#6098]
lib
- Updated set_telescope_pointing to populate ENGQLPTG keyword with new
allowed values [#6088]
outlier_detection
- Avoid using 'linear' interpolation method as default for
blot
due to
a bug in the implimentation of the bilinear interpolator in thedrizzle
package. Now the default value will be 'poly5'. [#6116]
ramp_fitting
- Re-enable multiprocessing in
RampFitStep
by moving code back from
stcal package. [#6119]
scripts
- Add migrate_data command with support for migrating spec_table in
x1d files produced with <= 1.1.0 of this package. [#6055]
tweakreg
- Remove attached tweakreg catalog from datamodel before exiting step [#6102]
JWST Build 7.8 rc1
ami_analyze
- Create copy of input datamodel to avoid overwriting input. [#5828]
assign_wcs
-
Convert the ra values to array in util.wrap_ra, but if input is a list return
a list [#6031] -
Moved the routine wrap_ra from cube_build to assign_wcs.util. The s_region is
now correct for data that cross ra boundary. [#6026] -
Changed evaluation of grism bounding box center from averaged extrema of
transformed bounding box to transformed centroid of source_cat object [#5809] -
Added pixel shift to MSA slits due to 0-indexing in NIRSpec slit validation
code, fixing difference between bounding box locations during the separate
halves of assign_wcs runs [#5927] -
Added logic to prevent the sending of an empty list of slits to the
validate_open_slits function, so a proper error message is provided to
the user [#5939] -
Added computed
spectral_region
tomodel.meta.wcsinfo
. [#5969]
associations
-
Add rule Asn_MIRMRSBackground to treat background as science. [#6046]
-
Updated level2b WFSS rules to only consider exposures from the same
instrument channel when matching direct images with grism images in
NIRCam WFSS observations. [#5786] -
Removed PATTTYPE='None' constraint from Lv3MIRMRS association rule to
generate spec3 associations for undithered MRS observations. [#5804] -
Updated level2b WFSS rules to only consider exposures using the same
PUPIL value (cross filter) when matching direct images with grism images
in NIRISS WFSS observations. [#5896] -
Updated level2b and level3 TSO rules to exclude exposures with
EXP_TYPE=NRC_TSGRISM and PUPIL=CLEAR, which can result from NIRCam
engineering template observations. [#5946] -
Updated level2b NIRSpec FS rules to exclude exposures sharing a primary
dither location from the list of background exposures [#5994]
background
-
Remove unused
SubtractImagesStep
[#5919] -
Added new step parameter to optionally save the combined, average
background image:save_combined_background
. [#5954]
calwebb_spec2
- Updated documentation to indicate that master_background is applied to
NIRSpec MOS exposures in the calwebb_spec2 pipeline [#5913]
calwebb_spec3
- Updated documentation to indicate that master_background is applied to
NIRSpec MOS exposures in the calwebb_spec2 pipeline [#5913]
csv_tools
- The
csv_tools
subpackage was removed [#6006]
cube_build
-
Fixed typo in
CubeBuildStep
spec for grating [#5839] -
Update code to read in spectral and spatial size of exposure on the sky [#5991]
-
For calspec2 pipeline skip determining the dq plane in
cube_build
[#5991] -
Remove certain WCS keywords that are irrelevant after
cube_build
. [#6032]
datamodels
-
Added
is_star
toslitmeta
[#5788] -
Update keyword comments for NIRSpec grating wheel (GWA) keywords [#5844]
-
Moved functions in
dqflags
anddynamic_mask
tostcal
[#5898] -
API change -
stcal.dqflags.interpret_bit_flags
andstcal.dynamicdq.dynamic_mask
now require themnemonic_map
as input. [#5898, #5914] -
Implemented new data models
SpecKernelModel
,SpecProfileModel
,
SpecTraceModel
, andWaveMapModel
for use by new NIRISS SOSS
reference files in optimized 1D extraction [#5925] -
Added
FULLP
to SUBARRAY enum list in core, subarray,
and keyword_psubarray schemas [#5947] -
Moved JWST_[XYZ] and JWST_[DXDYDZ] keywords from primary to SCI extension
header and updated their comment fields to indicate they'll now be in the
barycentric frame. Also added the new OBSGEO[XYZ] keywords to the SCI
extension header, which are in the geocentric frame. [#6050] -
Added a new datamodel,
SegmentationMapModel
that has an uint32 data array
for storing the segmentation map output fromsource_catalog
. [#6051]
documentation
-
Update documentation, deprecating primary use of CFG files [#5901]
-
Update pipeline introduction document to include segmentation map (
segm
)
in list of data products [#5956] -
Update
assign_mtwcs
step docs and reference theassign_mtwcs
step in the
calwebb_image3
andcalwebb_spec3
pipeline docs [#6024]
extract_1d
- Implemented error and variance propagation for all modes but those
utilizing IFU cubes [#6014]
extract_2d
-
For WFSS removed setting srctype to UNKNOWN; added setting
is_star
in slitmeta [#5788] -
In NRC_TSGRISM mode replaced FITS WCS keywords with JWST specific ones. [#6005]
-
Added
specsys
to slits. [#6005]
general
-
Update file naming conventions documentation to clarify when optional components
will be used. [#5796] -
Update DQFLAGS table in RTD docs with new definitions for persistence and
ad_floor in bits five and six [#5815] -
Update data products,
calwebb_image3
, andsource_catalog
docs to include
information about the segmentation map product [#5949] -
Replace documentation references to ambiguous class names with full
paths. [#6017]
jump
-
Update the step to detect jumps in three and four group integations [#5915].
-
Change the default S/N ratio for not flagging neighbors to be a higher value to
better reflect the correct IPC.
lib
-
Update
update_mt_kwds
function inset_telescope_pointing.py
to populate
the TARG_RA/TARG_DEC [#5808] -
moved
basic_utils.multiple_replace
to stcal. [#5898] -
Implemented window clipping algorithm for WFSS contamination corrections. [#5978]
-
Updated
set_velocity_aberration
andutc_to_tdb
to access the JWST
position and velocity keywords from the SCI extension header, rather than the
primary header. [#6050]
master_background
- Updated documentation to more fully describe the various ways in which the
step is applied [#5913]
outlier_detection
- Outlier detection on non-dithered images is implemented with a simple sigma
clipping, dithered outlier detection cleaned up and HST specific steps removed
and additional tests added. [#5822]
ramp_fitting
-
Refactoring OLS code for ramp fitting to improve readability and maintenance.
Also, reference tonreads
is being removed and replaced withngroups
to remove and confusion on functionality. [#5872] -
Refactoring ramp fit code separating OLS and GLS code into their own file. [#5951]
-
Refactoring ramp fit code in preparation for moving code to STCAL. [#6010]
-
Moved ramp fit code to STCAL. [#6023]
-
Now that ramp fitting has been moved to STCAL, for the JWST unit tests to
pass need to use STCAL 0.2.1 or greater. The bug fix for JP-1920 were made
in STCAL, which affected JWST unit tests for ramp fitting. [#6038]
refpix
-
Added code to handle NIR subarrays that use 4 readout amplifiers. Uses and
applies reference pixel signal from available amplifiers and side reference
pixel regions, including odd-even column separation if requested [#5926] -
Fixed a bug introduced in #5926 that affected refpix calibration of 1-amp NIR
subarrays [#5937] -
Added regression test and unit test for NIR 4-amp subarray correction [#5967]
resample
-
Fix
resample_spec
output size from input images crossing RA=0 [#5929] -
Propagate variance arrays into
SlitModel
used as input forResampleSpecStep
[#5941] -
Remove certain WCS keywords that are irrelevant after resampling. [#5971]
-
Propagate error and variance arrays in
ResampleStep
for imaging data. [#6036] -
Propagate error and variance arrays in
ResampleSpecStep
for 2D spectral data [#6041] -
Record
pixel_scale_ratio
andpixfrac
fromResampleStep
in header
keywords PXSCLRT and PIXFRAC, respectively, ormeta.resample.pixel_scale_ratio
andmeta.resample.pixfrac
. [#6044]
source_catalog
-
Updated the concentration indices to be calculated as flux ratios
instead of magnitude differences. The CI column names have also been
renamed to list the larger EE first, e.g.CI_50_30
. [#5810] -
Aperture-corrected total fluxes and magnitudes are now computed for
all sources. [#5996] -
Photometric errors are now computed using the new resampled total
error array. [#5997] -
The
nn_dist
column was replaced by ann_label
column
indicating the label number of the nearest neighbor. [#5998] -
The
is_star
column was replaced by ais_extended
column with
inverted boolean values. [#6018] -
Circular aperture sizes now scale in the case of non-native pixel
scales in the resampled image. [#6045] -
Segmentation map output dtype is now
uint32
[#6051]
srctype
- Added section for WFSS mode data to set srctype based on
is_star
value [#5788]
transforms
- Added
is_star
to GrismObject [#5788]
tweakreg
-
Fix a bug due to
models_grouped
now returningodict_values
instead
of lists. [#6022] -
Updated documentation to include the new "rshift" option for fit geometry [#5899]
wfss_contam
- Implemented basic step structure to apply WFSS contamination corrections, along with
the necessary grism library modules [#5508]
JWST v1.1.0 (Build 7.7.1)
assign_mtwcs
- Fixed a bug which caused the step to fail with
MultiSlitModel
input. [#JP-1907]
assign_wcs
-
Added velocity aberration-corrected frame
'v2v3vacorr'
to the WCS
pipeline which takes into account DVA effects. [#5602] -
Renamed MIRI frame
'V2_V3_spatial'
to'v2v3_spatial'
and
'V2_V3_vacorr_spatial'
to'v2v3vacorr_spatial'
. Added axes names
to the'v2v3'
frame fornircam
,niriss
,miri
, andfgs
.
Renamed axes fornirspec
fromV2
andV3
to
v2
andv3
. [#5765] -
Changed units of the
'v2v3'
frame fornircam
fromu.deg
to
u.arcsec
[#5765] -
Added spectral frames to the output WCS frame of TSO and WFSS observations. [#5771]
associations
-
Warn about duplicate product names and do not write duplicate associations [#5721]
-
Added new Lvl2 rule, Asn_Lv2NRSLAMPImage, to run Image2 pipeline for NRSLAMP
exposures with OPMODE=image [#5740] -
Ignore duplicate product names while handling Level 2 associations [#5780]
-
Constraint added to Asn_Lv3Coron to remove background exposures [#5781]
combine_1d
- Pull source_id from input x1d headers (from source_catalog) to populate
c1d output headers [#5759]
cube_build
-
Added support for cross-dichroic configurations [#5722]
-
Added infrastructure to support NIRSpec opaque + grating options to build lamp mode data [#5757]
-
When building MIRI internal_cal type cubes removed the requirement that cdelt1=cdelt2 [#5757]
datamodels
-
Updated keyword_readpatt, core, preadpatt schemas for new MIRI detector
readout patterns 'FASTR1', 'FASTR100' and 'SLOWR1' [#5670] -
Added extr_x and extr_y to multispec datamodel. These values are center
of extraction region for IFU data [#5685] -
Added segmentation map output file name to core schema keywords, under
keyword 'SEGMFILE' [#5730] -
Added '1LOS' to PATTTYPE enum list in core.schema datamodel [#5728]
-
Added 'IMAGE' to OPMODE enum list [#5745]
-
Added source_id to combinedspec and multicombinedspec schemas to populate
combine1d output headers [#5759]
extract_1d
-
Adding writing SRCTYPE, EXTR_X, and EXTR_Y to extracted spec for IFU data [#5685]
-
Only update the output x1d data using the PRIMARY input data. Prevents SCI data in x1d data [#5694]
-
Fixed bug in background region fitting for image columns/rows that have zero weight
for all pixels [#5696] -
Determine the background using sigma clipping of entire extended region for
extended source IFU data [#5743]
group_scale
- Fix premature model closing in group_scale_step [#5692]
lib
-
Make EngDB_Value public for JSDP use [#5669]
-
Update code in
set_velocity_aberration.py
functions based on Colin Cox
suggestions: simplify DVA scale computation and improve apparentRA
and
DEC
aberrated position computation. Also, attributesra_offset
and
dec_offset
ofdatamodel.meta.velocity_aberration
have been renamed to
va_ra_ref
andva_dec_ref
and their corresponding FITS keywords
have been renamed fromDVA_RA
andDVA_DEC
to
VA_RA
andVA_DEC
. [#5666] -
Make get_wcs_values_from_siaf public for JSDP use [#5669]
outlier_detection
- Remove hard-coded MRS outlier detection values now that a parameter reference
file exists. [#5753]
photom
- Fixed handling of NIRSpec IFU extended source data, so that the flux
calibration gets converted to surface brightness [#5761]
pipeline
- Remove references to Numpy globals
np.int
,np.float
,np.bool
and
np.str
in the package. [#5769]
ramp_fitting
-
Fixed bug in handling NGROUPS=2 exposures for pixels that saturate in group 2.
Proper slope, err, and other quantities are now computed from the good data
in group 1. [#5700] -
Update documentation to define optimal weighting algorithm [#5682]
resample
- Make inverse variance
weight_type="ivm"
the default weighting scheme for
multiple exposures resampled into a single output. [#5738]
source_catalog
- Added the segmentation map as an output data file, with
suffix "segm". [#5730]
srctype
-
Changed default SRCTYPE for non-primary NIRSpec slits in a FIXEDSLIT
exposure to 'EXTENDED' rather than 'POINT' [#5671] -
Changed logic for handling NIRSpec MOS exposures to blank out the "global"
value of SRCTYPE, to ensure that only the individual slit-specific values
of SRCTYPE get used downstream. [#5754]
stpipe
JWST Build 7.7.1 rc1
Final release notes are in the jwst v1.1.0 (Build 7.7.1) section.
JWST Build 7.7
Summary of changes in the 0.18.x release
Updates to Level-2a processing for all exposure modes
- Fixed bug in the minimum number of groups per integration for the jump detection step by changing it from 3 to 5
- Reworked the jump step to reduce memory usage
- Updated the ramp_fit step to add 'DO_NOT_USE' DQ flag to pixels that have all groups flagged as saturated
- Turned the MIRI "reset" step back on in the level-2a pipeline
- Updated the saturation step to use the A-to-D limit of 65535 as the saturation threshold for pixels flagged with "NO_SAT_CHECK" in the saturation reference file
- Updated the saturation step to flag groups having values below the A-to-D floor (zero)
Updates to Level-2b processing for all exposure modes
- Enhance the flat_field step to flag MIRI imager NON_SCIENCE pixels as DO_NOT_USE
- Enhancements to assign_wcs to add FITS SIP approximation keywords to imaging mode WCS
Updates to Level-2b spectroscopic (calwebb_spec2) processing
- Enable the resample_spec step for NIRSpec line lamp exposures
- Enhancements and bug fixes to the extract_1d step for extracting and applying aperture corrections to IFU mode data
- Bug fixes to the wavecorr step to produce correct wavelength shifts
- Enable processing of NRS_LAMP exposures in the assign_wcs and resample_spec steps
- Enhancements and bug fixes to cube_build for handling single cubes
- Bug fix for extract_1d when determining source RA/Dec in input resampled Slit data
- Enhanced extract_1d to use an extract1d reference file to guide processing for NIRCam TSGRISM exposures, allowing for column-by-column fitting and subtraction of background signal
- Bug fix for extract_1d when there's only one spectrum instance for a WFSS source
- Updated flat_field step branch logic to handle NRS_LAMP as a spectroscopic exposure
- Updated NIRSpec fixed-slit processing in the flat_field and photom steps to compute and save correction values for both point and uniform sources in the primary slit when it contains a point source, in order to support master background corrections
Updates to the Level-3 imaging (calwebb_image3) processing
- Bug fix in outlier_detection to account for background signal when blotting the median-combined image back to individual exposure's space
- Bug fix in the skymatch step to prevent failures when attempting to compute statistics on a single pixel
- Implemented memory checks in the outlier_detection and resample steps to prevent the creation of huge arrays and subsequent memory allocation errors
- Added "pixel_scale_ratio" parameter to the resample step to allow for finer output grid
- Added support for the new fitting geometry mode "rshift" in the tweakreg step
Updates to the Level-3 spectroscopic (calwebb_spec3) processing
- Update the NIRSpec MOS master background logic to only proceed with processing after verifying that there are both background and source slits available in the input dataset
- Enhancement to the combine_1d step to produce separate extensions for each spectral order
Updates to the Level-3 TSO (calwebb_tso3) pipeline
- Updated the tso_photometry step to place the photometric aperture at the location given by the XREF_SCI, YREF_SCI keyword values, instead of using CRPIX1, CRPIX2
- Fixed the flux units in the source_catalog output
- Updated the white_light step to allow for the specification of wavelength limits to restrict the portion of the spectrum used to compute the integrated flux
Updates to the Level-3 AMI (calwebb_ami3) pipeline
- Complete overhaul of the ami_analyze step to use the latest ImPlaneIA algorithms from the AMI WG
- Enhancements to the ami_analyze step to allow two user-settable parameter
Detailed notes
documentation
- Update documentation introduction to include installation and CRDS setup
instructions. [#5659]
combine1d
- Fixed code error in combine1d, creating extensions per spectral order
with the same input data [#5644]
ramp_fitting
- Fix a bug in estimating the max number of segments that will be needed
to fit any pixel [#5653]
set_telescope_pointing
- Update the check in set_telescope_pointing that determines whether an
exposure is TSO mode to always consider hardwired TSO EXP_TYPEs as TSO,
regardless of TSOVISIT and NINTS settings. [#5657]
white_light
- Fixed error causing multi-segment data to reject int_times
for MJDs [#5566]
JWST Build 7.7 rc3
associations
-
JWSTDMS-410 Asn_Lv2NRSLAMPSpectral: Break out the negative cases [#5635]
-
Update MIRI LRS-Fixedslit ALONG-SLIT-NOD backgrounds strategies [#5620]
cube_build
- Do not allow varibles defined in spec (part of the cube_build_step class) to
be changed, to allow calspec2 to loop over a list of files and run the
pipeline. [#5603]
datamodels
- Updated schemas for new keywords CROWDFLD, PRIDTYPE, PRIDTPTS, PATTNPTS, SMGRDPAT,
changed name of SUBPXPNS to SUBPXPTS, and new allowed values for PATTTYPE. [#5618]
flat_field
- Added DO_NOT_USE to pixels flagged as NON_SCIENCE for non-NIRSpec data [#5601]
outlier_detection
- Account for the background subtracted data in the blot image for determining
the noise image used in flagging outliers [#5601]
set_telescope_pointing
- Updated to populate XREF_SCI, YREF_SCI keywords for all TSO exposures,
not just NRC_TSGRISM mode. [#5616]
JWST Build 7.7 rc2
combine1d
- Output FITS now contains separate combine1d extensions for each spectral
order present in the data [#5204]
datamodels
- Fix missing CHANNEL entry in distortion reffile schema. [#5553]
extract_1d
- For IFU data (NIRSpec and MIRI) the extraction radius is now a varying size
based on wavelength. The apcorr correction is a function of wavelength and
radius size. Fixes a bug in units conversion for applying the apcorr correction.
The units are now correctly converted from arcseconds to pixels. Added an
new method to apply the apcorr correction for IFU data. [#5506]
pipeline
- Removed all unnecessary parameter settings from cfg files for all steps
and pipelines, and removed references to step config files from most
pipeline modules (only kept those that are necessary for intended
functionality). [#5574]
skymatch
- Fixed a bug due to which sky matching may fail under certain circumstances
such as using 'mode' statistics on a single pixel (after sigma-clipping). [#5567]
stpipe
- Removed unused LinearPipeline class. [#5590]
wavecorr
- Fixed bugs in wavecorr. [#5570]
JWST Build 7.7 rc1
ami
-
Update code to use two new input parameters: psf_offset,rotation_search [#5548]
-
Update code and unit tests to use new ami_analyze algorithms [#5390]
-
Update ami_analyze to extract a SUB80 subarray from full-frame images [#5437]
assign_wcs
-
Add nrs_verify to the NIRSpec exposure list [#5403]
-
Enable resample_spec for NIRSpec line lamp exposures [#5484]
-
Added SIP approximation to WCS for imaging modes. FITS WCS keywords added to meta.wcsinfo. [#5507]
-
Fix bug where subarray bounding boxes were 1 pixel too small. [#5543]
-
Mark Nirspec slits which project on less than one pixel as invalid. [#5554]
associations
-
Add new dither keyword subpxpts to constraints [#5525]
-
Add further constraints to rule Asn_Lv2NRSLAMPSpectral such that associations
are created only when LAMP is on and OPMODE indicates a valid optical path. [#5496] -
Restrict association creation based on optical path for NIRSpec Fixed-slit and IFU [#5504]
-
Asn_Lv3SpecAux: Add optical element constraint [#5479]
-
Add utility asn_gather [#5468]
-
Do not allow target acqs to be considered TSO [#5385]
-
Add NRS_VERIFY to the list of target acq/confirmation images [#5395]
cube_build
-
When making SINGLE type cubes for outlier detection or mrs_imatch data not in the
appropriate channel/grating is skipped [#5347] -
If outlier detection has flagged all the data on a input file as DO_NOT_USE, then
skip the file in creating an ifucube [*5347] -
Refactor DataTypes handling of ModelContainer. [#5409]
datamodels
-
Skip serializing
None
in datamodels to be compatible withasdf>=2.8
[#5371] -
Implement full class deprecator decorator and use for MIRIRampModel [#5382]
-
Add NRS_VERIFY to the core schema as an allowed EXP_TYPE [#5395]
-
Remove logging from DataModel.close [#5413]
-
Updated keyword schemas for EXP_TYPE and MODULE, to keep in sync with the
JWST Keyword Dictionary [#5452] -
Added flatfield and photom correction arrays to slit data models [#5460]
-
Move core
jwst.datamodels
code tostdatamodels
package and add it as
an install dependency [#5433] -
Update schemas to include new allowed SUBARRAY values for FGS ASIC tuning
modes [#5531] -
Add meta.visit.pointing_engdb_quality entry to correspond to ENGQLPTG keyword [#5556]
-
Update Moving Target CHEBY table extension schema for changes to column
definitions in the JWSTKD and SDP [#5558]
extract_1d
-
Fixed bug involving the determination of source RA/Dec for resampled Slit
data. [#5353] -
Updated to use an EXTRACT1D reference file for NIRCam TSGRISM exposures;
added step param "bkg_fit" to allow for mean and median options in background
computation, in addition to the existing polynomial fit; fixed bug in
background computation that was preventing background subtraction from
ever happening. [#5414] -
Fixed bug involving the processing of WFSS observations when there's only
one spectrum instance for a given source. [#5439]
fits_generator
- Addressed deprecated get_children method of XML parser. Changed type of PATTSIZE from
float to string in templates. [#5536]
flatfield
-
Fixed bug in sending NIRSpec AUTOWAVE exposures to the spectroscopic
processing branch. [#5356] -
Updated branch logic to handle NRS_LAMP exposures as spectroscopic. [#5370]
-
Updated NIRSpec fixed-slit processing to compute and save correction
values for both point and uniform sources in the primary slit when it
contains a point source, in order to support master background corrections.
[#5462]
jump
-
Fixed bug in the minimum number of groups per integration for the jump
detection step by changing it from 3 to 5. [#5376] -
Various rework to reduce memory usage and increase readability. [#5404]
master_background
- Update the NIRSpec MOS master background logic to only proceed with processing
after verifying that there are both background and source slits available in
the input dataset. [#5370]
outlier_detection
- Implement memory check in resample to prevent huge arrays [#5354]
photom
- Updated NIRSpec fixed-slit processing to compute and save correction
values for both point and uniform sources in the primary slit when it
contains a point source, in order to support master background corrections.
[#5463]
pipeline
- Update
Image3Pipeline
to allow sky subtraction when input contains
only one image (group). [#5423] - Enable resample_spec for NIRSpec line lamp exposures in Spec2Pipeline [#5484]
ramp_fitting
-
Update to store output as an
IFUImageModel
for NIRSpec AUTOWAVE exposures
using the IFU mode. [#5356] -
Update to add 'DO_NOT_USE' DQ flag to pixels with all groups flagged as
saturated. [#5367]
resample
-
Implement memory check in resample to prevent huge arrays [#5354]
-
Add
pixel_scale_ratio
parameter to allow finer output grid. [#5389] -
Enable resample_spec for NIRSpec line lamp exposures [#5484]
reset
- Turn the step back on for the calwebb_detector1 pipeline [#5485]
saturation
- Set saturation threshold to A-to-D limit of 65535 for pixels flagged with
NO_SAT_CHECK in the saturation reference file, instead of skipping any
test of those pixels. [#5394] - Flag groups values below A/D floor (0 DN) (#5422)
set_telescope_pointing
- Add logging of the found quaternion information [#5495]
- Handle cases where engineering database's pointing mnemonics are all zero over the requested time range [#5540]
- Set value of keyword ENGQLPTG to CALCULATED or PLANNED depending on whether pointing telemetry was used to
update the WCS [#5556]
skymatch
- Fix a bug in
skymatch
that would result in a crash whenskymethod
contains'global'
and the single image group's sky cannot be computed
(e.g., because all pixels are flagged as "bad"). [#5440]
stpipe
- Implement utility function all_steps and fix crds reference file retrieval for non-datamodels [#5492]
tso_photometry
-
Place aperture using header keywords XREF_SCI and YREF_SCI instead of
CRPIX1 and CRPIX2 [#5533] -
Fixed the flux units in the output photometry catalog. [#5529]
tweakreg
- Add support for the new
fitgeom
mode:'rshift'
that can fit only
for shifts and a rotation. [#5475]
wfs_combine
white_light
- Add support for step parameters
min_wavelength
andmax_wavelength
to modify
the wavelength region over which the flux integration is calculated. [#5501]
JWST Build 7.6
Release Notes
The JWST calibration pipeline (v0.17.1) has been made available on PyPi and Github. A high-level list of updates in this build is given below.
Association generator rules have been updated to:
- Fix incorrect product names for level-3 IFU products
Updates to Level-2a processing for all exposure modes include:
- Enabled creation of the "rateints" product for all exposures, even when NINTS=1
Updates to Level-2b processing for all exposure modes include:
- Enabled application of the "filteroffset" correction for NIRCam and NIRISS imaging modes in the assign_wcs step
- The flat-field step has been updated to set DQ='DO_NOT_USE' for reference file pixels that have values of NaN or zero, as well as reference file pixels flagged as 'NO_FLAT'.
Updates to Level-2b spectroscopic (calwebb_spec2) processing include:
- The ability to perform master background subtraction for NIRSpec MOS exposures
- The ability to process NIRSpec internal lamp exposures
- Improved calculation of bounding boxes for grism images in the assign_wcs step
- Updated the assign_wcs step to allow for user-settable extraction heights in grism (WFSS) images
- The ability to apply minimal processing of MIRI MRS TSO exposures
- Changed the default weighting in the cube_build step to "emsm"
- The ability to perform aperture corrections for point source extracted spectra in the extract_1d step
- Bug fixes in flat-fielding for NIRSpec fixed-slit exposures
Updates to the Level-3 imaging (calwebb_image3) processing include:
- The outlier_detection step has been fixed so that it does not subtract background from the science data
Updates to the Level-3 spectroscopic (calwebb_spec3) processing include:
- Implemented corrections to master background subtraction for NIRSpec IFU exposures
- Updated the master_background step to allow for saving of the 2D master background data
Updates to the Level-3 Coronagraphic (calwebb_coron3) pipeline include:
-
Implemented bad pixel replacement in the align_refs step
Updates to the Level-3 TSO (calwebb_tso3) pipeline include: -
Fixed a bug in the computation of integration time stamps
Complete change log:
associations
- Add product name override to the
IFUGratingBkg
class, to prevent the default
"clear" suffix showing up in NIRSpec IFU product names. [#5326]
barshadow
-
Implement using a user-supplied correction which overrides all references. [#5302]
-
Implement applying the inverse operation. [#5302]
blendmeta
- Do not close files that were not opened by blendmodels [#5299]
cube_build
-
If every wavelength plane of the IFU cube contains 0 data, cube_build is skipped [#5294]
-
Remove "clear" suffix from MIRI MRS product name templates [#5326]
flat_field
-
Update how the flat field reference dq mask is used for NIRSpec MOS data [#5284]
-
Implement providing a user-supplied flat field which overrides all references. [#5302]
-
Implement applying the inverse operation. [#5302]
master_backround
-
Create new step
MasterBackgroundNrsSlits
step to handle NIRSpec MOS data inSpec2Pipeline
[#5317] -
Implement option to save the 2d version of the calculated master background [#5317]
outlier_detection
- Fix bug where background was being subtracted on the input data [#4858]
pathloss
-
Implement using a user-supplied correction which overrides all references. [#5302]
-
Implement applying the inverse operation. [#5302]
photom
-
Implement using a user-supplied correction which overrides all references. [#5302]
-
Implement applying the inverse operation. [#5302]
pipeline
-
Spec3Pipeline check whether master background subtraction has already occurred. [#5308]
-
Implement master background subtraction in Spec2Pipeline for NIRSpec MOS data. [#5302]
-
Include the per-slit failure traceback in any RuntimeError raised in Spec2Pipeline. [#5315]
ramp_fitting
- Reinstate copying of INT_TIMES table to output rateints product for TSO exposures. [#5321]
tso_photometry
- Fix a bug in the computation of integration time stamps when the INT_TIMES
table is not available. [#5318]